From a3751c4ecf19aa8eddc56df02b90c5cc0d47db7e Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Wed, 4 Jun 2025 19:21:51 +0300 Subject: [PATCH 01/20] algo: implement sine/cosine using Intel SVML for single/double precision MIME-Version: 1.0 Content-Type: text/plain; charset=UTF-8 Content-Transfer-Encoding: 8bit - Add sin/cos functions with ≤1 ULP and ≤4 ULP accuracy variants - Support large argument ranges with proper range reduction - Standalone implementation doesn't require libm - Written using Google Highway for SIMD optimization - Optimize for both float32 and float64 data types --- npsr/common.h | 146 + npsr/npsr.h | 12 + npsr/trig/inl.h | 61 + npsr/trig/large-inl.h | 288 + npsr/trig/lut-inl.h | 25437 +++++++++++++++++++++++++++++++++++++++ npsr/trig/lut-inl.h.py | 224 + npsr/trig/small-inl.h | 352 + npsr/utils-inl.h | 97 + 8 files changed, 26617 insertions(+) create mode 100644 npsr/common.h create mode 100644 npsr/npsr.h create mode 100644 npsr/trig/inl.h create mode 100644 npsr/trig/large-inl.h create mode 100644 npsr/trig/lut-inl.h create mode 100644 npsr/trig/lut-inl.h.py create mode 100644 npsr/trig/small-inl.h create mode 100644 npsr/utils-inl.h diff --git a/npsr/common.h b/npsr/common.h new file mode 100644 index 0000000..2837c4b --- /dev/null +++ b/npsr/common.h @@ -0,0 +1,146 @@ +#ifndef NUMPY_SIMD_ROUTINES_NPSR_COMMON_H_ +#define NUMPY_SIMD_ROUTINES_NPSR_COMMON_H_ + +#include "hwy/highway.h" + +#include +#include + +namespace npsr { + +struct _NoLargeArgument {}; +struct _NoSpecialCases {}; +struct _NoExceptions {}; +struct _LowAccuracy {}; +constexpr auto kNoLargeArgument = _NoLargeArgument{}; +constexpr auto kNoSpecialCases = _NoSpecialCases{}; +constexpr auto kNoExceptions = _NoExceptions{}; +constexpr auto kLowAccuracy = _LowAccuracy{}; + +struct Round { + struct _Force {}; + struct _Nearest {}; + struct _Down {}; + struct _Up {}; + struct _Zero {}; + static constexpr auto kForce = _Force{}; + static constexpr auto kNearest = _Nearest{}; +#if 0 // not used yet + static constexpr auto kDown = _Down{}; + static constexpr auto kUp = _Up{}; + static constexpr auto kZero = _Zero{}; +#endif +}; + +struct Subnormal { + struct _DAZ {}; + struct _FTZ {}; + struct _IEEE754 {}; +#if 0 // not used yet + static constexpr auto kDAZ = _DAZ{}; + static constexpr auto kFTZ = _FTZ{}; +#endif + static constexpr auto kIEEE754 = _IEEE754{}; +}; + +struct FPExceptions { + static constexpr auto kNone = 0; + static constexpr auto kInvalid = FE_INVALID; + static constexpr auto kDivByZero = FE_DIVBYZERO; + static constexpr auto kOverflow = FE_OVERFLOW; + static constexpr auto kUnderflow = FE_UNDERFLOW; +}; + +template class Precise { +public: + Precise() { + if constexpr (!kNoExceptions) { + fegetexceptflag(&_exceptions, FE_ALL_EXCEPT); + } + if constexpr (kRoundForce) { + _rounding_mode = fegetround(); + int new_mode = _NewRoundingMode(); + if (_rounding_mode != new_mode) { + _retrieve_rounding_mode = true; + fesetround(new_mode); + } + } + } + void FlushExceptions() { fesetexceptflag(&_exceptions, FE_ALL_EXCEPT); } + + void Raise(int errors) { + static_assert(!kNoExceptions, + "Cannot raise exceptions in NoExceptions mode"); + _exceptions |= errors; + } + ~Precise() { + FlushExceptions(); + if constexpr (kRoundForce) { + if (_retrieve_rounding_mode) { + fesetround(_rounding_mode); + } + } + } + static constexpr bool kNoExceptions = + (std::is_same_v<_NoExceptions, Args> || ...); + static constexpr bool kNoLargeArgument = + (std::is_same_v<_NoLargeArgument, Args> || ...); + static constexpr bool kNoSpecialCases = + (std::is_same_v<_NoSpecialCases, Args> || ...); + static constexpr bool kLowAccuracy = + (std::is_same_v<_LowAccuracy, Args> || ...); + // defaults to high accuracy if no low accuracy flag is set + static constexpr bool kHighAccuracy = !kLowAccuracy; + // defaults to large argument support if no no large argument flag is set + static constexpr bool kLargeArgument = !kNoLargeArgument; + // defaults to special cases support if no no special cases flag is set + static constexpr bool kSpecialCases = !kNoSpecialCases; + // defaults to exception support if no no exception flag is set + static constexpr bool kException = !kNoExceptions; + + static constexpr bool kRoundForce = + (std::is_same_v || ...); + static constexpr bool _kRoundNearest = + (std::is_same_v || ...); + static constexpr bool kRoundZero = + (std::is_same_v || ...); + static constexpr bool kRoundDown = + (std::is_same_v || ...); + static constexpr bool kRoundUp = (std::is_same_v || ...); + // only one rounding mode can be set + static_assert((_kRoundNearest + kRoundDown + kRoundUp + kRoundZero) <= 1, + "Only one rounding mode can be set at a time"); + // if no rounding mode is set, default to round nearest + static constexpr bool kRoundNearest = + _kRoundNearest || (!kRoundDown && !kRoundUp && !kRoundZero); + + static constexpr bool kDAZ = (std::is_same_v || ...); + static constexpr bool kFTZ = (std::is_same_v || ...); + static constexpr bool _kIEEE754 = + (std::is_same_v || ...); + static_assert(!_kIEEE754 || !(kDAZ || kFTZ), + "IEEE754 mode cannot be used " + "with Denormals Are Zero (DAZ) or Flush To Zero (FTZ) " + "subnormal handling"); + static constexpr bool kIEEE754 = _kIEEE754 || !(kDAZ || kFTZ); + +private: + int _NewRoundingMode() const { + if constexpr (kRoundDown) { + return FE_DOWNWARD; + } else if constexpr (kRoundUp) { + return FE_UPWARD; + } else if constexpr (kRoundZero) { + return FE_TOWARDZERO; + } else { + return FE_TONEAREST; + } + } + int _rounding_mode = 0; + bool _retrieve_rounding_mode = false; + fexcept_t _exceptions; +}; + +} // namespace npsr + +#endif // NUMPY_SIMD_ROUTINES_NPSR_COMMON_H_ diff --git a/npsr/npsr.h b/npsr/npsr.h new file mode 100644 index 0000000..9ca3af7 --- /dev/null +++ b/npsr/npsr.h @@ -0,0 +1,12 @@ +// To include them once per target, which is ensured by the toggle check. +// clang-format off +#if defined(_NPSR_NPSR_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef _NPSR_NPSR_H_ +#undef _NPSR_NPSR_H_ +#else +#define _NPSR_NPSR_H_ +#endif + +#include "npsr/trig/inl.h" + +#endif // _NPSR_NPSR_H_ diff --git a/npsr/trig/inl.h b/npsr/trig/inl.h new file mode 100644 index 0000000..a77463f --- /dev/null +++ b/npsr/trig/inl.h @@ -0,0 +1,61 @@ +#include "npsr/common.h" + +#include "npsr/sincos/large-inl.h" +#include "npsr/sincos/small-inl.h" + +// clang-format off +#if defined(NPSR_TRIG_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TRIG_INL_H_ +#undef NPSR_TRIG_INL_H_ +#else +#define NPSR_TRIG_INL_H_ +#endif + +HWY_BEFORE_NAMESPACE(); + +namespace npsr::HWY_NAMESPACE::sincos { +template +HWY_API V SinCos(Prec &prec, V x) { + using namespace hwy::HWY_NAMESPACE; + constexpr bool kIsSingle = std::is_same_v, float>; + const DFromV d; + V ret; + if constexpr (Prec::kLowAccuracy) { + ret = SmallArgLow(x); + } + else { + ret = SmallArg(x); + } + if constexpr (Prec::kLargeArgument) { + // Identify inputs requiring extended precision (very large arguments) + auto has_large_arg = Gt(Abs(x), Set(d, kIsSingle ? 10000.0 : 16777216.0)); + if (HWY_UNLIKELY(!AllFalse(d, has_large_arg))) { + // Use extended precision algorithm for large arguments + ret = IfThenElse(has_large_arg, LargeArg(x), ret); + } + } + if constexpr (Prec::kSpecialCases || Prec::kException) { + auto is_finite = IsFinite(x); + ret = IfThenElse(is_finite, ret, NaN(d)); + if constexpr (Prec::kException) { + prec.Raise(!AllFalse(d, IsInf(x)) ? FPExceptions::kInvalid : 0); + } + } + return ret; +} +} // namespace npsr::HWY_NAMESPACE::sincos + +namespace npsr::HWY_NAMESPACE { +template +HWY_API V Sin(Prec &prec, V x) { + return sincos::SinCos(prec, x); +} +template +HWY_API V Cos(Prec &prec, V x) { + return sincos::SinCos(prec, x); +} +} // namespace npsr::HWY_NAMESPACE + +HWY_AFTER_NAMESPACE(); + +#endif // NPSR_TRIG_INL_H_ diff --git a/npsr/trig/large-inl.h b/npsr/trig/large-inl.h new file mode 100644 index 0000000..c7f8072 --- /dev/null +++ b/npsr/trig/large-inl.h @@ -0,0 +1,288 @@ +#include "npsr/common.h" +#include "npsr/trig/lut-inl.h" +// clang-format off +#if defined(NPSR_TRIG_LARGE_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TRIG_LARGE_INL_H_ +#undef NPSR_TRIG_LARGE_INL_H_ +#else +#define NPSR_TRIG_LARGE_INL_H_ +#endif + +HWY_BEFORE_NAMESPACE(); +namespace npsr::HWY_NAMESPACE::sincos { + +template HWY_API V LargeArg(V x) { + using namespace hwy; + using namespace hwy::HWY_NAMESPACE; + + using D = DFromV; + using DI = RebindToSigned; + using DU = RebindToUnsigned; + using VI = Vec; + using VU = Vec; + using T = TFromV; + using TU = TFromV; + const D d; + const DI di; + const DU du; + + constexpr bool kIsSingle = std::is_same_v; + + // ============================================================================= + // PHASE 1: Table Lookup for Reduction Constants + // ============================================================================= + // Each table entry contains 3 consecutive values [high, mid, low] + // providing ~96-bit (F32) or ~192-bit (F64) precision for (4/π) × 2^exp + VU u_exponent = GetBiasedExponent(x); + VI i_table_idx = BitCast(di, Add(ShiftLeft<1>(u_exponent), u_exponent)); // × 2 + 1 = × 3 + + // Gather three parts of (4/π) × 2^exp from precomputed table + // Generated by Python script with offset: 70 (F32) or 137 (F64) + VU u_p_hi = GatherIndex(du, kLargeReductionTable, i_table_idx); + VU u_p_med = GatherIndex(du, kLargeReductionTable + 1, i_table_idx); + VU u_p_lo = GatherIndex(du, kLargeReductionTable + 2, i_table_idx); + + // ============================================================================= + // PHASE 2: Extract and Normalize Mantissa + // ============================================================================= + + // Extract and Normalize Mantissa + V abx = Abs(x); + VU u_input = BitCast(du, abx); + VU u_significand = And(u_input, Set(du, MantissaMask())); + // Add implicit leading 1 bit + VU u_integer_bit = Or(u_significand, Set(du, static_cast(1) << MantissaBits())); + VU u_mantissa = Or(u_significand, u_integer_bit); + + // Split mantissa into halves for extended precision multiplication + // F32: 16-bit halves, F64: 32-bit halves + constexpr int kHalfShift = (sizeof(T) / 2) * 8; + VU u_low_mask = Set(du, (static_cast(1) << kHalfShift) - 1); + VU u_m0 = And(u_mantissa, u_low_mask); + VU u_m1 = ShiftRight(u_mantissa); + + // Split reduction constants into halves + VU u_p0 = And(u_p_lo, u_low_mask); + VU u_p1 = ShiftRight(u_p_lo); + VU u_p2 = And(u_p_med, u_low_mask); + VU u_p3 = ShiftRight(u_p_med); + VU u_p4 = And(u_p_hi, u_low_mask); + VU u_p5 = ShiftRight(u_p_hi); + + // ============================================================================= + // PHASE 3: Extended Precision Multiplication + // ============================================================================= + // mantissa × (4/π × 2^exp) using half-word multiplications + // F32: 16×16→32 bit, F64: 32×32→64 bit multiplications + + // Products with highest precision part + VU u_m04 = Mul(u_m0, u_p4); + VU u_m05 = Mul(u_m0, u_p5); + VU u_m14 = Mul(u_m1, u_p4); + // Omit u_m1 × u_p5 to prevent overflow + + // Products with medium precision part + VU u_m02 = Mul(u_m0, u_p2); + VU u_m03 = Mul(u_m0, u_p3); + VU u_m12 = Mul(u_m1, u_p2); + VU u_m13 = Mul(u_m1, u_p3); + + // Products with lowest precision part + VU u_m01 = Mul(u_m0, u_p1); + VU u_m10 = Mul(u_m1, u_p0); + VU u_m11 = Mul(u_m1, u_p1); + + // ============================================================================= + // PHASE 4: Carry Propagation and Result Assembly + // ============================================================================= + // Extract carry bits from each product + VU u_carry04 = ShiftRight(u_m04); + VU u_carry02 = ShiftRight(u_m02); + VU u_carry03 = ShiftRight(u_m03); + VU u_carry01 = ShiftRight(u_m01); + VU u_carry10 = ShiftRight(u_m10); + + // Extract lower halves + VU u_low04 = And(u_m04, u_low_mask); + VU u_low02 = And(u_m02, u_low_mask); + VU u_low05 = And(u_m05, u_low_mask); + VU u_low03 = And(u_m03, u_low_mask); + + // Column-wise accumulation (Intel SVML pattern) + VU u_col3 = Add(u_low05, Add(u_m14, u_carry04)); + VU u_col2 = Add(u_low04, Add(u_m13, u_carry03)); + VU u_col1 = Add(u_low02, Add(u_m11, u_carry01)); + VU u_col0 = Add(u_low03, Add(u_m12, u_carry02)); + + // Carry propagation through columns + VU u_sum0 = Add(u_carry10, u_col1); + VU u_carry_final0 = ShiftRight(u_sum0); + VU u_sum1 = Add(u_carry_final0, u_col0); + VU u_carry_final1 = ShiftRight(u_sum1); + VU u_sum1_shifted = ShiftLeft(u_sum1); + VU u_sum2 = Add(u_carry_final1, u_col2); + VU u_carry_final2 = ShiftRight(u_sum2); + VU u_sum3 = Add(u_carry_final2, u_col3); + + // Assemble final result + VU u_result0 = And(u_sum0, u_low_mask); + VU u_result2 = And(u_sum2, u_low_mask); + VU u_result3 = ShiftLeft(u_sum3); + + VU u_reduce_lo = Add(u_sum1_shifted, u_result0); + VU u_reduce_hi = Add(u_result3, u_result2); + + // ============================================================================= + // PHASE 5: Extract Quotient and Fractional Parts + // ============================================================================= + + // Extract integer quotient + constexpr int kQuotientShift = ExponentBits() + 1; // 9 for F32, 12 for F64 + VU u_shifted_n = ShiftRight(u_reduce_hi); + + // fractional shifts derived from magic constants + // F32: 5, 18, 14 (sum = 37, total with quotient = 46 = 2×23) + // F64: 28, 24, 40 (sum = 92, total with quotient = 104 = 2×52) + constexpr int kFracLowShift = kIsSingle ? 5 : 28; + constexpr int kFracMidShift = kIsSingle ? 18 : 24; + constexpr int kFracHighShift = kIsSingle ? 14 : 40; + + // Verify total shift constraint + constexpr int kTotalShift = kQuotientShift + kFracLowShift + kFracMidShift + kFracHighShift; + static_assert(kTotalShift == (kIsSingle ? 46 : 104), "Total shift must equal 2×mantissa_bits"); + + // Extract fractional parts + constexpr TU kFracMidMask = (static_cast(1) << kFracMidShift) - 1; + VU u_frac_low_bits = And(u_reduce_lo, Set(du, kFracMidMask)); + VU u_shifted_sig_lo = ShiftLeft(u_frac_low_bits); + VU u_frac_mid_bits = ShiftRight(u_reduce_lo); + + // ============================================================================= + // PHASE 6: Magic Number Conversion to Floating Point + // ============================================================================= + // magic constants for branchless int→float conversion + // Handle sign bit + VU u_sign_bit = And(BitCast(du, x), Set(du, SignMask())); + VU u_exponent_part = Xor(u_sign_bit, BitCast(du, Set(d, static_cast(1.0)))); + VU u_quotient_signed = Or(u_shifted_n, u_exponent_part); + + // Magic number conversion for quotient + V shifter = Set(d, kIsSingle ? 0x1.8p15f : 0x1.8p43); + V integer_part = Add(shifter, BitCast(d, u_quotient_signed)); + V n = Sub(integer_part, shifter); + V reduced_hi = Sub(BitCast(d, u_quotient_signed), n); + + // constants for fractional parts + VU u_epsilon_low = BitCast(du, Set(d, kIsSingle ? 0x1p-46f : 0x1p-104)); + VU u_exp_low = Xor(u_sign_bit, u_epsilon_low); + VU u_frac_low_combined = Or(u_shifted_sig_lo, u_exp_low); + + constexpr TU kFracHighMask = (static_cast(1) << (kFracHighShift - kFracLowShift)) - 1; + VU u_frac_high_bits = And(u_reduce_hi, Set(du, kFracHighMask)); + V shifter_lo = BitCast(d, u_exp_low); + V reduced_lo = Sub(BitCast(d, u_frac_low_combined), shifter_lo); + + VU u_epsilon = BitCast(du, Set(d, kIsSingle ? 0x1p-23f : 0x1p-52)); + VU u_exp_mid = Xor(u_sign_bit, u_epsilon); + VU u_shifted_sig_mid = Or(ShiftLeft(u_frac_high_bits), u_frac_mid_bits); + VU u_frac_mid_combined = Or(u_shifted_sig_mid, u_exp_mid); + V shifter_mid = BitCast(d, u_exp_mid); + V reduced_med = Sub(BitCast(d, u_frac_mid_combined), shifter_mid); + + // ============================================================================= + // PHASE 7: Convert to Radians + // ============================================================================= + + // High-precision 2π constants + V _2pu_lead = Set(d, kIsSingle ? 0x1.921fb6p2f : 0x1.921fb54442d18p+2); + V _2pu_trail = Set(d, kIsSingle ? -0x1.777a5cp-23f : 0x1.1a62633145c07p-52); + + // Compensated summation + V r_hi = Add(reduced_hi, reduced_med); + V reduced_hu_err = Sub(reduced_hi, r_hi); + V reduced_med_corr = Add(reduced_med, reduced_hu_err); + V r_lo = Add(reduced_med_corr, reduced_lo); + + // Multiply by π with error compensation (Cody-Waite multiplication) + V red_hi = Mul(r_hi, _2pu_lead); + V mult_error = MulSub(r_hi, _2pu_lead, red_hi); + V red_lo_final_part = MulAdd(_2pu_trail, r_hi, mult_error); + V red_lo_final = MulAdd(_2pu_lead, r_lo, red_lo_final_part); + + // ============================================================================= + // PHASE 8: Small Argument Handling + // ============================================================================= + + const V min_input = Set(d, static_cast(0x1p-20)); + const auto ismall_arg = Gt(min_input, abx); + + V r = IfThenElse(ismall_arg, x, red_hi); + V e = IfThenElse(ismall_arg, Zero(d), red_lo_final); + + // Calculate table index + VU u_n_mask = Set(du, kIsSingle ? 0xFF : 0x1FF); + VU u_index = And(BitCast(du, integer_part), u_n_mask); + constexpr int kTableEntryBytesShift = kIsSingle ? 2 : 3; + VI u_table_index = BitCast(di, ShiftLeft(u_index)); + + // ============================================================================= + // PHASE 9: Table Lookup + // ============================================================================= + + const T *table_base = IS_COS ? kCosApproxTable : kSinApproxTable; + + // Gather table values: [deriv_error, sin_hi, sin_lo, deriv] + // Based on Sollya script: p0=deriv_error, p1=sin_hi, p2=sin_lo, + // p3=deriv + V deriv_error = GatherIndex(d, table_base, u_table_index); + V sin_hi = GatherIndex(d, table_base + 1, u_table_index); + V sin_lo = GatherIndex(d, table_base + 2, u_table_index); + V deriv = GatherIndex(d, table_base + 3, u_table_index); + + // ============================================================================= + // PHASE 10: Final Assembly + // ============================================================================= + + V r2 = Mul(r, r); + + // Apply first-order correction: sin_hi + deriv × r + V first_order = MulAdd(deriv, r, sin_hi); + V linear_error =MulAdd(deriv, r, Sub(sin_hi, first_order)); + + // Apply derivative error correction + V deriv_corrected = MulAdd(r, deriv_error, first_order); + V deriv_correction_error = + MulAdd(r, deriv_error, Sub(first_order, deriv_corrected)); + V total_linear_error = Add(deriv_correction_error, linear_error); + + // Polynomial corrections + V s2 = Set(d, kIsSingle ? 0x1.1110b8p-7f : 0x1.1110fabb3551cp-7); + V s1 = Set(d, kIsSingle ? -0x1.555556p-3f : -0x1.5555555554448p-3); + V sin_poly = MulAdd(s2, r2, s1); + sin_poly = Mul(sin_poly, r2); + sin_poly = Mul(sin_poly, r); + + V c2 = Set(d, kIsSingle ? 0x1.5554f8p-5f : 0x1.5555555554ccfp-5); + V c1 = Set(d, static_cast(-0.5)); + V cos_poly = MulAdd(c2, r2, c1); + cos_poly = Mul(cos_poly, r2); + + // Apply cross-term corrections + V func_deriv_sum = Add(deriv_error, deriv); + V corr1 = NegMulAdd(sin_hi, r, func_deriv_sum); + // Apply remaining corrections + V corr = MulAdd(corr1, e, sin_lo); + + V poly_correction = MulAdd(corr1, sin_poly, total_linear_error); + + V cos_correction = MulAdd(sin_hi, cos_poly, corr); + V final_correction = Add(cos_correction, poly_correction); + + // Assemble final result: primary_value + all_corrections + return Add(deriv_corrected, final_correction); +} +// NOLINTNEXTLINE(google-readability-namespace-comments) +} // namespace npsr::HWY_NAMESPACE::sincos +HWY_AFTER_NAMESPACE(); + +#endif // NPSR_TRIG_LARGE_INL_H_ diff --git a/npsr/trig/lut-inl.h b/npsr/trig/lut-inl.h new file mode 100644 index 0000000..67b52f8 --- /dev/null +++ b/npsr/trig/lut-inl.h @@ -0,0 +1,25437 @@ +// auto generated by npsr/sincos/lut-inl.h.py +#include +#if defined(NPSR_TRIG_LUT_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TRIG_LUT_INL_H_ +#undef NPSR_TRIG_LUT_INL_H_ +#else +#define NPSR_TRIG_LUT_INL_H_ +#endif + +HWY_BEFORE_NAMESPACE(); + +namespace npsr::HWY_NAMESPACE::sincos { +HWY_API void DummySupressUnusedTargetWarn(); + + +template constexpr T kLargeReductionTable[] = {}; +template constexpr T kSinApproxTable[] = {}; +template constexpr T kCosApproxTable[] = {}; +template constexpr T kHiSinKPi16Table[] = {}; +template constexpr T kHiCosKPi16Table[] = {}; +template constexpr T kPackedLowSinCosKPi16Table[] = {}; + +template <> HWY_ALIGN constexpr double kHiSinKPi16Table[] = { +0, +0x1.8f8b83c69a60bp-3, +0x1.87de2a6aea963p-2, +0x1.1c73b39ae68c8p-1, +0x1.6a09e667f3bcdp-1, +0x1.a9b66290ea1a3p-1, +0x1.d906bcf328d46p-1, +0x1.f6297cff75cbp-1, +0x1p0, +0x1.f6297cff75cbp-1, +0x1.d906bcf328d46p-1, +0x1.a9b66290ea1a3p-1, +0x1.6a09e667f3bcdp-1, +0x1.1c73b39ae68c8p-1, +0x1.87de2a6aea963p-2, +0x1.8f8b83c69a60bp-3 +}; +template <> HWY_ALIGN constexpr double kHiCosKPi16Table[] = { +0x1p0, +0x1.f6297cff75cbp-1, +0x1.d906bcf328d46p-1, +0x1.a9b66290ea1a3p-1, +0x1.6a09e667f3bcdp-1, +0x1.1c73b39ae68c8p-1, +0x1.87de2a6aea963p-2, +0x1.8f8b83c69a60bp-3, +0, +-0x1.8f8b83c69a60bp-3, +-0x1.87de2a6aea963p-2, +-0x1.1c73b39ae68c8p-1, +-0x1.6a09e667f3bcdp-1, +-0x1.a9b66290ea1a3p-1, +-0x1.d906bcf328d46p-1, +-0x1.f6297cff75cbp-1 +}; +template <> HWY_ALIGN constexpr double kPackedLowSinCosKPi16Table[] = { +0, +0x1.56217bc626d19p-56, +0x1.457e6bc672cedp-56, +0x1.9f6303c8b25ddp-60, +-0x1.bdd34bc8bdd34p-55, +0x1.b25dd3c39f63p-55, +-0x1.72ced3c7457e6p-57, +-0x1.26d193c756217p-57, +0, +0x1.26d193c756217p-57, +0x1.72ced3c7457e6p-57, +-0x1.b25dd3c39f63p-55, +0x1.bdd34bc8bdd34p-55, +-0x1.9f6303c8b25ddp-60, +-0x1.457e6bc672cedp-56, +-0x1.56217bc626d19p-56 +}; +template <> HWY_ALIGN constexpr uint32_t kLargeReductionTable[] = { +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x0U, +0x1U, +0x0U, +0x0U, +0x2U, +0x0U, +0x0U, +0x5U, +0x0U, +0x0U, +0xaU, +0x0U, +0x0U, +0x14U, +0x0U, +0x0U, +0x28U, +0x0U, +0x0U, +0x51U, +0x0U, +0x0U, +0xa2U, +0x0U, +0x0U, +0x145U, +0x0U, +0x0U, +0x28bU, +0x0U, +0x0U, +0x517U, +0x0U, +0x0U, +0xa2fU, +0x0U, +0x0U, +0x145fU, +0x0U, +0x0U, +0x28beU, +0x0U, +0x0U, +0x517cU, +0x0U, +0x0U, +0xa2f9U, +0x0U, +0x0U, +0x145f3U, +0x0U, +0x0U, +0x28be6U, +0x0U, +0x0U, +0x517ccU, +0x0U, +0x0U, +0xa2f98U, +0x0U, +0x0U, +0x145f30U, +0x0U, +0x0U, +0x28be60U, +0x0U, +0x0U, +0x517cc1U, +0x0U, +0x0U, +0xa2f983U, +0x0U, +0x0U, +0x145f306U, +0x0U, +0x0U, +0x28be60dU, +0x0U, +0x0U, +0x517cc1bU, +0x0U, +0x0U, +0xa2f9836U, +0x0U, +0x0U, +0x145f306dU, +0x0U, +0x0U, +0x28be60dbU, +0x0U, +0x0U, +0x517cc1b7U, +0x0U, +0x0U, +0xa2f9836eU, +0x0U, +0x1U, +0x45f306dcU, +0x0U, +0x2U, +0x8be60db9U, +0x0U, +0x5U, +0x17cc1b72U, +0x0U, +0xaU, +0x2f9836e4U, +0x0U, +0x14U, +0x5f306dc9U, +0x0U, +0x28U, +0xbe60db93U, +0x0U, +0x51U, +0x7cc1b727U, +0x0U, +0xa2U, +0xf9836e4eU, +0x0U, +0x145U, +0xf306dc9cU, +0x0U, +0x28bU, +0xe60db939U, +0x0U, +0x517U, +0xcc1b7272U, +0x0U, +0xa2fU, +0x9836e4e4U, +0x0U, +0x145fU, +0x306dc9c8U, +0x0U, +0x28beU, +0x60db9391U, +0x0U, +0x517cU, +0xc1b72722U, +0x0U, +0xa2f9U, +0x836e4e44U, +0x0U, +0x145f3U, +0x6dc9c88U, +0x0U, +0x28be6U, +0xdb93910U, +0x0U, +0x517ccU, +0x1b727220U, +0x0U, +0xa2f98U, +0x36e4e441U, +0x0U, +0x145f30U, +0x6dc9c882U, +0x0U, +0x28be60U, +0xdb939105U, +0x0U, +0x517cc1U, +0xb727220aU, +0x0U, +0xa2f983U, +0x6e4e4415U, +0x0U, +0x145f306U, +0xdc9c882aU, +0x0U, +0x28be60dU, +0xb9391054U, +0x0U, +0x517cc1bU, +0x727220a9U, +0x0U, +0xa2f9836U, +0xe4e44152U, +0x0U, +0x145f306dU, +0xc9c882a5U, +0x0U, +0x28be60dbU, +0x9391054aU, +0x0U, +0x517cc1b7U, +0x27220a94U, +0x0U, +0xa2f9836eU, +0x4e441529U, +0x1U, +0x45f306dcU, +0x9c882a53U, +0x2U, +0x8be60db9U, +0x391054a7U, +0x5U, +0x17cc1b72U, +0x7220a94fU, +0xaU, +0x2f9836e4U, +0xe441529fU, +0x14U, +0x5f306dc9U, +0xc882a53fU, +0x28U, +0xbe60db93U, +0x91054a7fU, +0x51U, +0x7cc1b727U, +0x220a94feU, +0xa2U, +0xf9836e4eU, +0x441529fcU, +0x145U, +0xf306dc9cU, +0x882a53f8U, +0x28bU, +0xe60db939U, +0x1054a7f0U, +0x517U, +0xcc1b7272U, +0x20a94fe1U, +0xa2fU, +0x9836e4e4U, +0x41529fc2U, +0x145fU, +0x306dc9c8U, +0x82a53f84U, +0x28beU, +0x60db9391U, +0x54a7f09U, +0x517cU, +0xc1b72722U, +0xa94fe13U, +0xa2f9U, +0x836e4e44U, +0x1529fc27U, +0x145f3U, +0x6dc9c88U, +0x2a53f84eU, +0x28be6U, +0xdb93910U, +0x54a7f09dU, +0x517ccU, +0x1b727220U, +0xa94fe13aU, +0xa2f98U, +0x36e4e441U, +0x529fc275U, +0x145f30U, +0x6dc9c882U, +0xa53f84eaU, +0x28be60U, +0xdb939105U, +0x4a7f09d5U, +0x517cc1U, +0xb727220aU, +0x94fe13abU, +0xa2f983U, +0x6e4e4415U, +0x29fc2757U, +0x145f306U, +0xdc9c882aU, +0x53f84eafU, +0x28be60dU, +0xb9391054U, +0xa7f09d5fU, +0x517cc1bU, +0x727220a9U, +0x4fe13abeU, +0xa2f9836U, +0xe4e44152U, +0x9fc2757dU, +0x145f306dU, +0xc9c882a5U, +0x3f84eafaU, +0x28be60dbU, +0x9391054aU, +0x7f09d5f4U, +0x517cc1b7U, +0x27220a94U, +0xfe13abe8U, +0xa2f9836eU, +0x4e441529U, +0xfc2757d1U, +0x45f306dcU, +0x9c882a53U, +0xf84eafa3U, +0x8be60db9U, +0x391054a7U, +0xf09d5f47U, +0x17cc1b72U, +0x7220a94fU, +0xe13abe8fU, +0x2f9836e4U, +0xe441529fU, +0xc2757d1fU, +0x5f306dc9U, +0xc882a53fU, +0x84eafa3eU, +0xbe60db93U, +0x91054a7fU, +0x9d5f47dU, +0x7cc1b727U, +0x220a94feU, +0x13abe8faU, +0xf9836e4eU, +0x441529fcU, +0x2757d1f5U, +0xf306dc9cU, +0x882a53f8U, +0x4eafa3eaU, +0xe60db939U, +0x1054a7f0U, +0x9d5f47d4U, +0xcc1b7272U, +0x20a94fe1U, +0x3abe8fa9U, +0x9836e4e4U, +0x41529fc2U, +0x757d1f53U, +0x306dc9c8U, +0x82a53f84U, +0xeafa3ea6U, +0x60db9391U, +0x54a7f09U, +0xd5f47d4dU, +0xc1b72722U, +0xa94fe13U, +0xabe8fa9aU, +0x836e4e44U, +0x1529fc27U, +0x57d1f534U, +0x6dc9c88U, +0x2a53f84eU, +0xafa3ea69U, +0xdb93910U, +0x54a7f09dU, +0x5f47d4d3U, +0x1b727220U, +0xa94fe13aU, +0xbe8fa9a6U, +0x36e4e441U, +0x529fc275U, +0x7d1f534dU, +0x6dc9c882U, +0xa53f84eaU, +0xfa3ea69bU, +0xdb939105U, +0x4a7f09d5U, +0xf47d4d37U, +0xb727220aU, +0x94fe13abU, +0xe8fa9a6eU, +0x6e4e4415U, +0x29fc2757U, +0xd1f534ddU, +0xdc9c882aU, +0x53f84eafU, +0xa3ea69bbU, +0xb9391054U, +0xa7f09d5fU, +0x47d4d377U, +0x727220a9U, +0x4fe13abeU, +0x8fa9a6eeU, +0xe4e44152U, +0x9fc2757dU, +0x1f534ddcU, +0xc9c882a5U, +0x3f84eafaU, +0x3ea69bb8U, +0x9391054aU, +0x7f09d5f4U, +0x7d4d3770U, +0x27220a94U, +0xfe13abe8U, +0xfa9a6ee0U, +0x4e441529U, +0xfc2757d1U, +0xf534ddc0U, +0x9c882a53U, +0xf84eafa3U, +0xea69bb81U, +0x391054a7U, +0xf09d5f47U, +0xd4d37703U, +0x7220a94fU, +0xe13abe8fU, +0xa9a6ee06U, +0xe441529fU, +0xc2757d1fU, +0x534ddc0dU, +0xc882a53fU, +0x84eafa3eU, +0xa69bb81bU, +0x91054a7fU, +0x9d5f47dU, +0x4d377036U, +0x220a94feU, +0x13abe8faU, +0x9a6ee06dU, +0x441529fcU, +0x2757d1f5U, +0x34ddc0dbU, +0x882a53f8U, +0x4eafa3eaU, +0x69bb81b6U, +0x1054a7f0U, +0x9d5f47d4U, +0xd377036dU, +0x20a94fe1U, +0x3abe8fa9U, +0xa6ee06dbU, +0x41529fc2U, +0x757d1f53U, +0x4ddc0db6U, +0x82a53f84U, +0xeafa3ea6U, +0x9bb81b6cU, +0x54a7f09U, +0xd5f47d4dU, +0x377036d8U, +0xa94fe13U, +0xabe8fa9aU, +0x6ee06db1U, +0x1529fc27U, +0x57d1f534U, +0xddc0db62U, +0x2a53f84eU, +0xafa3ea69U, +0xbb81b6c5U, +0x54a7f09dU, +0x5f47d4d3U, +0x77036d8aU, +0xa94fe13aU, +0xbe8fa9a6U, +0xee06db14U, +0x529fc275U, +0x7d1f534dU, +0xdc0db629U, +0xa53f84eaU, +0xfa3ea69bU, +0xb81b6c52U, +0x4a7f09d5U, +0xf47d4d37U, +0x7036d8a5U, +0x94fe13abU, +0xe8fa9a6eU, +0xe06db14aU, +0x29fc2757U, +0xd1f534ddU, +0xc0db6295U, +0x53f84eafU, +0xa3ea69bbU, +0x81b6c52bU, +0xa7f09d5fU, +0x47d4d377U, +0x36d8a56U, +0x4fe13abeU, +0x8fa9a6eeU, +0x6db14acU, +0x9fc2757dU, +0x1f534ddcU, +0xdb62959U, +0x3f84eafaU, +0x3ea69bb8U, +0x1b6c52b3U, +0x7f09d5f4U, +0x7d4d3770U, +0x36d8a566U, +0xfe13abe8U, +0xfa9a6ee0U, +0x6db14accU, +0xfc2757d1U, +0xf534ddc0U, +0xdb629599U, +0xf84eafa3U, +0xea69bb81U, +0xb6c52b32U, +0xf09d5f47U, +0xd4d37703U, +0x6d8a5664U, +0xe13abe8fU, +0xa9a6ee06U, +0xdb14acc9U, +0xc2757d1fU, +0x534ddc0dU, +0xb6295993U, +0x84eafa3eU, +0xa69bb81bU, +0x6c52b327U, +0x9d5f47dU, +0x4d377036U, +0xd8a5664fU, +0x13abe8faU, +0x9a6ee06dU, +0xb14acc9eU, +0x2757d1f5U, +0x34ddc0dbU, +0x6295993cU, +0x4eafa3eaU, +0x69bb81b6U, +0xc52b3278U, +0x9d5f47d4U, +0xd377036dU, +0x8a5664f1U, +0x3abe8fa9U, +0xa6ee06dbU, +0x14acc9e2U, +0x757d1f53U, +0x4ddc0db6U, +0x295993c4U, +0xeafa3ea6U, +0x9bb81b6cU, +0x52b32788U, +0xd5f47d4dU, +0x377036d8U, +0xa5664f10U, +0xabe8fa9aU, +0x6ee06db1U, +0x4acc9e21U, +0x57d1f534U, +0xddc0db62U, +0x95993c43U, +0xafa3ea69U, +0xbb81b6c5U, +0x2b327887U, +0x5f47d4d3U, +0x77036d8aU, +0x5664f10eU, +0xbe8fa9a6U, +0xee06db14U, +0xacc9e21cU, +0x7d1f534dU, +0xdc0db629U, +0x5993c439U, +0xfa3ea69bU, +0xb81b6c52U, +0xb3278872U, +0xf47d4d37U, +0x7036d8a5U, +0x664f10e4U, +0xe8fa9a6eU, +0xe06db14aU, +0xcc9e21c8U, +0xd1f534ddU, +0xc0db6295U, +0x993c4390U, +0xa3ea69bbU, +0x81b6c52bU, +0x32788720U, +0x47d4d377U, +0x36d8a56U, +0x64f10e41U, +0x8fa9a6eeU, +0x6db14acU, +0xc9e21c82U, +0x1f534ddcU, +0xdb62959U, +0x93c43904U, +0x3ea69bb8U, +0x1b6c52b3U, +0x27887208U, +0x7d4d3770U, +0x36d8a566U, +0x4f10e410U, +0xfa9a6ee0U, +0x6db14accU, +0x9e21c820U, +0xf534ddc0U, +0xdb629599U, +0x3c439041U, +0xea69bb81U, +0xb6c52b32U, +0x78872083U, +0xd4d37703U, +0x6d8a5664U, +0xf10e4107U, +0xa9a6ee06U, +0xdb14acc9U, +0xe21c820fU, +0x534ddc0dU, +0xb6295993U, +0xc439041fU, +0xa69bb81bU, +0x6c52b327U, +0x8872083fU, +0x4d377036U, +0xd8a5664fU, +0x10e4107fU, +0x9a6ee06dU, +0xb14acc9eU, +0x21c820ffU +}; +template <> HWY_ALIGN constexpr float kSinApproxTable[] = { +0, +0, +0, +0x1p0, +-0x1.3bcfbep-12, +0x1.92156p-6, +-0x1.0b933p-31, +0x1p0, +-0x1.3bc39p-10, +0x1.91f66p-5, +-0x1.de44fep-30, +0x1p0, +-0x1.63253p-9, +0x1.2d520ap-4, +-0x1.a63cc2p-29, +0x1p0, +-0x1.3b92e2p-8, +0x1.917a6cp-4, +-0x1.eb25eap-31, +0x1p0, +-0x1.ecdc78p-8, +0x1.f564e6p-4, +-0x1.2ad19ep-29, +0x1p0, +-0x1.62aa04p-7, +0x1.2c8106p-3, +0x1.d1cc28p-28, +0x1p0, +-0x1.e26c16p-7, +0x1.5e2144p-3, +0x1.22cff2p-29, +0x1p0, +-0x1.3ad06p-6, +0x1.8f8b84p-3, +-0x1.cb2cfap-30, +0x1p0, +-0x1.8e18a8p-6, +0x1.c0b826p-3, +0x1.4fc9ecp-28, +0x1p0, +-0x1.eb0208p-6, +0x1.f19f98p-3, +-0x1.37a83ap-29, +0x1p0, +-0x1.28bf18p-5, +0x1.111d26p-2, +0x1.58fb3cp-29, +0x1p0, +-0x1.60beaap-5, +0x1.294062p-2, +0x1.dab3ep-27, +0x1p0, +-0x1.9d7714p-5, +0x1.4135cap-2, +-0x1.7d134p-27, +0x1p0, +-0x1.dedefcp-5, +0x1.58f9a8p-2, +-0x1.4a9c04p-27, +0x1p0, +-0x1.127624p-4, +0x1.708854p-2, +-0x1.e0b74cp-27, +0x1p0, +-0x1.37ca18p-4, +0x1.87de2ap-2, +0x1.abaa58p-28, +0x1p0, +-0x1.5f6598p-4, +0x1.9ef794p-2, +0x1.d476c6p-29, +0x1p0, +-0x1.894286p-4, +0x1.b5d1p-2, +0x1.3c2b98p-27, +0x1p0, +-0x1.b55a7p-4, +0x1.cc66eap-2, +-0x1.b38ee8p-28, +0x1p0, +-0x1.e3a688p-4, +0x1.e2b5d4p-2, +-0x1.fe4272p-28, +0x1p0, +-0x1.0a0fd4p-3, +0x1.f8ba4ep-2, +-0x1.01d952p-28, +0x1p0, +-0x1.235f2ep-3, +0x1.07387ap-1, +-0x1.b74004p-27, +0x1p0, +-0x1.3dbd6ap-3, +0x1.11eb36p-1, +-0x1.7c969cp-26, +0x1p0, +-0x1.592676p-3, +0x1.1c73b4p-1, +-0x1.9465cep-27, +0x1p0, +-0x1.759618p-3, +0x1.26d054p-1, +0x1.9ba25cp-26, +0x1p0, +-0x1.9307eep-3, +0x1.30ff8p-1, +-0x1.8f47e6p-28, +0x1p0, +-0x1.b1776ep-3, +0x1.3affa2p-1, +0x1.240a18p-26, +0x1p0, +-0x1.d0dfe6p-3, +0x1.44cf32p-1, +0x1.424776p-27, +0x1p0, +-0x1.f13c7ep-3, +0x1.4e6cacp-1, +-0x1.070686p-27, +0x1p0, +-0x1.09441cp-2, +0x1.57d694p-1, +-0x1.6e626cp-26, +0x1p0, +-0x1.1a5efap-2, +0x1.610b76p-1, +-0x1.5c5a64p-26, +0x1p0, +0, +0x1.6a09e6p-1, +0x1.9fcef4p-27, +0, +0x1.842dd6p-3, +0x1.72d084p-1, +-0x1.02000ep-26, +0x1p-1, +0x1.5f5a4ep-3, +0x1.7b5df2p-1, +0x1.3557d8p-28, +0x1p-1, +0x1.39b2aep-3, +0x1.83b0ep-1, +0x1.7ff2eep-26, +0x1p-1, +0x1.133ccap-3, +0x1.8bc806p-1, +0x1.62a2e8p-26, +0x1p-1, +0x1.d7fd14p-4, +0x1.93a224p-1, +0x1.324c8p-26, +0x1p-1, +0x1.87fbfep-4, +0x1.9b3e04p-1, +0x1.fce1dp-27, +0x1p-1, +0x1.3682a6p-4, +0x1.a29a7ap-1, +0x1.189e08p-31, +0x1p-1, +0x1.c73b3ap-5, +0x1.a9b662p-1, +0x1.21d434p-26, +0x1p-1, +0x1.1eb354p-5, +0x1.b090a6p-1, +-0x1.fabf8p-27, +0x1p-1, +0x1.ce1e64p-7, +0x1.b72834p-1, +0x1.465b9p-27, +0x1p-1, +-0x1.d16c9p-8, +0x1.bd7c0ap-1, +0x1.8df2a6p-26, +0x1p-1, +-0x1.d4a2c8p-6, +0x1.c38b3p-1, +-0x1.cfe84ap-26, +0x1p-1, +-0x1.9cc8b4p-5, +0x1.c954b2p-1, +0x1.3411f4p-29, +0x1p-1, +-0x1.28bbfep-4, +0x1.ced7bp-1, +-0x1.786712p-26, +0x1p-1, +-0x1.8421bp-4, +0x1.d4134ep-1, +-0x1.d646d8p-26, +0x1p-1, +-0x1.e08756p-4, +0x1.d906bcp-1, +0x1.e651a8p-26, +0x1p-1, +-0x1.1eef5ap-3, +0x1.ddb13cp-1, +-0x1.2667b8p-26, +0x1p-1, +0x1.63e69ep-4, +0x1.e2121p-1, +0x1.3da1bap-27, +0x1p-2, +0x1.04d726p-4, +0x1.e6288ep-1, +0x1.891c22p-26, +0x1p-2, +0x1.4a0318p-5, +0x1.e9f416p-1, +-0x1.273a44p-26, +0x1p-2, +0x1.11d262p-6, +0x1.ed740ep-1, +0x1.da1258p-27, +0x1p-2, +-0x1.cc0d0ap-8, +0x1.f0a7fp-1, +-0x1.1b73cap-27, +0x1p-2, +-0x1.fa3ecap-6, +0x1.f38f3ap-1, +0x1.8c9cb2p-26, +0x1p-2, +-0x1.c1d1fp-5, +0x1.f6297cp-1, +0x1.feeb96p-26, +0x1p-2, +0x1.788512p-5, +0x1.f8765p-1, +-0x1.63ad16p-27, +0x1p-3, +0x1.640838p-6, +0x1.fa7558p-1, +-0x1.eeb5d2p-30, +0x1p-3, +-0x1.536352p-9, +0x1.fc2648p-1, +-0x1.e3cc06p-26, +0x1p-3, +-0x1.ba165p-6, +0x1.fd88dap-1, +0x1.e89292p-28, +0x1p-3, +0x1.6a904ap-7, +0x1.fe9cdap-1, +0x1.a03108p-26, +0x1p-4, +-0x1.b82684p-7, +0x1.ff621ep-1, +0x1.bcb6bep-28, +0x1p-4, +-0x1.b7aa82p-8, +0x1.ffd886p-1, +0x1.099a1ap-30, +0x1p-5, +0, +0x1p0, +0, +0, +0x1.b7aa82p-8, +0x1.ffd886p-1, +0x1.099a1ap-30, +-0x1p-5, +0x1.b82684p-7, +0x1.ff621ep-1, +0x1.bcb6bep-28, +-0x1p-4, +-0x1.6a904ap-7, +0x1.fe9cdap-1, +0x1.a03108p-26, +-0x1p-4, +0x1.ba165p-6, +0x1.fd88dap-1, +0x1.e89292p-28, +-0x1p-3, +0x1.536352p-9, +0x1.fc2648p-1, +-0x1.e3cc06p-26, +-0x1p-3, +-0x1.640838p-6, +0x1.fa7558p-1, +-0x1.eeb5d2p-30, +-0x1p-3, +-0x1.788512p-5, +0x1.f8765p-1, +-0x1.63ad16p-27, +-0x1p-3, +0x1.c1d1fp-5, +0x1.f6297cp-1, +0x1.feeb96p-26, +-0x1p-2, +0x1.fa3ecap-6, +0x1.f38f3ap-1, +0x1.8c9cb2p-26, +-0x1p-2, +0x1.cc0d0ap-8, +0x1.f0a7fp-1, +-0x1.1b73cap-27, +-0x1p-2, +-0x1.11d262p-6, +0x1.ed740ep-1, +0x1.da1258p-27, +-0x1p-2, +-0x1.4a0318p-5, +0x1.e9f416p-1, +-0x1.273a44p-26, +-0x1p-2, +-0x1.04d726p-4, +0x1.e6288ep-1, +0x1.891c22p-26, +-0x1p-2, +-0x1.63e69ep-4, +0x1.e2121p-1, +0x1.3da1bap-27, +-0x1p-2, +0x1.1eef5ap-3, +0x1.ddb13cp-1, +-0x1.2667b8p-26, +-0x1p-1, +0x1.e08756p-4, +0x1.d906bcp-1, +0x1.e651a8p-26, +-0x1p-1, +0x1.8421bp-4, +0x1.d4134ep-1, +-0x1.d646d8p-26, +-0x1p-1, +0x1.28bbfep-4, +0x1.ced7bp-1, +-0x1.786712p-26, +-0x1p-1, +0x1.9cc8b4p-5, +0x1.c954b2p-1, +0x1.3411f4p-29, +-0x1p-1, +0x1.d4a2c8p-6, +0x1.c38b3p-1, +-0x1.cfe84ap-26, +-0x1p-1, +0x1.d16c9p-8, +0x1.bd7c0ap-1, +0x1.8df2a6p-26, +-0x1p-1, +-0x1.ce1e64p-7, +0x1.b72834p-1, +0x1.465b9p-27, +-0x1p-1, +-0x1.1eb354p-5, +0x1.b090a6p-1, +-0x1.fabf8p-27, +-0x1p-1, +-0x1.c73b3ap-5, +0x1.a9b662p-1, +0x1.21d434p-26, +-0x1p-1, +-0x1.3682a6p-4, +0x1.a29a7ap-1, +0x1.189e08p-31, +-0x1p-1, +-0x1.87fbfep-4, +0x1.9b3e04p-1, +0x1.fce1dp-27, +-0x1p-1, +-0x1.d7fd14p-4, +0x1.93a224p-1, +0x1.324c8p-26, +-0x1p-1, +-0x1.133ccap-3, +0x1.8bc806p-1, +0x1.62a2e8p-26, +-0x1p-1, +-0x1.39b2aep-3, +0x1.83b0ep-1, +0x1.7ff2eep-26, +-0x1p-1, +-0x1.5f5a4ep-3, +0x1.7b5df2p-1, +0x1.3557d8p-28, +-0x1p-1, +-0x1.842dd6p-3, +0x1.72d084p-1, +-0x1.02000ep-26, +-0x1p-1, +0, +0x1.6a09e6p-1, +0x1.9fcef4p-27, +0, +0x1.1a5efap-2, +0x1.610b76p-1, +-0x1.5c5a64p-26, +-0x1p0, +0x1.09441cp-2, +0x1.57d694p-1, +-0x1.6e626cp-26, +-0x1p0, +0x1.f13c7ep-3, +0x1.4e6cacp-1, +-0x1.070686p-27, +-0x1p0, +0x1.d0dfe6p-3, +0x1.44cf32p-1, +0x1.424776p-27, +-0x1p0, +0x1.b1776ep-3, +0x1.3affa2p-1, +0x1.240a18p-26, +-0x1p0, +0x1.9307eep-3, +0x1.30ff8p-1, +-0x1.8f47e6p-28, +-0x1p0, +0x1.759618p-3, +0x1.26d054p-1, +0x1.9ba25cp-26, +-0x1p0, +0x1.592676p-3, +0x1.1c73b4p-1, +-0x1.9465cep-27, +-0x1p0, +0x1.3dbd6ap-3, +0x1.11eb36p-1, +-0x1.7c969cp-26, +-0x1p0, +0x1.235f2ep-3, +0x1.07387ap-1, +-0x1.b74004p-27, +-0x1p0, +0x1.0a0fd4p-3, +0x1.f8ba4ep-2, +-0x1.01d952p-28, +-0x1p0, +0x1.e3a688p-4, +0x1.e2b5d4p-2, +-0x1.fe4272p-28, +-0x1p0, +0x1.b55a7p-4, +0x1.cc66eap-2, +-0x1.b38ee8p-28, +-0x1p0, +0x1.894286p-4, +0x1.b5d1p-2, +0x1.3c2b98p-27, +-0x1p0, +0x1.5f6598p-4, +0x1.9ef794p-2, +0x1.d476c6p-29, +-0x1p0, +0x1.37ca18p-4, +0x1.87de2ap-2, +0x1.abaa58p-28, +-0x1p0, +0x1.127624p-4, +0x1.708854p-2, +-0x1.e0b74cp-27, +-0x1p0, +0x1.dedefcp-5, +0x1.58f9a8p-2, +-0x1.4a9c04p-27, +-0x1p0, +0x1.9d7714p-5, +0x1.4135cap-2, +-0x1.7d134p-27, +-0x1p0, +0x1.60beaap-5, +0x1.294062p-2, +0x1.dab3ep-27, +-0x1p0, +0x1.28bf18p-5, +0x1.111d26p-2, +0x1.58fb3cp-29, +-0x1p0, +0x1.eb0208p-6, +0x1.f19f98p-3, +-0x1.37a83ap-29, +-0x1p0, +0x1.8e18a8p-6, +0x1.c0b826p-3, +0x1.4fc9ecp-28, +-0x1p0, +0x1.3ad06p-6, +0x1.8f8b84p-3, +-0x1.cb2cfap-30, +-0x1p0, +0x1.e26c16p-7, +0x1.5e2144p-3, +0x1.22cff2p-29, +-0x1p0, +0x1.62aa04p-7, +0x1.2c8106p-3, +0x1.d1cc28p-28, +-0x1p0, +0x1.ecdc78p-8, +0x1.f564e6p-4, +-0x1.2ad19ep-29, +-0x1p0, +0x1.3b92e2p-8, +0x1.917a6cp-4, +-0x1.eb25eap-31, +-0x1p0, +0x1.63253p-9, +0x1.2d520ap-4, +-0x1.a63cc2p-29, +-0x1p0, +0x1.3bc39p-10, +0x1.91f66p-5, +-0x1.de44fep-30, +-0x1p0, +0x1.3bcfbep-12, +0x1.92156p-6, +-0x1.0b933p-31, +-0x1p0, +0, +0, +0, +-0x1p0, +0x1.3bcfbep-12, +-0x1.92156p-6, +0x1.0b933p-31, +-0x1p0, +0x1.3bc39p-10, +-0x1.91f66p-5, +0x1.de44fep-30, +-0x1p0, +0x1.63253p-9, +-0x1.2d520ap-4, +0x1.a63cc2p-29, +-0x1p0, +0x1.3b92e2p-8, +-0x1.917a6cp-4, +0x1.eb25eap-31, +-0x1p0, +0x1.ecdc78p-8, +-0x1.f564e6p-4, +0x1.2ad19ep-29, +-0x1p0, +0x1.62aa04p-7, +-0x1.2c8106p-3, +-0x1.d1cc28p-28, +-0x1p0, +0x1.e26c16p-7, +-0x1.5e2144p-3, +-0x1.22cff2p-29, +-0x1p0, +0x1.3ad06p-6, +-0x1.8f8b84p-3, +0x1.cb2cfap-30, +-0x1p0, +0x1.8e18a8p-6, +-0x1.c0b826p-3, +-0x1.4fc9ecp-28, +-0x1p0, +0x1.eb0208p-6, +-0x1.f19f98p-3, +0x1.37a83ap-29, +-0x1p0, +0x1.28bf18p-5, +-0x1.111d26p-2, +-0x1.58fb3cp-29, +-0x1p0, +0x1.60beaap-5, +-0x1.294062p-2, +-0x1.dab3ep-27, +-0x1p0, +0x1.9d7714p-5, +-0x1.4135cap-2, +0x1.7d134p-27, +-0x1p0, +0x1.dedefcp-5, +-0x1.58f9a8p-2, +0x1.4a9c04p-27, +-0x1p0, +0x1.127624p-4, +-0x1.708854p-2, +0x1.e0b74cp-27, +-0x1p0, +0x1.37ca18p-4, +-0x1.87de2ap-2, +-0x1.abaa58p-28, +-0x1p0, +0x1.5f6598p-4, +-0x1.9ef794p-2, +-0x1.d476c6p-29, +-0x1p0, +0x1.894286p-4, +-0x1.b5d1p-2, +-0x1.3c2b98p-27, +-0x1p0, +0x1.b55a7p-4, +-0x1.cc66eap-2, +0x1.b38ee8p-28, +-0x1p0, +0x1.e3a688p-4, +-0x1.e2b5d4p-2, +0x1.fe4272p-28, +-0x1p0, +0x1.0a0fd4p-3, +-0x1.f8ba4ep-2, +0x1.01d952p-28, +-0x1p0, +0x1.235f2ep-3, +-0x1.07387ap-1, +0x1.b74004p-27, +-0x1p0, +0x1.3dbd6ap-3, +-0x1.11eb36p-1, +0x1.7c969cp-26, +-0x1p0, +0x1.592676p-3, +-0x1.1c73b4p-1, +0x1.9465cep-27, +-0x1p0, +0x1.759618p-3, +-0x1.26d054p-1, +-0x1.9ba25cp-26, +-0x1p0, +0x1.9307eep-3, +-0x1.30ff8p-1, +0x1.8f47e6p-28, +-0x1p0, +0x1.b1776ep-3, +-0x1.3affa2p-1, +-0x1.240a18p-26, +-0x1p0, +0x1.d0dfe6p-3, +-0x1.44cf32p-1, +-0x1.424776p-27, +-0x1p0, +0x1.f13c7ep-3, +-0x1.4e6cacp-1, +0x1.070686p-27, +-0x1p0, +0x1.09441cp-2, +-0x1.57d694p-1, +0x1.6e626cp-26, +-0x1p0, +0x1.1a5efap-2, +-0x1.610b76p-1, +0x1.5c5a64p-26, +-0x1p0, +0, +-0x1.6a09e6p-1, +-0x1.9fcef4p-27, +0, +-0x1.842dd6p-3, +-0x1.72d084p-1, +0x1.02000ep-26, +-0x1p-1, +-0x1.5f5a4ep-3, +-0x1.7b5df2p-1, +-0x1.3557d8p-28, +-0x1p-1, +-0x1.39b2aep-3, +-0x1.83b0ep-1, +-0x1.7ff2eep-26, +-0x1p-1, +-0x1.133ccap-3, +-0x1.8bc806p-1, +-0x1.62a2e8p-26, +-0x1p-1, +-0x1.d7fd14p-4, +-0x1.93a224p-1, +-0x1.324c8p-26, +-0x1p-1, +-0x1.87fbfep-4, +-0x1.9b3e04p-1, +-0x1.fce1dp-27, +-0x1p-1, +-0x1.3682a6p-4, +-0x1.a29a7ap-1, +-0x1.189e08p-31, +-0x1p-1, +-0x1.c73b3ap-5, +-0x1.a9b662p-1, +-0x1.21d434p-26, +-0x1p-1, +-0x1.1eb354p-5, +-0x1.b090a6p-1, +0x1.fabf8p-27, +-0x1p-1, +-0x1.ce1e64p-7, +-0x1.b72834p-1, +-0x1.465b9p-27, +-0x1p-1, +0x1.d16c9p-8, +-0x1.bd7c0ap-1, +-0x1.8df2a6p-26, +-0x1p-1, +0x1.d4a2c8p-6, +-0x1.c38b3p-1, +0x1.cfe84ap-26, +-0x1p-1, +0x1.9cc8b4p-5, +-0x1.c954b2p-1, +-0x1.3411f4p-29, +-0x1p-1, +0x1.28bbfep-4, +-0x1.ced7bp-1, +0x1.786712p-26, +-0x1p-1, +0x1.8421bp-4, +-0x1.d4134ep-1, +0x1.d646d8p-26, +-0x1p-1, +0x1.e08756p-4, +-0x1.d906bcp-1, +-0x1.e651a8p-26, +-0x1p-1, +0x1.1eef5ap-3, +-0x1.ddb13cp-1, +0x1.2667b8p-26, +-0x1p-1, +-0x1.63e69ep-4, +-0x1.e2121p-1, +-0x1.3da1bap-27, +-0x1p-2, +-0x1.04d726p-4, +-0x1.e6288ep-1, +-0x1.891c22p-26, +-0x1p-2, +-0x1.4a0318p-5, +-0x1.e9f416p-1, +0x1.273a44p-26, +-0x1p-2, +-0x1.11d262p-6, +-0x1.ed740ep-1, +-0x1.da1258p-27, +-0x1p-2, +0x1.cc0d0ap-8, +-0x1.f0a7fp-1, +0x1.1b73cap-27, +-0x1p-2, +0x1.fa3ecap-6, +-0x1.f38f3ap-1, +-0x1.8c9cb2p-26, +-0x1p-2, +0x1.c1d1fp-5, +-0x1.f6297cp-1, +-0x1.feeb96p-26, +-0x1p-2, +-0x1.788512p-5, +-0x1.f8765p-1, +0x1.63ad16p-27, +-0x1p-3, +-0x1.640838p-6, +-0x1.fa7558p-1, +0x1.eeb5d2p-30, +-0x1p-3, +0x1.536352p-9, +-0x1.fc2648p-1, +0x1.e3cc06p-26, +-0x1p-3, +0x1.ba165p-6, +-0x1.fd88dap-1, +-0x1.e89292p-28, +-0x1p-3, +-0x1.6a904ap-7, +-0x1.fe9cdap-1, +-0x1.a03108p-26, +-0x1p-4, +0x1.b82684p-7, +-0x1.ff621ep-1, +-0x1.bcb6bep-28, +-0x1p-4, +0x1.b7aa82p-8, +-0x1.ffd886p-1, +-0x1.099a1ap-30, +-0x1p-5, +0, +-0x1p0, +0, +0, +-0x1.b7aa82p-8, +-0x1.ffd886p-1, +-0x1.099a1ap-30, +0x1p-5, +-0x1.b82684p-7, +-0x1.ff621ep-1, +-0x1.bcb6bep-28, +0x1p-4, +0x1.6a904ap-7, +-0x1.fe9cdap-1, +-0x1.a03108p-26, +0x1p-4, +-0x1.ba165p-6, +-0x1.fd88dap-1, +-0x1.e89292p-28, +0x1p-3, +-0x1.536352p-9, +-0x1.fc2648p-1, +0x1.e3cc06p-26, +0x1p-3, +0x1.640838p-6, +-0x1.fa7558p-1, +0x1.eeb5d2p-30, +0x1p-3, +0x1.788512p-5, +-0x1.f8765p-1, +0x1.63ad16p-27, +0x1p-3, +-0x1.c1d1fp-5, +-0x1.f6297cp-1, +-0x1.feeb96p-26, +0x1p-2, +-0x1.fa3ecap-6, +-0x1.f38f3ap-1, +-0x1.8c9cb2p-26, +0x1p-2, +-0x1.cc0d0ap-8, +-0x1.f0a7fp-1, +0x1.1b73cap-27, +0x1p-2, +0x1.11d262p-6, +-0x1.ed740ep-1, +-0x1.da1258p-27, +0x1p-2, +0x1.4a0318p-5, +-0x1.e9f416p-1, +0x1.273a44p-26, +0x1p-2, +0x1.04d726p-4, +-0x1.e6288ep-1, +-0x1.891c22p-26, +0x1p-2, +0x1.63e69ep-4, +-0x1.e2121p-1, +-0x1.3da1bap-27, +0x1p-2, +-0x1.1eef5ap-3, +-0x1.ddb13cp-1, +0x1.2667b8p-26, +0x1p-1, +-0x1.e08756p-4, +-0x1.d906bcp-1, +-0x1.e651a8p-26, +0x1p-1, +-0x1.8421bp-4, +-0x1.d4134ep-1, +0x1.d646d8p-26, +0x1p-1, +-0x1.28bbfep-4, +-0x1.ced7bp-1, +0x1.786712p-26, +0x1p-1, +-0x1.9cc8b4p-5, +-0x1.c954b2p-1, +-0x1.3411f4p-29, +0x1p-1, +-0x1.d4a2c8p-6, +-0x1.c38b3p-1, +0x1.cfe84ap-26, +0x1p-1, +-0x1.d16c9p-8, +-0x1.bd7c0ap-1, +-0x1.8df2a6p-26, +0x1p-1, +0x1.ce1e64p-7, +-0x1.b72834p-1, +-0x1.465b9p-27, +0x1p-1, +0x1.1eb354p-5, +-0x1.b090a6p-1, +0x1.fabf8p-27, +0x1p-1, +0x1.c73b3ap-5, +-0x1.a9b662p-1, +-0x1.21d434p-26, +0x1p-1, +0x1.3682a6p-4, +-0x1.a29a7ap-1, +-0x1.189e08p-31, +0x1p-1, +0x1.87fbfep-4, +-0x1.9b3e04p-1, +-0x1.fce1dp-27, +0x1p-1, +0x1.d7fd14p-4, +-0x1.93a224p-1, +-0x1.324c8p-26, +0x1p-1, +0x1.133ccap-3, +-0x1.8bc806p-1, +-0x1.62a2e8p-26, +0x1p-1, +0x1.39b2aep-3, +-0x1.83b0ep-1, +-0x1.7ff2eep-26, +0x1p-1, +0x1.5f5a4ep-3, +-0x1.7b5df2p-1, +-0x1.3557d8p-28, +0x1p-1, +0x1.842dd6p-3, +-0x1.72d084p-1, +0x1.02000ep-26, +0x1p-1, +0, +-0x1.6a09e6p-1, +-0x1.9fcef4p-27, +0, +-0x1.1a5efap-2, +-0x1.610b76p-1, +0x1.5c5a64p-26, +0x1p0, +-0x1.09441cp-2, +-0x1.57d694p-1, +0x1.6e626cp-26, +0x1p0, +-0x1.f13c7ep-3, +-0x1.4e6cacp-1, +0x1.070686p-27, +0x1p0, +-0x1.d0dfe6p-3, +-0x1.44cf32p-1, +-0x1.424776p-27, +0x1p0, +-0x1.b1776ep-3, +-0x1.3affa2p-1, +-0x1.240a18p-26, +0x1p0, +-0x1.9307eep-3, +-0x1.30ff8p-1, +0x1.8f47e6p-28, +0x1p0, +-0x1.759618p-3, +-0x1.26d054p-1, +-0x1.9ba25cp-26, +0x1p0, +-0x1.592676p-3, +-0x1.1c73b4p-1, +0x1.9465cep-27, +0x1p0, +-0x1.3dbd6ap-3, +-0x1.11eb36p-1, +0x1.7c969cp-26, +0x1p0, +-0x1.235f2ep-3, +-0x1.07387ap-1, +0x1.b74004p-27, +0x1p0, +-0x1.0a0fd4p-3, +-0x1.f8ba4ep-2, +0x1.01d952p-28, +0x1p0, +-0x1.e3a688p-4, +-0x1.e2b5d4p-2, +0x1.fe4272p-28, +0x1p0, +-0x1.b55a7p-4, +-0x1.cc66eap-2, +0x1.b38ee8p-28, +0x1p0, +-0x1.894286p-4, +-0x1.b5d1p-2, +-0x1.3c2b98p-27, +0x1p0, +-0x1.5f6598p-4, +-0x1.9ef794p-2, +-0x1.d476c6p-29, +0x1p0, +-0x1.37ca18p-4, +-0x1.87de2ap-2, +-0x1.abaa58p-28, +0x1p0, +-0x1.127624p-4, +-0x1.708854p-2, +0x1.e0b74cp-27, +0x1p0, +-0x1.dedefcp-5, +-0x1.58f9a8p-2, +0x1.4a9c04p-27, +0x1p0, +-0x1.9d7714p-5, +-0x1.4135cap-2, +0x1.7d134p-27, +0x1p0, +-0x1.60beaap-5, +-0x1.294062p-2, +-0x1.dab3ep-27, +0x1p0, +-0x1.28bf18p-5, +-0x1.111d26p-2, +-0x1.58fb3cp-29, +0x1p0, +-0x1.eb0208p-6, +-0x1.f19f98p-3, +0x1.37a83ap-29, +0x1p0, +-0x1.8e18a8p-6, +-0x1.c0b826p-3, +-0x1.4fc9ecp-28, +0x1p0, +-0x1.3ad06p-6, +-0x1.8f8b84p-3, +0x1.cb2cfap-30, +0x1p0, +-0x1.e26c16p-7, +-0x1.5e2144p-3, +-0x1.22cff2p-29, +0x1p0, +-0x1.62aa04p-7, +-0x1.2c8106p-3, +-0x1.d1cc28p-28, +0x1p0, +-0x1.ecdc78p-8, +-0x1.f564e6p-4, +0x1.2ad19ep-29, +0x1p0, +-0x1.3b92e2p-8, +-0x1.917a6cp-4, +0x1.eb25eap-31, +0x1p0, +-0x1.63253p-9, +-0x1.2d520ap-4, +0x1.a63cc2p-29, +0x1p0, +-0x1.3bc39p-10, +-0x1.91f66p-5, +0x1.de44fep-30, +0x1p0, +-0x1.3bcfbep-12, +-0x1.92156p-6, +0x1.0b933p-31, +0x1p0 +}; +template <> HWY_ALIGN constexpr float kCosApproxTable[] = { +0, +0x1p0, +0, +0, +0x1.b7aa82p-8, +0x1.ffd886p-1, +0x1.099a1ap-30, +-0x1p-5, +0x1.b82684p-7, +0x1.ff621ep-1, +0x1.bcb6bep-28, +-0x1p-4, +-0x1.6a904ap-7, +0x1.fe9cdap-1, +0x1.a03108p-26, +-0x1p-4, +0x1.ba165p-6, +0x1.fd88dap-1, +0x1.e89292p-28, +-0x1p-3, +0x1.536352p-9, +0x1.fc2648p-1, +-0x1.e3cc06p-26, +-0x1p-3, +-0x1.640838p-6, +0x1.fa7558p-1, +-0x1.eeb5d2p-30, +-0x1p-3, +-0x1.788512p-5, +0x1.f8765p-1, +-0x1.63ad16p-27, +-0x1p-3, +0x1.c1d1fp-5, +0x1.f6297cp-1, +0x1.feeb96p-26, +-0x1p-2, +0x1.fa3ecap-6, +0x1.f38f3ap-1, +0x1.8c9cb2p-26, +-0x1p-2, +0x1.cc0d0ap-8, +0x1.f0a7fp-1, +-0x1.1b73cap-27, +-0x1p-2, +-0x1.11d262p-6, +0x1.ed740ep-1, +0x1.da1258p-27, +-0x1p-2, +-0x1.4a0318p-5, +0x1.e9f416p-1, +-0x1.273a44p-26, +-0x1p-2, +-0x1.04d726p-4, +0x1.e6288ep-1, +0x1.891c22p-26, +-0x1p-2, +-0x1.63e69ep-4, +0x1.e2121p-1, +0x1.3da1bap-27, +-0x1p-2, +0x1.1eef5ap-3, +0x1.ddb13cp-1, +-0x1.2667b8p-26, +-0x1p-1, +0x1.e08756p-4, +0x1.d906bcp-1, +0x1.e651a8p-26, +-0x1p-1, +0x1.8421bp-4, +0x1.d4134ep-1, +-0x1.d646d8p-26, +-0x1p-1, +0x1.28bbfep-4, +0x1.ced7bp-1, +-0x1.786712p-26, +-0x1p-1, +0x1.9cc8b4p-5, +0x1.c954b2p-1, +0x1.3411f4p-29, +-0x1p-1, +0x1.d4a2c8p-6, +0x1.c38b3p-1, +-0x1.cfe84ap-26, +-0x1p-1, +0x1.d16c9p-8, +0x1.bd7c0ap-1, +0x1.8df2a6p-26, +-0x1p-1, +-0x1.ce1e64p-7, +0x1.b72834p-1, +0x1.465b9p-27, +-0x1p-1, +-0x1.1eb354p-5, +0x1.b090a6p-1, +-0x1.fabf8p-27, +-0x1p-1, +-0x1.c73b3ap-5, +0x1.a9b662p-1, +0x1.21d434p-26, +-0x1p-1, +-0x1.3682a6p-4, +0x1.a29a7ap-1, +0x1.189e08p-31, +-0x1p-1, +-0x1.87fbfep-4, +0x1.9b3e04p-1, +0x1.fce1dp-27, +-0x1p-1, +-0x1.d7fd14p-4, +0x1.93a224p-1, +0x1.324c8p-26, +-0x1p-1, +-0x1.133ccap-3, +0x1.8bc806p-1, +0x1.62a2e8p-26, +-0x1p-1, +-0x1.39b2aep-3, +0x1.83b0ep-1, +0x1.7ff2eep-26, +-0x1p-1, +-0x1.5f5a4ep-3, +0x1.7b5df2p-1, +0x1.3557d8p-28, +-0x1p-1, +-0x1.842dd6p-3, +0x1.72d084p-1, +-0x1.02000ep-26, +-0x1p-1, +0, +0x1.6a09e6p-1, +0x1.9fcef4p-27, +0, +0x1.1a5efap-2, +0x1.610b76p-1, +-0x1.5c5a64p-26, +-0x1p0, +0x1.09441cp-2, +0x1.57d694p-1, +-0x1.6e626cp-26, +-0x1p0, +0x1.f13c7ep-3, +0x1.4e6cacp-1, +-0x1.070686p-27, +-0x1p0, +0x1.d0dfe6p-3, +0x1.44cf32p-1, +0x1.424776p-27, +-0x1p0, +0x1.b1776ep-3, +0x1.3affa2p-1, +0x1.240a18p-26, +-0x1p0, +0x1.9307eep-3, +0x1.30ff8p-1, +-0x1.8f47e6p-28, +-0x1p0, +0x1.759618p-3, +0x1.26d054p-1, +0x1.9ba25cp-26, +-0x1p0, +0x1.592676p-3, +0x1.1c73b4p-1, +-0x1.9465cep-27, +-0x1p0, +0x1.3dbd6ap-3, +0x1.11eb36p-1, +-0x1.7c969cp-26, +-0x1p0, +0x1.235f2ep-3, +0x1.07387ap-1, +-0x1.b74004p-27, +-0x1p0, +0x1.0a0fd4p-3, +0x1.f8ba4ep-2, +-0x1.01d952p-28, +-0x1p0, +0x1.e3a688p-4, +0x1.e2b5d4p-2, +-0x1.fe4272p-28, +-0x1p0, +0x1.b55a7p-4, +0x1.cc66eap-2, +-0x1.b38ee8p-28, +-0x1p0, +0x1.894286p-4, +0x1.b5d1p-2, +0x1.3c2b98p-27, +-0x1p0, +0x1.5f6598p-4, +0x1.9ef794p-2, +0x1.d476c6p-29, +-0x1p0, +0x1.37ca18p-4, +0x1.87de2ap-2, +0x1.abaa58p-28, +-0x1p0, +0x1.127624p-4, +0x1.708854p-2, +-0x1.e0b74cp-27, +-0x1p0, +0x1.dedefcp-5, +0x1.58f9a8p-2, +-0x1.4a9c04p-27, +-0x1p0, +0x1.9d7714p-5, +0x1.4135cap-2, +-0x1.7d134p-27, +-0x1p0, +0x1.60beaap-5, +0x1.294062p-2, +0x1.dab3ep-27, +-0x1p0, +0x1.28bf18p-5, +0x1.111d26p-2, +0x1.58fb3cp-29, +-0x1p0, +0x1.eb0208p-6, +0x1.f19f98p-3, +-0x1.37a83ap-29, +-0x1p0, +0x1.8e18a8p-6, +0x1.c0b826p-3, +0x1.4fc9ecp-28, +-0x1p0, +0x1.3ad06p-6, +0x1.8f8b84p-3, +-0x1.cb2cfap-30, +-0x1p0, +0x1.e26c16p-7, +0x1.5e2144p-3, +0x1.22cff2p-29, +-0x1p0, +0x1.62aa04p-7, +0x1.2c8106p-3, +0x1.d1cc28p-28, +-0x1p0, +0x1.ecdc78p-8, +0x1.f564e6p-4, +-0x1.2ad19ep-29, +-0x1p0, +0x1.3b92e2p-8, +0x1.917a6cp-4, +-0x1.eb25eap-31, +-0x1p0, +0x1.63253p-9, +0x1.2d520ap-4, +-0x1.a63cc2p-29, +-0x1p0, +0x1.3bc39p-10, +0x1.91f66p-5, +-0x1.de44fep-30, +-0x1p0, +0x1.3bcfbep-12, +0x1.92156p-6, +-0x1.0b933p-31, +-0x1p0, +0, +0, +0, +-0x1p0, +0x1.3bcfbep-12, +-0x1.92156p-6, +0x1.0b933p-31, +-0x1p0, +0x1.3bc39p-10, +-0x1.91f66p-5, +0x1.de44fep-30, +-0x1p0, +0x1.63253p-9, +-0x1.2d520ap-4, +0x1.a63cc2p-29, +-0x1p0, +0x1.3b92e2p-8, +-0x1.917a6cp-4, +0x1.eb25eap-31, +-0x1p0, +0x1.ecdc78p-8, +-0x1.f564e6p-4, +0x1.2ad19ep-29, +-0x1p0, +0x1.62aa04p-7, +-0x1.2c8106p-3, +-0x1.d1cc28p-28, +-0x1p0, +0x1.e26c16p-7, +-0x1.5e2144p-3, +-0x1.22cff2p-29, +-0x1p0, +0x1.3ad06p-6, +-0x1.8f8b84p-3, +0x1.cb2cfap-30, +-0x1p0, +0x1.8e18a8p-6, +-0x1.c0b826p-3, +-0x1.4fc9ecp-28, +-0x1p0, +0x1.eb0208p-6, +-0x1.f19f98p-3, +0x1.37a83ap-29, +-0x1p0, +0x1.28bf18p-5, +-0x1.111d26p-2, +-0x1.58fb3cp-29, +-0x1p0, +0x1.60beaap-5, +-0x1.294062p-2, +-0x1.dab3ep-27, +-0x1p0, +0x1.9d7714p-5, +-0x1.4135cap-2, +0x1.7d134p-27, +-0x1p0, +0x1.dedefcp-5, +-0x1.58f9a8p-2, +0x1.4a9c04p-27, +-0x1p0, +0x1.127624p-4, +-0x1.708854p-2, +0x1.e0b74cp-27, +-0x1p0, +0x1.37ca18p-4, +-0x1.87de2ap-2, +-0x1.abaa58p-28, +-0x1p0, +0x1.5f6598p-4, +-0x1.9ef794p-2, +-0x1.d476c6p-29, +-0x1p0, +0x1.894286p-4, +-0x1.b5d1p-2, +-0x1.3c2b98p-27, +-0x1p0, +0x1.b55a7p-4, +-0x1.cc66eap-2, +0x1.b38ee8p-28, +-0x1p0, +0x1.e3a688p-4, +-0x1.e2b5d4p-2, +0x1.fe4272p-28, +-0x1p0, +0x1.0a0fd4p-3, +-0x1.f8ba4ep-2, +0x1.01d952p-28, +-0x1p0, +0x1.235f2ep-3, +-0x1.07387ap-1, +0x1.b74004p-27, +-0x1p0, +0x1.3dbd6ap-3, +-0x1.11eb36p-1, +0x1.7c969cp-26, +-0x1p0, +0x1.592676p-3, +-0x1.1c73b4p-1, +0x1.9465cep-27, +-0x1p0, +0x1.759618p-3, +-0x1.26d054p-1, +-0x1.9ba25cp-26, +-0x1p0, +0x1.9307eep-3, +-0x1.30ff8p-1, +0x1.8f47e6p-28, +-0x1p0, +0x1.b1776ep-3, +-0x1.3affa2p-1, +-0x1.240a18p-26, +-0x1p0, +0x1.d0dfe6p-3, +-0x1.44cf32p-1, +-0x1.424776p-27, +-0x1p0, +0x1.f13c7ep-3, +-0x1.4e6cacp-1, +0x1.070686p-27, +-0x1p0, +0x1.09441cp-2, +-0x1.57d694p-1, +0x1.6e626cp-26, +-0x1p0, +0x1.1a5efap-2, +-0x1.610b76p-1, +0x1.5c5a64p-26, +-0x1p0, +0, +-0x1.6a09e6p-1, +-0x1.9fcef4p-27, +0, +-0x1.842dd6p-3, +-0x1.72d084p-1, +0x1.02000ep-26, +-0x1p-1, +-0x1.5f5a4ep-3, +-0x1.7b5df2p-1, +-0x1.3557d8p-28, +-0x1p-1, +-0x1.39b2aep-3, +-0x1.83b0ep-1, +-0x1.7ff2eep-26, +-0x1p-1, +-0x1.133ccap-3, +-0x1.8bc806p-1, +-0x1.62a2e8p-26, +-0x1p-1, +-0x1.d7fd14p-4, +-0x1.93a224p-1, +-0x1.324c8p-26, +-0x1p-1, +-0x1.87fbfep-4, +-0x1.9b3e04p-1, +-0x1.fce1dp-27, +-0x1p-1, +-0x1.3682a6p-4, +-0x1.a29a7ap-1, +-0x1.189e08p-31, +-0x1p-1, +-0x1.c73b3ap-5, +-0x1.a9b662p-1, +-0x1.21d434p-26, +-0x1p-1, +-0x1.1eb354p-5, +-0x1.b090a6p-1, +0x1.fabf8p-27, +-0x1p-1, +-0x1.ce1e64p-7, +-0x1.b72834p-1, +-0x1.465b9p-27, +-0x1p-1, +0x1.d16c9p-8, +-0x1.bd7c0ap-1, +-0x1.8df2a6p-26, +-0x1p-1, +0x1.d4a2c8p-6, +-0x1.c38b3p-1, +0x1.cfe84ap-26, +-0x1p-1, +0x1.9cc8b4p-5, +-0x1.c954b2p-1, +-0x1.3411f4p-29, +-0x1p-1, +0x1.28bbfep-4, +-0x1.ced7bp-1, +0x1.786712p-26, +-0x1p-1, +0x1.8421bp-4, +-0x1.d4134ep-1, +0x1.d646d8p-26, +-0x1p-1, +0x1.e08756p-4, +-0x1.d906bcp-1, +-0x1.e651a8p-26, +-0x1p-1, +0x1.1eef5ap-3, +-0x1.ddb13cp-1, +0x1.2667b8p-26, +-0x1p-1, +-0x1.63e69ep-4, +-0x1.e2121p-1, +-0x1.3da1bap-27, +-0x1p-2, +-0x1.04d726p-4, +-0x1.e6288ep-1, +-0x1.891c22p-26, +-0x1p-2, +-0x1.4a0318p-5, +-0x1.e9f416p-1, +0x1.273a44p-26, +-0x1p-2, +-0x1.11d262p-6, +-0x1.ed740ep-1, +-0x1.da1258p-27, +-0x1p-2, +0x1.cc0d0ap-8, +-0x1.f0a7fp-1, +0x1.1b73cap-27, +-0x1p-2, +0x1.fa3ecap-6, +-0x1.f38f3ap-1, +-0x1.8c9cb2p-26, +-0x1p-2, +0x1.c1d1fp-5, +-0x1.f6297cp-1, +-0x1.feeb96p-26, +-0x1p-2, +-0x1.788512p-5, +-0x1.f8765p-1, +0x1.63ad16p-27, +-0x1p-3, +-0x1.640838p-6, +-0x1.fa7558p-1, +0x1.eeb5d2p-30, +-0x1p-3, +0x1.536352p-9, +-0x1.fc2648p-1, +0x1.e3cc06p-26, +-0x1p-3, +0x1.ba165p-6, +-0x1.fd88dap-1, +-0x1.e89292p-28, +-0x1p-3, +-0x1.6a904ap-7, +-0x1.fe9cdap-1, +-0x1.a03108p-26, +-0x1p-4, +0x1.b82684p-7, +-0x1.ff621ep-1, +-0x1.bcb6bep-28, +-0x1p-4, +0x1.b7aa82p-8, +-0x1.ffd886p-1, +-0x1.099a1ap-30, +-0x1p-5, +0, +-0x1p0, +0, +0, +-0x1.b7aa82p-8, +-0x1.ffd886p-1, +-0x1.099a1ap-30, +0x1p-5, +-0x1.b82684p-7, +-0x1.ff621ep-1, +-0x1.bcb6bep-28, +0x1p-4, +0x1.6a904ap-7, +-0x1.fe9cdap-1, +-0x1.a03108p-26, +0x1p-4, +-0x1.ba165p-6, +-0x1.fd88dap-1, +-0x1.e89292p-28, +0x1p-3, +-0x1.536352p-9, +-0x1.fc2648p-1, +0x1.e3cc06p-26, +0x1p-3, +0x1.640838p-6, +-0x1.fa7558p-1, +0x1.eeb5d2p-30, +0x1p-3, +0x1.788512p-5, +-0x1.f8765p-1, +0x1.63ad16p-27, +0x1p-3, +-0x1.c1d1fp-5, +-0x1.f6297cp-1, +-0x1.feeb96p-26, +0x1p-2, +-0x1.fa3ecap-6, +-0x1.f38f3ap-1, +-0x1.8c9cb2p-26, +0x1p-2, +-0x1.cc0d0ap-8, +-0x1.f0a7fp-1, +0x1.1b73cap-27, +0x1p-2, +0x1.11d262p-6, +-0x1.ed740ep-1, +-0x1.da1258p-27, +0x1p-2, +0x1.4a0318p-5, +-0x1.e9f416p-1, +0x1.273a44p-26, +0x1p-2, +0x1.04d726p-4, +-0x1.e6288ep-1, +-0x1.891c22p-26, +0x1p-2, +0x1.63e69ep-4, +-0x1.e2121p-1, +-0x1.3da1bap-27, +0x1p-2, +-0x1.1eef5ap-3, +-0x1.ddb13cp-1, +0x1.2667b8p-26, +0x1p-1, +-0x1.e08756p-4, +-0x1.d906bcp-1, +-0x1.e651a8p-26, +0x1p-1, +-0x1.8421bp-4, +-0x1.d4134ep-1, +0x1.d646d8p-26, +0x1p-1, +-0x1.28bbfep-4, +-0x1.ced7bp-1, +0x1.786712p-26, +0x1p-1, +-0x1.9cc8b4p-5, +-0x1.c954b2p-1, +-0x1.3411f4p-29, +0x1p-1, +-0x1.d4a2c8p-6, +-0x1.c38b3p-1, +0x1.cfe84ap-26, +0x1p-1, +-0x1.d16c9p-8, +-0x1.bd7c0ap-1, +-0x1.8df2a6p-26, +0x1p-1, +0x1.ce1e64p-7, +-0x1.b72834p-1, +-0x1.465b9p-27, +0x1p-1, +0x1.1eb354p-5, +-0x1.b090a6p-1, +0x1.fabf8p-27, +0x1p-1, +0x1.c73b3ap-5, +-0x1.a9b662p-1, +-0x1.21d434p-26, +0x1p-1, +0x1.3682a6p-4, +-0x1.a29a7ap-1, +-0x1.189e08p-31, +0x1p-1, +0x1.87fbfep-4, +-0x1.9b3e04p-1, +-0x1.fce1dp-27, +0x1p-1, +0x1.d7fd14p-4, +-0x1.93a224p-1, +-0x1.324c8p-26, +0x1p-1, +0x1.133ccap-3, +-0x1.8bc806p-1, +-0x1.62a2e8p-26, +0x1p-1, +0x1.39b2aep-3, +-0x1.83b0ep-1, +-0x1.7ff2eep-26, +0x1p-1, +0x1.5f5a4ep-3, +-0x1.7b5df2p-1, +-0x1.3557d8p-28, +0x1p-1, +0x1.842dd6p-3, +-0x1.72d084p-1, +0x1.02000ep-26, +0x1p-1, +0, +-0x1.6a09e6p-1, +-0x1.9fcef4p-27, +0, +-0x1.1a5efap-2, +-0x1.610b76p-1, +0x1.5c5a64p-26, +0x1p0, +-0x1.09441cp-2, +-0x1.57d694p-1, +0x1.6e626cp-26, +0x1p0, +-0x1.f13c7ep-3, +-0x1.4e6cacp-1, +0x1.070686p-27, +0x1p0, +-0x1.d0dfe6p-3, +-0x1.44cf32p-1, +-0x1.424776p-27, +0x1p0, +-0x1.b1776ep-3, +-0x1.3affa2p-1, +-0x1.240a18p-26, +0x1p0, +-0x1.9307eep-3, +-0x1.30ff8p-1, +0x1.8f47e6p-28, +0x1p0, +-0x1.759618p-3, +-0x1.26d054p-1, +-0x1.9ba25cp-26, +0x1p0, +-0x1.592676p-3, +-0x1.1c73b4p-1, +0x1.9465cep-27, +0x1p0, +-0x1.3dbd6ap-3, +-0x1.11eb36p-1, +0x1.7c969cp-26, +0x1p0, +-0x1.235f2ep-3, +-0x1.07387ap-1, +0x1.b74004p-27, +0x1p0, +-0x1.0a0fd4p-3, +-0x1.f8ba4ep-2, +0x1.01d952p-28, +0x1p0, +-0x1.e3a688p-4, +-0x1.e2b5d4p-2, +0x1.fe4272p-28, +0x1p0, +-0x1.b55a7p-4, +-0x1.cc66eap-2, +0x1.b38ee8p-28, +0x1p0, +-0x1.894286p-4, +-0x1.b5d1p-2, +-0x1.3c2b98p-27, +0x1p0, +-0x1.5f6598p-4, +-0x1.9ef794p-2, +-0x1.d476c6p-29, +0x1p0, +-0x1.37ca18p-4, +-0x1.87de2ap-2, +-0x1.abaa58p-28, +0x1p0, +-0x1.127624p-4, +-0x1.708854p-2, +0x1.e0b74cp-27, +0x1p0, +-0x1.dedefcp-5, +-0x1.58f9a8p-2, +0x1.4a9c04p-27, +0x1p0, +-0x1.9d7714p-5, +-0x1.4135cap-2, +0x1.7d134p-27, +0x1p0, +-0x1.60beaap-5, +-0x1.294062p-2, +-0x1.dab3ep-27, +0x1p0, +-0x1.28bf18p-5, +-0x1.111d26p-2, +-0x1.58fb3cp-29, +0x1p0, +-0x1.eb0208p-6, +-0x1.f19f98p-3, +0x1.37a83ap-29, +0x1p0, +-0x1.8e18a8p-6, +-0x1.c0b826p-3, +-0x1.4fc9ecp-28, +0x1p0, +-0x1.3ad06p-6, +-0x1.8f8b84p-3, +0x1.cb2cfap-30, +0x1p0, +-0x1.e26c16p-7, +-0x1.5e2144p-3, +-0x1.22cff2p-29, +0x1p0, +-0x1.62aa04p-7, +-0x1.2c8106p-3, +-0x1.d1cc28p-28, +0x1p0, +-0x1.ecdc78p-8, +-0x1.f564e6p-4, +0x1.2ad19ep-29, +0x1p0, +-0x1.3b92e2p-8, +-0x1.917a6cp-4, +0x1.eb25eap-31, +0x1p0, +-0x1.63253p-9, +-0x1.2d520ap-4, +0x1.a63cc2p-29, +0x1p0, +-0x1.3bc39p-10, +-0x1.91f66p-5, +0x1.de44fep-30, +0x1p0, +-0x1.3bcfbep-12, +-0x1.92156p-6, +0x1.0b933p-31, +0x1p0, +0, +0, +0, +0x1p0, +-0x1.3bcfbep-12, +0x1.92156p-6, +-0x1.0b933p-31, +0x1p0, +-0x1.3bc39p-10, +0x1.91f66p-5, +-0x1.de44fep-30, +0x1p0, +-0x1.63253p-9, +0x1.2d520ap-4, +-0x1.a63cc2p-29, +0x1p0, +-0x1.3b92e2p-8, +0x1.917a6cp-4, +-0x1.eb25eap-31, +0x1p0, +-0x1.ecdc78p-8, +0x1.f564e6p-4, +-0x1.2ad19ep-29, +0x1p0, +-0x1.62aa04p-7, +0x1.2c8106p-3, +0x1.d1cc28p-28, +0x1p0, +-0x1.e26c16p-7, +0x1.5e2144p-3, +0x1.22cff2p-29, +0x1p0, +-0x1.3ad06p-6, +0x1.8f8b84p-3, +-0x1.cb2cfap-30, +0x1p0, +-0x1.8e18a8p-6, +0x1.c0b826p-3, +0x1.4fc9ecp-28, +0x1p0, +-0x1.eb0208p-6, +0x1.f19f98p-3, +-0x1.37a83ap-29, +0x1p0, +-0x1.28bf18p-5, +0x1.111d26p-2, +0x1.58fb3cp-29, +0x1p0, +-0x1.60beaap-5, +0x1.294062p-2, +0x1.dab3ep-27, +0x1p0, +-0x1.9d7714p-5, +0x1.4135cap-2, +-0x1.7d134p-27, +0x1p0, +-0x1.dedefcp-5, +0x1.58f9a8p-2, +-0x1.4a9c04p-27, +0x1p0, +-0x1.127624p-4, +0x1.708854p-2, +-0x1.e0b74cp-27, +0x1p0, +-0x1.37ca18p-4, +0x1.87de2ap-2, +0x1.abaa58p-28, +0x1p0, +-0x1.5f6598p-4, +0x1.9ef794p-2, +0x1.d476c6p-29, +0x1p0, +-0x1.894286p-4, +0x1.b5d1p-2, +0x1.3c2b98p-27, +0x1p0, +-0x1.b55a7p-4, +0x1.cc66eap-2, +-0x1.b38ee8p-28, +0x1p0, +-0x1.e3a688p-4, +0x1.e2b5d4p-2, +-0x1.fe4272p-28, +0x1p0, +-0x1.0a0fd4p-3, +0x1.f8ba4ep-2, +-0x1.01d952p-28, +0x1p0, +-0x1.235f2ep-3, +0x1.07387ap-1, +-0x1.b74004p-27, +0x1p0, +-0x1.3dbd6ap-3, +0x1.11eb36p-1, +-0x1.7c969cp-26, +0x1p0, +-0x1.592676p-3, +0x1.1c73b4p-1, +-0x1.9465cep-27, +0x1p0, +-0x1.759618p-3, +0x1.26d054p-1, +0x1.9ba25cp-26, +0x1p0, +-0x1.9307eep-3, +0x1.30ff8p-1, +-0x1.8f47e6p-28, +0x1p0, +-0x1.b1776ep-3, +0x1.3affa2p-1, +0x1.240a18p-26, +0x1p0, +-0x1.d0dfe6p-3, +0x1.44cf32p-1, +0x1.424776p-27, +0x1p0, +-0x1.f13c7ep-3, +0x1.4e6cacp-1, +-0x1.070686p-27, +0x1p0, +-0x1.09441cp-2, +0x1.57d694p-1, +-0x1.6e626cp-26, +0x1p0, +-0x1.1a5efap-2, +0x1.610b76p-1, +-0x1.5c5a64p-26, +0x1p0, +0, +0x1.6a09e6p-1, +0x1.9fcef4p-27, +0, +0x1.842dd6p-3, +0x1.72d084p-1, +-0x1.02000ep-26, +0x1p-1, +0x1.5f5a4ep-3, +0x1.7b5df2p-1, +0x1.3557d8p-28, +0x1p-1, +0x1.39b2aep-3, +0x1.83b0ep-1, +0x1.7ff2eep-26, +0x1p-1, +0x1.133ccap-3, +0x1.8bc806p-1, +0x1.62a2e8p-26, +0x1p-1, +0x1.d7fd14p-4, +0x1.93a224p-1, +0x1.324c8p-26, +0x1p-1, +0x1.87fbfep-4, +0x1.9b3e04p-1, +0x1.fce1dp-27, +0x1p-1, +0x1.3682a6p-4, +0x1.a29a7ap-1, +0x1.189e08p-31, +0x1p-1, +0x1.c73b3ap-5, +0x1.a9b662p-1, +0x1.21d434p-26, +0x1p-1, +0x1.1eb354p-5, +0x1.b090a6p-1, +-0x1.fabf8p-27, +0x1p-1, +0x1.ce1e64p-7, +0x1.b72834p-1, +0x1.465b9p-27, +0x1p-1, +-0x1.d16c9p-8, +0x1.bd7c0ap-1, +0x1.8df2a6p-26, +0x1p-1, +-0x1.d4a2c8p-6, +0x1.c38b3p-1, +-0x1.cfe84ap-26, +0x1p-1, +-0x1.9cc8b4p-5, +0x1.c954b2p-1, +0x1.3411f4p-29, +0x1p-1, +-0x1.28bbfep-4, +0x1.ced7bp-1, +-0x1.786712p-26, +0x1p-1, +-0x1.8421bp-4, +0x1.d4134ep-1, +-0x1.d646d8p-26, +0x1p-1, +-0x1.e08756p-4, +0x1.d906bcp-1, +0x1.e651a8p-26, +0x1p-1, +-0x1.1eef5ap-3, +0x1.ddb13cp-1, +-0x1.2667b8p-26, +0x1p-1, +0x1.63e69ep-4, +0x1.e2121p-1, +0x1.3da1bap-27, +0x1p-2, +0x1.04d726p-4, +0x1.e6288ep-1, +0x1.891c22p-26, +0x1p-2, +0x1.4a0318p-5, +0x1.e9f416p-1, +-0x1.273a44p-26, +0x1p-2, +0x1.11d262p-6, +0x1.ed740ep-1, +0x1.da1258p-27, +0x1p-2, +-0x1.cc0d0ap-8, +0x1.f0a7fp-1, +-0x1.1b73cap-27, +0x1p-2, +-0x1.fa3ecap-6, +0x1.f38f3ap-1, +0x1.8c9cb2p-26, +0x1p-2, +-0x1.c1d1fp-5, +0x1.f6297cp-1, +0x1.feeb96p-26, +0x1p-2, +0x1.788512p-5, +0x1.f8765p-1, +-0x1.63ad16p-27, +0x1p-3, +0x1.640838p-6, +0x1.fa7558p-1, +-0x1.eeb5d2p-30, +0x1p-3, +-0x1.536352p-9, +0x1.fc2648p-1, +-0x1.e3cc06p-26, +0x1p-3, +-0x1.ba165p-6, +0x1.fd88dap-1, +0x1.e89292p-28, +0x1p-3, +0x1.6a904ap-7, +0x1.fe9cdap-1, +0x1.a03108p-26, +0x1p-4, +-0x1.b82684p-7, +0x1.ff621ep-1, +0x1.bcb6bep-28, +0x1p-4, +-0x1.b7aa82p-8, +0x1.ffd886p-1, +0x1.099a1ap-30, +0x1p-5 +}; +template <> HWY_ALIGN constexpr uint64_t kLargeReductionTable[] = { +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x1ULL, +0x0ULL, +0x0ULL, +0x2ULL, +0x0ULL, +0x0ULL, +0x5ULL, +0x0ULL, +0x0ULL, +0xaULL, +0x0ULL, +0x0ULL, +0x14ULL, +0x0ULL, +0x0ULL, +0x28ULL, +0x0ULL, +0x0ULL, +0x51ULL, +0x0ULL, +0x0ULL, +0xa2ULL, +0x0ULL, +0x0ULL, +0x145ULL, +0x0ULL, +0x0ULL, +0x28bULL, +0x0ULL, +0x0ULL, +0x517ULL, +0x0ULL, +0x0ULL, +0xa2fULL, +0x0ULL, +0x0ULL, +0x145fULL, +0x0ULL, +0x0ULL, +0x28beULL, +0x0ULL, +0x0ULL, +0x517cULL, +0x0ULL, +0x0ULL, +0xa2f9ULL, +0x0ULL, +0x0ULL, +0x145f3ULL, +0x0ULL, +0x0ULL, +0x28be6ULL, +0x0ULL, +0x0ULL, +0x517ccULL, +0x0ULL, +0x0ULL, +0xa2f98ULL, +0x0ULL, +0x0ULL, +0x145f30ULL, +0x0ULL, +0x0ULL, +0x28be60ULL, +0x0ULL, +0x0ULL, +0x517cc1ULL, +0x0ULL, +0x0ULL, +0xa2f983ULL, +0x0ULL, +0x0ULL, +0x145f306ULL, +0x0ULL, +0x0ULL, +0x28be60dULL, +0x0ULL, +0x0ULL, +0x517cc1bULL, +0x0ULL, +0x0ULL, +0xa2f9836ULL, +0x0ULL, +0x0ULL, +0x145f306dULL, +0x0ULL, +0x0ULL, +0x28be60dbULL, +0x0ULL, +0x0ULL, +0x517cc1b7ULL, +0x0ULL, +0x0ULL, +0xa2f9836eULL, +0x0ULL, +0x0ULL, +0x145f306dcULL, +0x0ULL, +0x0ULL, +0x28be60db9ULL, +0x0ULL, +0x0ULL, +0x517cc1b72ULL, +0x0ULL, +0x0ULL, +0xa2f9836e4ULL, +0x0ULL, +0x0ULL, +0x145f306dc9ULL, +0x0ULL, +0x0ULL, +0x28be60db93ULL, +0x0ULL, +0x0ULL, +0x517cc1b727ULL, +0x0ULL, +0x0ULL, +0xa2f9836e4eULL, +0x0ULL, +0x0ULL, +0x145f306dc9cULL, +0x0ULL, +0x0ULL, +0x28be60db939ULL, +0x0ULL, +0x0ULL, +0x517cc1b7272ULL, +0x0ULL, +0x0ULL, +0xa2f9836e4e4ULL, +0x0ULL, +0x0ULL, +0x145f306dc9c8ULL, +0x0ULL, +0x0ULL, +0x28be60db9391ULL, +0x0ULL, +0x0ULL, +0x517cc1b72722ULL, +0x0ULL, +0x0ULL, +0xa2f9836e4e44ULL, +0x0ULL, +0x0ULL, +0x145f306dc9c88ULL, +0x0ULL, +0x0ULL, +0x28be60db93910ULL, +0x0ULL, +0x0ULL, +0x517cc1b727220ULL, +0x0ULL, +0x0ULL, +0xa2f9836e4e441ULL, +0x0ULL, +0x0ULL, +0x145f306dc9c882ULL, +0x0ULL, +0x0ULL, +0x28be60db939105ULL, +0x0ULL, +0x0ULL, +0x517cc1b727220aULL, +0x0ULL, +0x0ULL, +0xa2f9836e4e4415ULL, +0x0ULL, +0x0ULL, +0x145f306dc9c882aULL, +0x0ULL, +0x0ULL, +0x28be60db9391054ULL, +0x0ULL, +0x0ULL, +0x517cc1b727220a9ULL, +0x0ULL, +0x0ULL, +0xa2f9836e4e44152ULL, +0x0ULL, +0x0ULL, +0x145f306dc9c882a5ULL, +0x0ULL, +0x0ULL, +0x28be60db9391054aULL, +0x0ULL, +0x0ULL, +0x517cc1b727220a94ULL, +0x0ULL, +0x0ULL, +0xa2f9836e4e441529ULL, +0x0ULL, +0x1ULL, +0x45f306dc9c882a53ULL, +0x0ULL, +0x2ULL, +0x8be60db9391054a7ULL, +0x0ULL, +0x5ULL, +0x17cc1b727220a94fULL, +0x0ULL, +0xaULL, +0x2f9836e4e441529fULL, +0x0ULL, +0x14ULL, +0x5f306dc9c882a53fULL, +0x0ULL, +0x28ULL, +0xbe60db9391054a7fULL, +0x0ULL, +0x51ULL, +0x7cc1b727220a94feULL, +0x0ULL, +0xa2ULL, +0xf9836e4e441529fcULL, +0x0ULL, +0x145ULL, +0xf306dc9c882a53f8ULL, +0x0ULL, +0x28bULL, +0xe60db9391054a7f0ULL, +0x0ULL, +0x517ULL, +0xcc1b727220a94fe1ULL, +0x0ULL, +0xa2fULL, +0x9836e4e441529fc2ULL, +0x0ULL, +0x145fULL, +0x306dc9c882a53f84ULL, +0x0ULL, +0x28beULL, +0x60db9391054a7f09ULL, +0x0ULL, +0x517cULL, +0xc1b727220a94fe13ULL, +0x0ULL, +0xa2f9ULL, +0x836e4e441529fc27ULL, +0x0ULL, +0x145f3ULL, +0x6dc9c882a53f84eULL, +0x0ULL, +0x28be6ULL, +0xdb9391054a7f09dULL, +0x0ULL, +0x517ccULL, +0x1b727220a94fe13aULL, +0x0ULL, +0xa2f98ULL, +0x36e4e441529fc275ULL, +0x0ULL, +0x145f30ULL, +0x6dc9c882a53f84eaULL, +0x0ULL, +0x28be60ULL, +0xdb9391054a7f09d5ULL, +0x0ULL, +0x517cc1ULL, +0xb727220a94fe13abULL, +0x0ULL, +0xa2f983ULL, +0x6e4e441529fc2757ULL, +0x0ULL, +0x145f306ULL, +0xdc9c882a53f84eafULL, +0x0ULL, +0x28be60dULL, +0xb9391054a7f09d5fULL, +0x0ULL, +0x517cc1bULL, +0x727220a94fe13abeULL, +0x0ULL, +0xa2f9836ULL, +0xe4e441529fc2757dULL, +0x0ULL, +0x145f306dULL, +0xc9c882a53f84eafaULL, +0x0ULL, +0x28be60dbULL, +0x9391054a7f09d5f4ULL, +0x0ULL, +0x517cc1b7ULL, +0x27220a94fe13abe8ULL, +0x0ULL, +0xa2f9836eULL, +0x4e441529fc2757d1ULL, +0x0ULL, +0x145f306dcULL, +0x9c882a53f84eafa3ULL, +0x0ULL, +0x28be60db9ULL, +0x391054a7f09d5f47ULL, +0x0ULL, +0x517cc1b72ULL, +0x7220a94fe13abe8fULL, +0x0ULL, +0xa2f9836e4ULL, +0xe441529fc2757d1fULL, +0x0ULL, +0x145f306dc9ULL, +0xc882a53f84eafa3eULL, +0x0ULL, +0x28be60db93ULL, +0x91054a7f09d5f47dULL, +0x0ULL, +0x517cc1b727ULL, +0x220a94fe13abe8faULL, +0x0ULL, +0xa2f9836e4eULL, +0x441529fc2757d1f5ULL, +0x0ULL, +0x145f306dc9cULL, +0x882a53f84eafa3eaULL, +0x0ULL, +0x28be60db939ULL, +0x1054a7f09d5f47d4ULL, +0x0ULL, +0x517cc1b7272ULL, +0x20a94fe13abe8fa9ULL, +0x0ULL, +0xa2f9836e4e4ULL, +0x41529fc2757d1f53ULL, +0x0ULL, +0x145f306dc9c8ULL, +0x82a53f84eafa3ea6ULL, +0x0ULL, +0x28be60db9391ULL, +0x54a7f09d5f47d4dULL, +0x0ULL, +0x517cc1b72722ULL, +0xa94fe13abe8fa9aULL, +0x0ULL, +0xa2f9836e4e44ULL, +0x1529fc2757d1f534ULL, +0x0ULL, +0x145f306dc9c88ULL, +0x2a53f84eafa3ea69ULL, +0x0ULL, +0x28be60db93910ULL, +0x54a7f09d5f47d4d3ULL, +0x0ULL, +0x517cc1b727220ULL, +0xa94fe13abe8fa9a6ULL, +0x0ULL, +0xa2f9836e4e441ULL, +0x529fc2757d1f534dULL, +0x0ULL, +0x145f306dc9c882ULL, +0xa53f84eafa3ea69bULL, +0x0ULL, +0x28be60db939105ULL, +0x4a7f09d5f47d4d37ULL, +0x0ULL, +0x517cc1b727220aULL, +0x94fe13abe8fa9a6eULL, +0x0ULL, +0xa2f9836e4e4415ULL, +0x29fc2757d1f534ddULL, +0x0ULL, +0x145f306dc9c882aULL, +0x53f84eafa3ea69bbULL, +0x0ULL, +0x28be60db9391054ULL, +0xa7f09d5f47d4d377ULL, +0x0ULL, +0x517cc1b727220a9ULL, +0x4fe13abe8fa9a6eeULL, +0x0ULL, +0xa2f9836e4e44152ULL, +0x9fc2757d1f534ddcULL, +0x0ULL, +0x145f306dc9c882a5ULL, +0x3f84eafa3ea69bb8ULL, +0x0ULL, +0x28be60db9391054aULL, +0x7f09d5f47d4d3770ULL, +0x0ULL, +0x517cc1b727220a94ULL, +0xfe13abe8fa9a6ee0ULL, +0x0ULL, +0xa2f9836e4e441529ULL, +0xfc2757d1f534ddc0ULL, +0x1ULL, +0x45f306dc9c882a53ULL, +0xf84eafa3ea69bb81ULL, +0x2ULL, +0x8be60db9391054a7ULL, +0xf09d5f47d4d37703ULL, +0x5ULL, +0x17cc1b727220a94fULL, +0xe13abe8fa9a6ee06ULL, +0xaULL, +0x2f9836e4e441529fULL, +0xc2757d1f534ddc0dULL, +0x14ULL, +0x5f306dc9c882a53fULL, +0x84eafa3ea69bb81bULL, +0x28ULL, +0xbe60db9391054a7fULL, +0x9d5f47d4d377036ULL, +0x51ULL, +0x7cc1b727220a94feULL, +0x13abe8fa9a6ee06dULL, +0xa2ULL, +0xf9836e4e441529fcULL, +0x2757d1f534ddc0dbULL, +0x145ULL, +0xf306dc9c882a53f8ULL, +0x4eafa3ea69bb81b6ULL, +0x28bULL, +0xe60db9391054a7f0ULL, +0x9d5f47d4d377036dULL, +0x517ULL, +0xcc1b727220a94fe1ULL, +0x3abe8fa9a6ee06dbULL, +0xa2fULL, +0x9836e4e441529fc2ULL, +0x757d1f534ddc0db6ULL, +0x145fULL, +0x306dc9c882a53f84ULL, +0xeafa3ea69bb81b6cULL, +0x28beULL, +0x60db9391054a7f09ULL, +0xd5f47d4d377036d8ULL, +0x517cULL, +0xc1b727220a94fe13ULL, +0xabe8fa9a6ee06db1ULL, +0xa2f9ULL, +0x836e4e441529fc27ULL, +0x57d1f534ddc0db62ULL, +0x145f3ULL, +0x6dc9c882a53f84eULL, +0xafa3ea69bb81b6c5ULL, +0x28be6ULL, +0xdb9391054a7f09dULL, +0x5f47d4d377036d8aULL, +0x517ccULL, +0x1b727220a94fe13aULL, +0xbe8fa9a6ee06db14ULL, +0xa2f98ULL, +0x36e4e441529fc275ULL, +0x7d1f534ddc0db629ULL, +0x145f30ULL, +0x6dc9c882a53f84eaULL, +0xfa3ea69bb81b6c52ULL, +0x28be60ULL, +0xdb9391054a7f09d5ULL, +0xf47d4d377036d8a5ULL, +0x517cc1ULL, +0xb727220a94fe13abULL, +0xe8fa9a6ee06db14aULL, +0xa2f983ULL, +0x6e4e441529fc2757ULL, +0xd1f534ddc0db6295ULL, +0x145f306ULL, +0xdc9c882a53f84eafULL, +0xa3ea69bb81b6c52bULL, +0x28be60dULL, +0xb9391054a7f09d5fULL, +0x47d4d377036d8a56ULL, +0x517cc1bULL, +0x727220a94fe13abeULL, +0x8fa9a6ee06db14acULL, +0xa2f9836ULL, +0xe4e441529fc2757dULL, +0x1f534ddc0db62959ULL, +0x145f306dULL, +0xc9c882a53f84eafaULL, +0x3ea69bb81b6c52b3ULL, +0x28be60dbULL, +0x9391054a7f09d5f4ULL, +0x7d4d377036d8a566ULL, +0x517cc1b7ULL, +0x27220a94fe13abe8ULL, +0xfa9a6ee06db14accULL, +0xa2f9836eULL, +0x4e441529fc2757d1ULL, +0xf534ddc0db629599ULL, +0x145f306dcULL, +0x9c882a53f84eafa3ULL, +0xea69bb81b6c52b32ULL, +0x28be60db9ULL, +0x391054a7f09d5f47ULL, +0xd4d377036d8a5664ULL, +0x517cc1b72ULL, +0x7220a94fe13abe8fULL, +0xa9a6ee06db14acc9ULL, +0xa2f9836e4ULL, +0xe441529fc2757d1fULL, +0x534ddc0db6295993ULL, +0x145f306dc9ULL, +0xc882a53f84eafa3eULL, +0xa69bb81b6c52b327ULL, +0x28be60db93ULL, +0x91054a7f09d5f47dULL, +0x4d377036d8a5664fULL, +0x517cc1b727ULL, +0x220a94fe13abe8faULL, +0x9a6ee06db14acc9eULL, +0xa2f9836e4eULL, +0x441529fc2757d1f5ULL, +0x34ddc0db6295993cULL, +0x145f306dc9cULL, +0x882a53f84eafa3eaULL, +0x69bb81b6c52b3278ULL, +0x28be60db939ULL, +0x1054a7f09d5f47d4ULL, +0xd377036d8a5664f1ULL, +0x517cc1b7272ULL, +0x20a94fe13abe8fa9ULL, +0xa6ee06db14acc9e2ULL, +0xa2f9836e4e4ULL, +0x41529fc2757d1f53ULL, +0x4ddc0db6295993c4ULL, +0x145f306dc9c8ULL, +0x82a53f84eafa3ea6ULL, +0x9bb81b6c52b32788ULL, +0x28be60db9391ULL, +0x54a7f09d5f47d4dULL, +0x377036d8a5664f10ULL, +0x517cc1b72722ULL, +0xa94fe13abe8fa9aULL, +0x6ee06db14acc9e21ULL, +0xa2f9836e4e44ULL, +0x1529fc2757d1f534ULL, +0xddc0db6295993c43ULL, +0x145f306dc9c88ULL, +0x2a53f84eafa3ea69ULL, +0xbb81b6c52b327887ULL, +0x28be60db93910ULL, +0x54a7f09d5f47d4d3ULL, +0x77036d8a5664f10eULL, +0x517cc1b727220ULL, +0xa94fe13abe8fa9a6ULL, +0xee06db14acc9e21cULL, +0xa2f9836e4e441ULL, +0x529fc2757d1f534dULL, +0xdc0db6295993c439ULL, +0x145f306dc9c882ULL, +0xa53f84eafa3ea69bULL, +0xb81b6c52b3278872ULL, +0x28be60db939105ULL, +0x4a7f09d5f47d4d37ULL, +0x7036d8a5664f10e4ULL, +0x517cc1b727220aULL, +0x94fe13abe8fa9a6eULL, +0xe06db14acc9e21c8ULL, +0xa2f9836e4e4415ULL, +0x29fc2757d1f534ddULL, +0xc0db6295993c4390ULL, +0x145f306dc9c882aULL, +0x53f84eafa3ea69bbULL, +0x81b6c52b32788720ULL, +0x28be60db9391054ULL, +0xa7f09d5f47d4d377ULL, +0x36d8a5664f10e41ULL, +0x517cc1b727220a9ULL, +0x4fe13abe8fa9a6eeULL, +0x6db14acc9e21c82ULL, +0xa2f9836e4e44152ULL, +0x9fc2757d1f534ddcULL, +0xdb6295993c43904ULL, +0x145f306dc9c882a5ULL, +0x3f84eafa3ea69bb8ULL, +0x1b6c52b327887208ULL, +0x28be60db9391054aULL, +0x7f09d5f47d4d3770ULL, +0x36d8a5664f10e410ULL, +0x517cc1b727220a94ULL, +0xfe13abe8fa9a6ee0ULL, +0x6db14acc9e21c820ULL, +0xa2f9836e4e441529ULL, +0xfc2757d1f534ddc0ULL, +0xdb6295993c439041ULL, +0x45f306dc9c882a53ULL, +0xf84eafa3ea69bb81ULL, +0xb6c52b3278872083ULL, +0x8be60db9391054a7ULL, +0xf09d5f47d4d37703ULL, +0x6d8a5664f10e4107ULL, +0x17cc1b727220a94fULL, +0xe13abe8fa9a6ee06ULL, +0xdb14acc9e21c820fULL, +0x2f9836e4e441529fULL, +0xc2757d1f534ddc0dULL, +0xb6295993c439041fULL, +0x5f306dc9c882a53fULL, +0x84eafa3ea69bb81bULL, +0x6c52b3278872083fULL, +0xbe60db9391054a7fULL, +0x9d5f47d4d377036ULL, +0xd8a5664f10e4107fULL, +0x7cc1b727220a94feULL, +0x13abe8fa9a6ee06dULL, +0xb14acc9e21c820ffULL, +0xf9836e4e441529fcULL, +0x2757d1f534ddc0dbULL, +0x6295993c439041feULL, +0xf306dc9c882a53f8ULL, +0x4eafa3ea69bb81b6ULL, +0xc52b3278872083fcULL, +0xe60db9391054a7f0ULL, +0x9d5f47d4d377036dULL, +0x8a5664f10e4107f9ULL, +0xcc1b727220a94fe1ULL, +0x3abe8fa9a6ee06dbULL, +0x14acc9e21c820ff2ULL, +0x9836e4e441529fc2ULL, +0x757d1f534ddc0db6ULL, +0x295993c439041fe5ULL, +0x306dc9c882a53f84ULL, +0xeafa3ea69bb81b6cULL, +0x52b3278872083fcaULL, +0x60db9391054a7f09ULL, +0xd5f47d4d377036d8ULL, +0xa5664f10e4107f94ULL, +0xc1b727220a94fe13ULL, +0xabe8fa9a6ee06db1ULL, +0x4acc9e21c820ff28ULL, +0x836e4e441529fc27ULL, +0x57d1f534ddc0db62ULL, +0x95993c439041fe51ULL, +0x6dc9c882a53f84eULL, +0xafa3ea69bb81b6c5ULL, +0x2b3278872083fca2ULL, +0xdb9391054a7f09dULL, +0x5f47d4d377036d8aULL, +0x5664f10e4107f945ULL, +0x1b727220a94fe13aULL, +0xbe8fa9a6ee06db14ULL, +0xacc9e21c820ff28bULL, +0x36e4e441529fc275ULL, +0x7d1f534ddc0db629ULL, +0x5993c439041fe516ULL, +0x6dc9c882a53f84eaULL, +0xfa3ea69bb81b6c52ULL, +0xb3278872083fca2cULL, +0xdb9391054a7f09d5ULL, +0xf47d4d377036d8a5ULL, +0x664f10e4107f9458ULL, +0xb727220a94fe13abULL, +0xe8fa9a6ee06db14aULL, +0xcc9e21c820ff28b1ULL, +0x6e4e441529fc2757ULL, +0xd1f534ddc0db6295ULL, +0x993c439041fe5163ULL, +0xdc9c882a53f84eafULL, +0xa3ea69bb81b6c52bULL, +0x3278872083fca2c7ULL, +0xb9391054a7f09d5fULL, +0x47d4d377036d8a56ULL, +0x64f10e4107f9458eULL, +0x727220a94fe13abeULL, +0x8fa9a6ee06db14acULL, +0xc9e21c820ff28b1dULL, +0xe4e441529fc2757dULL, +0x1f534ddc0db62959ULL, +0x93c439041fe5163aULL, +0xc9c882a53f84eafaULL, +0x3ea69bb81b6c52b3ULL, +0x278872083fca2c75ULL, +0x9391054a7f09d5f4ULL, +0x7d4d377036d8a566ULL, +0x4f10e4107f9458eaULL, +0x27220a94fe13abe8ULL, +0xfa9a6ee06db14accULL, +0x9e21c820ff28b1d5ULL, +0x4e441529fc2757d1ULL, +0xf534ddc0db629599ULL, +0x3c439041fe5163abULL, +0x9c882a53f84eafa3ULL, +0xea69bb81b6c52b32ULL, +0x78872083fca2c757ULL, +0x391054a7f09d5f47ULL, +0xd4d377036d8a5664ULL, +0xf10e4107f9458eafULL, +0x7220a94fe13abe8fULL, +0xa9a6ee06db14acc9ULL, +0xe21c820ff28b1d5eULL, +0xe441529fc2757d1fULL, +0x534ddc0db6295993ULL, +0xc439041fe5163abdULL, +0xc882a53f84eafa3eULL, +0xa69bb81b6c52b327ULL, +0x8872083fca2c757bULL, +0x91054a7f09d5f47dULL, +0x4d377036d8a5664fULL, +0x10e4107f9458eaf7ULL, +0x220a94fe13abe8faULL, +0x9a6ee06db14acc9eULL, +0x21c820ff28b1d5efULL, +0x441529fc2757d1f5ULL, +0x34ddc0db6295993cULL, +0x439041fe5163abdeULL, +0x882a53f84eafa3eaULL, +0x69bb81b6c52b3278ULL, +0x872083fca2c757bdULL, +0x1054a7f09d5f47d4ULL, +0xd377036d8a5664f1ULL, +0xe4107f9458eaf7aULL, +0x20a94fe13abe8fa9ULL, +0xa6ee06db14acc9e2ULL, +0x1c820ff28b1d5ef5ULL, +0x41529fc2757d1f53ULL, +0x4ddc0db6295993c4ULL, +0x39041fe5163abdebULL, +0x82a53f84eafa3ea6ULL, +0x9bb81b6c52b32788ULL, +0x72083fca2c757bd7ULL, +0x54a7f09d5f47d4dULL, +0x377036d8a5664f10ULL, +0xe4107f9458eaf7aeULL, +0xa94fe13abe8fa9aULL, +0x6ee06db14acc9e21ULL, +0xc820ff28b1d5ef5dULL, +0x1529fc2757d1f534ULL, +0xddc0db6295993c43ULL, +0x9041fe5163abdebbULL, +0x2a53f84eafa3ea69ULL, +0xbb81b6c52b327887ULL, +0x2083fca2c757bd77ULL, +0x54a7f09d5f47d4d3ULL, +0x77036d8a5664f10eULL, +0x4107f9458eaf7aefULL, +0xa94fe13abe8fa9a6ULL, +0xee06db14acc9e21cULL, +0x820ff28b1d5ef5deULL, +0x529fc2757d1f534dULL, +0xdc0db6295993c439ULL, +0x41fe5163abdebbcULL, +0xa53f84eafa3ea69bULL, +0xb81b6c52b3278872ULL, +0x83fca2c757bd778ULL, +0x4a7f09d5f47d4d37ULL, +0x7036d8a5664f10e4ULL, +0x107f9458eaf7aef1ULL, +0x94fe13abe8fa9a6eULL, +0xe06db14acc9e21c8ULL, +0x20ff28b1d5ef5de2ULL, +0x29fc2757d1f534ddULL, +0xc0db6295993c4390ULL, +0x41fe5163abdebbc5ULL, +0x53f84eafa3ea69bbULL, +0x81b6c52b32788720ULL, +0x83fca2c757bd778aULL, +0xa7f09d5f47d4d377ULL, +0x36d8a5664f10e41ULL, +0x7f9458eaf7aef15ULL, +0x4fe13abe8fa9a6eeULL, +0x6db14acc9e21c82ULL, +0xff28b1d5ef5de2bULL, +0x9fc2757d1f534ddcULL, +0xdb6295993c43904ULL, +0x1fe5163abdebbc56ULL, +0x3f84eafa3ea69bb8ULL, +0x1b6c52b327887208ULL, +0x3fca2c757bd778acULL, +0x7f09d5f47d4d3770ULL, +0x36d8a5664f10e410ULL, +0x7f9458eaf7aef158ULL, +0xfe13abe8fa9a6ee0ULL, +0x6db14acc9e21c820ULL, +0xff28b1d5ef5de2b0ULL, +0xfc2757d1f534ddc0ULL, +0xdb6295993c439041ULL, +0xfe5163abdebbc561ULL, +0xf84eafa3ea69bb81ULL, +0xb6c52b3278872083ULL, +0xfca2c757bd778ac3ULL, +0xf09d5f47d4d37703ULL, +0x6d8a5664f10e4107ULL, +0xf9458eaf7aef1586ULL, +0xe13abe8fa9a6ee06ULL, +0xdb14acc9e21c820fULL, +0xf28b1d5ef5de2b0dULL, +0xc2757d1f534ddc0dULL, +0xb6295993c439041fULL, +0xe5163abdebbc561bULL, +0x84eafa3ea69bb81bULL, +0x6c52b3278872083fULL, +0xca2c757bd778ac36ULL, +0x9d5f47d4d377036ULL, +0xd8a5664f10e4107fULL, +0x9458eaf7aef1586dULL, +0x13abe8fa9a6ee06dULL, +0xb14acc9e21c820ffULL, +0x28b1d5ef5de2b0dbULL, +0x2757d1f534ddc0dbULL, +0x6295993c439041feULL, +0x5163abdebbc561b7ULL, +0x4eafa3ea69bb81b6ULL, +0xc52b3278872083fcULL, +0xa2c757bd778ac36eULL, +0x9d5f47d4d377036dULL, +0x8a5664f10e4107f9ULL, +0x458eaf7aef1586dcULL, +0x3abe8fa9a6ee06dbULL, +0x14acc9e21c820ff2ULL, +0x8b1d5ef5de2b0db9ULL, +0x757d1f534ddc0db6ULL, +0x295993c439041fe5ULL, +0x163abdebbc561b72ULL, +0xeafa3ea69bb81b6cULL, +0x52b3278872083fcaULL, +0x2c757bd778ac36e4ULL, +0xd5f47d4d377036d8ULL, +0xa5664f10e4107f94ULL, +0x58eaf7aef1586dc9ULL, +0xabe8fa9a6ee06db1ULL, +0x4acc9e21c820ff28ULL, +0xb1d5ef5de2b0db92ULL, +0x57d1f534ddc0db62ULL, +0x95993c439041fe51ULL, +0x63abdebbc561b724ULL, +0xafa3ea69bb81b6c5ULL, +0x2b3278872083fca2ULL, +0xc757bd778ac36e48ULL, +0x5f47d4d377036d8aULL, +0x5664f10e4107f945ULL, +0x8eaf7aef1586dc91ULL, +0xbe8fa9a6ee06db14ULL, +0xacc9e21c820ff28bULL, +0x1d5ef5de2b0db923ULL, +0x7d1f534ddc0db629ULL, +0x5993c439041fe516ULL, +0x3abdebbc561b7246ULL, +0xfa3ea69bb81b6c52ULL, +0xb3278872083fca2cULL, +0x757bd778ac36e48dULL, +0xf47d4d377036d8a5ULL, +0x664f10e4107f9458ULL, +0xeaf7aef1586dc91bULL, +0xe8fa9a6ee06db14aULL, +0xcc9e21c820ff28b1ULL, +0xd5ef5de2b0db9237ULL, +0xd1f534ddc0db6295ULL, +0x993c439041fe5163ULL, +0xabdebbc561b7246eULL, +0xa3ea69bb81b6c52bULL, +0x3278872083fca2c7ULL, +0x57bd778ac36e48dcULL, +0x47d4d377036d8a56ULL, +0x64f10e4107f9458eULL, +0xaf7aef1586dc91b8ULL, +0x8fa9a6ee06db14acULL, +0xc9e21c820ff28b1dULL, +0x5ef5de2b0db92371ULL, +0x1f534ddc0db62959ULL, +0x93c439041fe5163aULL, +0xbdebbc561b7246e3ULL, +0x3ea69bb81b6c52b3ULL, +0x278872083fca2c75ULL, +0x7bd778ac36e48dc7ULL, +0x7d4d377036d8a566ULL, +0x4f10e4107f9458eaULL, +0xf7aef1586dc91b8eULL, +0xfa9a6ee06db14accULL, +0x9e21c820ff28b1d5ULL, +0xef5de2b0db92371dULL, +0xf534ddc0db629599ULL, +0x3c439041fe5163abULL, +0xdebbc561b7246e3aULL, +0xea69bb81b6c52b32ULL, +0x78872083fca2c757ULL, +0xbd778ac36e48dc74ULL, +0xd4d377036d8a5664ULL, +0xf10e4107f9458eafULL, +0x7aef1586dc91b8e9ULL, +0xa9a6ee06db14acc9ULL, +0xe21c820ff28b1d5eULL, +0xf5de2b0db92371d2ULL, +0x534ddc0db6295993ULL, +0xc439041fe5163abdULL, +0xebbc561b7246e3a4ULL, +0xa69bb81b6c52b327ULL, +0x8872083fca2c757bULL, +0xd778ac36e48dc748ULL, +0x4d377036d8a5664fULL, +0x10e4107f9458eaf7ULL, +0xaef1586dc91b8e90ULL, +0x9a6ee06db14acc9eULL, +0x21c820ff28b1d5efULL, +0x5de2b0db92371d21ULL, +0x34ddc0db6295993cULL, +0x439041fe5163abdeULL, +0xbbc561b7246e3a42ULL, +0x69bb81b6c52b3278ULL, +0x872083fca2c757bdULL, +0x778ac36e48dc7484ULL, +0xd377036d8a5664f1ULL, +0xe4107f9458eaf7aULL, +0xef1586dc91b8e909ULL, +0xa6ee06db14acc9e2ULL, +0x1c820ff28b1d5ef5ULL, +0xde2b0db92371d212ULL, +0x4ddc0db6295993c4ULL, +0x39041fe5163abdebULL, +0xbc561b7246e3a424ULL, +0x9bb81b6c52b32788ULL, +0x72083fca2c757bd7ULL, +0x78ac36e48dc74849ULL, +0x377036d8a5664f10ULL, +0xe4107f9458eaf7aeULL, +0xf1586dc91b8e9093ULL, +0x6ee06db14acc9e21ULL, +0xc820ff28b1d5ef5dULL, +0xe2b0db92371d2126ULL, +0xddc0db6295993c43ULL, +0x9041fe5163abdebbULL, +0xc561b7246e3a424dULL, +0xbb81b6c52b327887ULL, +0x2083fca2c757bd77ULL, +0x8ac36e48dc74849bULL, +0x77036d8a5664f10eULL, +0x4107f9458eaf7aefULL, +0x1586dc91b8e90937ULL, +0xee06db14acc9e21cULL, +0x820ff28b1d5ef5deULL, +0x2b0db92371d2126eULL, +0xdc0db6295993c439ULL, +0x41fe5163abdebbcULL, +0x561b7246e3a424ddULL, +0xb81b6c52b3278872ULL, +0x83fca2c757bd778ULL, +0xac36e48dc74849baULL, +0x7036d8a5664f10e4ULL, +0x107f9458eaf7aef1ULL, +0x586dc91b8e909374ULL, +0xe06db14acc9e21c8ULL, +0x20ff28b1d5ef5de2ULL, +0xb0db92371d2126e9ULL, +0xc0db6295993c4390ULL, +0x41fe5163abdebbc5ULL, +0x61b7246e3a424dd2ULL, +0x81b6c52b32788720ULL, +0x83fca2c757bd778aULL, +0xc36e48dc74849ba5ULL, +0x36d8a5664f10e41ULL, +0x7f9458eaf7aef15ULL, +0x86dc91b8e909374bULL, +0x6db14acc9e21c82ULL, +0xff28b1d5ef5de2bULL, +0xdb92371d2126e97ULL, +0xdb6295993c43904ULL, +0x1fe5163abdebbc56ULL, +0x1b7246e3a424dd2eULL, +0x1b6c52b327887208ULL, +0x3fca2c757bd778acULL, +0x36e48dc74849ba5cULL, +0x36d8a5664f10e410ULL, +0x7f9458eaf7aef158ULL, +0x6dc91b8e909374b8ULL, +0x6db14acc9e21c820ULL, +0xff28b1d5ef5de2b0ULL, +0xdb92371d2126e970ULL, +0xdb6295993c439041ULL, +0xfe5163abdebbc561ULL, +0xb7246e3a424dd2e0ULL, +0xb6c52b3278872083ULL, +0xfca2c757bd778ac3ULL, +0x6e48dc74849ba5c0ULL, +0x6d8a5664f10e4107ULL, +0xf9458eaf7aef1586ULL, +0xdc91b8e909374b80ULL, +0xdb14acc9e21c820fULL, +0xf28b1d5ef5de2b0dULL, +0xb92371d2126e9700ULL, +0xb6295993c439041fULL, +0xe5163abdebbc561bULL, +0x7246e3a424dd2e00ULL, +0x6c52b3278872083fULL, +0xca2c757bd778ac36ULL, +0xe48dc74849ba5c00ULL, +0xd8a5664f10e4107fULL, +0x9458eaf7aef1586dULL, +0xc91b8e909374b801ULL, +0xb14acc9e21c820ffULL, +0x28b1d5ef5de2b0dbULL, +0x92371d2126e97003ULL, +0x6295993c439041feULL, +0x5163abdebbc561b7ULL, +0x246e3a424dd2e006ULL, +0xc52b3278872083fcULL, +0xa2c757bd778ac36eULL, +0x48dc74849ba5c00cULL, +0x8a5664f10e4107f9ULL, +0x458eaf7aef1586dcULL, +0x91b8e909374b8019ULL, +0x14acc9e21c820ff2ULL, +0x8b1d5ef5de2b0db9ULL, +0x2371d2126e970032ULL, +0x295993c439041fe5ULL, +0x163abdebbc561b72ULL, +0x46e3a424dd2e0064ULL, +0x52b3278872083fcaULL, +0x2c757bd778ac36e4ULL, +0x8dc74849ba5c00c9ULL, +0xa5664f10e4107f94ULL, +0x58eaf7aef1586dc9ULL, +0x1b8e909374b80192ULL, +0x4acc9e21c820ff28ULL, +0xb1d5ef5de2b0db92ULL, +0x371d2126e9700324ULL, +0x95993c439041fe51ULL, +0x63abdebbc561b724ULL, +0x6e3a424dd2e00649ULL, +0x2b3278872083fca2ULL, +0xc757bd778ac36e48ULL, +0xdc74849ba5c00c92ULL, +0x5664f10e4107f945ULL, +0x8eaf7aef1586dc91ULL, +0xb8e909374b801924ULL, +0xacc9e21c820ff28bULL, +0x1d5ef5de2b0db923ULL, +0x71d2126e97003249ULL, +0x5993c439041fe516ULL, +0x3abdebbc561b7246ULL, +0xe3a424dd2e006492ULL, +0xb3278872083fca2cULL, +0x757bd778ac36e48dULL, +0xc74849ba5c00c925ULL, +0x664f10e4107f9458ULL, +0xeaf7aef1586dc91bULL, +0x8e909374b801924bULL, +0xcc9e21c820ff28b1ULL, +0xd5ef5de2b0db9237ULL, +0x1d2126e970032497ULL, +0x993c439041fe5163ULL, +0xabdebbc561b7246eULL, +0x3a424dd2e006492eULL, +0x3278872083fca2c7ULL, +0x57bd778ac36e48dcULL, +0x74849ba5c00c925dULL, +0x64f10e4107f9458eULL, +0xaf7aef1586dc91b8ULL, +0xe909374b801924bbULL, +0xc9e21c820ff28b1dULL, +0x5ef5de2b0db92371ULL, +0xd2126e9700324977ULL, +0x93c439041fe5163aULL, +0xbdebbc561b7246e3ULL, +0xa424dd2e006492eeULL, +0x278872083fca2c75ULL, +0x7bd778ac36e48dc7ULL, +0x4849ba5c00c925ddULL, +0x4f10e4107f9458eaULL, +0xf7aef1586dc91b8eULL, +0x909374b801924bbaULL, +0x9e21c820ff28b1d5ULL, +0xef5de2b0db92371dULL, +0x2126e97003249775ULL, +0x3c439041fe5163abULL, +0xdebbc561b7246e3aULL, +0x424dd2e006492eeaULL, +0x78872083fca2c757ULL, +0xbd778ac36e48dc74ULL, +0x849ba5c00c925dd4ULL, +0xf10e4107f9458eafULL, +0x7aef1586dc91b8e9ULL, +0x9374b801924bba8ULL, +0xe21c820ff28b1d5eULL, +0xf5de2b0db92371d2ULL, +0x126e970032497750ULL, +0xc439041fe5163abdULL, +0xebbc561b7246e3a4ULL, +0x24dd2e006492eea0ULL, +0x8872083fca2c757bULL, +0xd778ac36e48dc748ULL, +0x49ba5c00c925dd41ULL, +0x10e4107f9458eaf7ULL, +0xaef1586dc91b8e90ULL, +0x9374b801924bba82ULL, +0x21c820ff28b1d5efULL, +0x5de2b0db92371d21ULL, +0x26e9700324977504ULL, +0x439041fe5163abdeULL, +0xbbc561b7246e3a42ULL, +0x4dd2e006492eea09ULL, +0x872083fca2c757bdULL, +0x778ac36e48dc7484ULL, +0x9ba5c00c925dd413ULL, +0xe4107f9458eaf7aULL, +0xef1586dc91b8e909ULL, +0x374b801924bba827ULL, +0x1c820ff28b1d5ef5ULL, +0xde2b0db92371d212ULL, +0x6e9700324977504eULL, +0x39041fe5163abdebULL, +0xbc561b7246e3a424ULL, +0xdd2e006492eea09dULL, +0x72083fca2c757bd7ULL, +0x78ac36e48dc74849ULL, +0xba5c00c925dd413aULL, +0xe4107f9458eaf7aeULL, +0xf1586dc91b8e9093ULL, +0x74b801924bba8274ULL, +0xc820ff28b1d5ef5dULL, +0xe2b0db92371d2126ULL, +0xe9700324977504e8ULL, +0x9041fe5163abdebbULL, +0xc561b7246e3a424dULL, +0xd2e006492eea09d1ULL, +0x2083fca2c757bd77ULL, +0x8ac36e48dc74849bULL, +0xa5c00c925dd413a3ULL, +0x4107f9458eaf7aefULL, +0x1586dc91b8e90937ULL, +0x4b801924bba82746ULL, +0x820ff28b1d5ef5deULL, +0x2b0db92371d2126eULL, +0x9700324977504e8cULL, +0x41fe5163abdebbcULL, +0x561b7246e3a424ddULL, +0x2e006492eea09d19ULL, +0x83fca2c757bd778ULL, +0xac36e48dc74849baULL, +0x5c00c925dd413a32ULL, +0x107f9458eaf7aef1ULL, +0x586dc91b8e909374ULL, +0xb801924bba827464ULL, +0x20ff28b1d5ef5de2ULL, +0xb0db92371d2126e9ULL, +0x700324977504e8c9ULL, +0x41fe5163abdebbc5ULL, +0x61b7246e3a424dd2ULL, +0xe006492eea09d192ULL, +0x83fca2c757bd778aULL, +0xc36e48dc74849ba5ULL, +0xc00c925dd413a324ULL, +0x7f9458eaf7aef15ULL, +0x86dc91b8e909374bULL, +0x801924bba8274648ULL, +0xff28b1d5ef5de2bULL, +0xdb92371d2126e97ULL, +0x324977504e8c90ULL, +0x1fe5163abdebbc56ULL, +0x1b7246e3a424dd2eULL, +0x6492eea09d1921ULL, +0x3fca2c757bd778acULL, +0x36e48dc74849ba5cULL, +0xc925dd413a3243ULL, +0x7f9458eaf7aef158ULL, +0x6dc91b8e909374b8ULL, +0x1924bba82746487ULL, +0xff28b1d5ef5de2b0ULL, +0xdb92371d2126e970ULL, +0x324977504e8c90eULL, +0xfe5163abdebbc561ULL, +0xb7246e3a424dd2e0ULL, +0x6492eea09d1921cULL, +0xfca2c757bd778ac3ULL, +0x6e48dc74849ba5c0ULL, +0xc925dd413a32439ULL, +0xf9458eaf7aef1586ULL, +0xdc91b8e909374b80ULL, +0x1924bba827464873ULL, +0xf28b1d5ef5de2b0dULL, +0xb92371d2126e9700ULL, +0x324977504e8c90e7ULL, +0xe5163abdebbc561bULL, +0x7246e3a424dd2e00ULL, +0x6492eea09d1921cfULL, +0xca2c757bd778ac36ULL, +0xe48dc74849ba5c00ULL, +0xc925dd413a32439fULL, +0x9458eaf7aef1586dULL, +0xc91b8e909374b801ULL, +0x924bba827464873fULL, +0x28b1d5ef5de2b0dbULL, +0x92371d2126e97003ULL, +0x24977504e8c90e7fULL, +0x5163abdebbc561b7ULL, +0x246e3a424dd2e006ULL, +0x492eea09d1921cfeULL, +0xa2c757bd778ac36eULL, +0x48dc74849ba5c00cULL, +0x925dd413a32439fcULL, +0x458eaf7aef1586dcULL, +0x91b8e909374b8019ULL, +0x24bba827464873f8ULL, +0x8b1d5ef5de2b0db9ULL, +0x2371d2126e970032ULL, +0x4977504e8c90e7f0ULL, +0x163abdebbc561b72ULL, +0x46e3a424dd2e0064ULL, +0x92eea09d1921cfe1ULL, +0x2c757bd778ac36e4ULL, +0x8dc74849ba5c00c9ULL, +0x25dd413a32439fc3ULL, +0x58eaf7aef1586dc9ULL, +0x1b8e909374b80192ULL, +0x4bba827464873f87ULL, +0xb1d5ef5de2b0db92ULL, +0x371d2126e9700324ULL, +0x977504e8c90e7f0eULL, +0x63abdebbc561b724ULL, +0x6e3a424dd2e00649ULL, +0x2eea09d1921cfe1dULL, +0xc757bd778ac36e48ULL, +0xdc74849ba5c00c92ULL, +0x5dd413a32439fc3bULL, +0x8eaf7aef1586dc91ULL, +0xb8e909374b801924ULL, +0xbba827464873f877ULL, +0x1d5ef5de2b0db923ULL, +0x71d2126e97003249ULL, +0x77504e8c90e7f0efULL, +0x3abdebbc561b7246ULL, +0xe3a424dd2e006492ULL, +0xeea09d1921cfe1deULL, +0x757bd778ac36e48dULL, +0xc74849ba5c00c925ULL, +0xdd413a32439fc3bdULL, +0xeaf7aef1586dc91bULL, +0x8e909374b801924bULL, +0xba827464873f877aULL, +0xd5ef5de2b0db9237ULL, +0x1d2126e970032497ULL, +0x7504e8c90e7f0ef5ULL, +0xabdebbc561b7246eULL, +0x3a424dd2e006492eULL, +0xea09d1921cfe1debULL, +0x57bd778ac36e48dcULL, +0x74849ba5c00c925dULL, +0xd413a32439fc3bd6ULL, +0xaf7aef1586dc91b8ULL, +0xe909374b801924bbULL, +0xa827464873f877acULL, +0x5ef5de2b0db92371ULL, +0xd2126e9700324977ULL, +0x504e8c90e7f0ef58ULL, +0xbdebbc561b7246e3ULL, +0xa424dd2e006492eeULL, +0xa09d1921cfe1deb1ULL, +0x7bd778ac36e48dc7ULL, +0x4849ba5c00c925ddULL, +0x413a32439fc3bd63ULL, +0xf7aef1586dc91b8eULL, +0x909374b801924bbaULL, +0x827464873f877ac7ULL, +0xef5de2b0db92371dULL, +0x2126e97003249775ULL, +0x4e8c90e7f0ef58eULL, +0xdebbc561b7246e3aULL, +0x424dd2e006492eeaULL, +0x9d1921cfe1deb1cULL, +0xbd778ac36e48dc74ULL, +0x849ba5c00c925dd4ULL, +0x13a32439fc3bd639ULL, +0x7aef1586dc91b8e9ULL, +0x9374b801924bba8ULL, +0x27464873f877ac72ULL, +0xf5de2b0db92371d2ULL, +0x126e970032497750ULL, +0x4e8c90e7f0ef58e5ULL, +0xebbc561b7246e3a4ULL, +0x24dd2e006492eea0ULL, +0x9d1921cfe1deb1cbULL, +0xd778ac36e48dc748ULL, +0x49ba5c00c925dd41ULL, +0x3a32439fc3bd6396ULL, +0xaef1586dc91b8e90ULL, +0x9374b801924bba82ULL, +0x7464873f877ac72cULL, +0x5de2b0db92371d21ULL, +0x26e9700324977504ULL, +0xe8c90e7f0ef58e58ULL, +0xbbc561b7246e3a42ULL, +0x4dd2e006492eea09ULL, +0xd1921cfe1deb1cb1ULL, +0x778ac36e48dc7484ULL, +0x9ba5c00c925dd413ULL, +0xa32439fc3bd63962ULL, +0xef1586dc91b8e909ULL, +0x374b801924bba827ULL, +0x464873f877ac72c4ULL, +0xde2b0db92371d212ULL, +0x6e9700324977504eULL, +0x8c90e7f0ef58e589ULL, +0xbc561b7246e3a424ULL, +0xdd2e006492eea09dULL, +0x1921cfe1deb1cb12ULL, +0x78ac36e48dc74849ULL, +0xba5c00c925dd413aULL, +0x32439fc3bd639625ULL, +0xf1586dc91b8e9093ULL, +0x74b801924bba8274ULL, +0x64873f877ac72c4aULL, +0xe2b0db92371d2126ULL, +0xe9700324977504e8ULL, +0xc90e7f0ef58e5894ULL, +0xc561b7246e3a424dULL, +0xd2e006492eea09d1ULL, +0x921cfe1deb1cb129ULL, +0x8ac36e48dc74849bULL, +0xa5c00c925dd413a3ULL, +0x2439fc3bd6396253ULL, +0x1586dc91b8e90937ULL, +0x4b801924bba82746ULL, +0x4873f877ac72c4a6ULL, +0x2b0db92371d2126eULL, +0x9700324977504e8cULL, +0x90e7f0ef58e5894dULL, +0x561b7246e3a424ddULL, +0x2e006492eea09d19ULL, +0x21cfe1deb1cb129aULL, +0xac36e48dc74849baULL, +0x5c00c925dd413a32ULL, +0x439fc3bd63962534ULL, +0x586dc91b8e909374ULL, +0xb801924bba827464ULL, +0x873f877ac72c4a69ULL, +0xb0db92371d2126e9ULL, +0x700324977504e8c9ULL, +0xe7f0ef58e5894d3ULL, +0x61b7246e3a424dd2ULL, +0xe006492eea09d192ULL, +0x1cfe1deb1cb129a7ULL, +0xc36e48dc74849ba5ULL, +0xc00c925dd413a324ULL, +0x39fc3bd63962534eULL, +0x86dc91b8e909374bULL, +0x801924bba8274648ULL, +0x73f877ac72c4a69cULL, +0xdb92371d2126e97ULL, +0x324977504e8c90ULL, +0xe7f0ef58e5894d39ULL, +0x1b7246e3a424dd2eULL, +0x6492eea09d1921ULL, +0xcfe1deb1cb129a73ULL, +0x36e48dc74849ba5cULL, +0xc925dd413a3243ULL, +0x9fc3bd63962534e7ULL, +0x6dc91b8e909374b8ULL, +0x1924bba82746487ULL, +0x3f877ac72c4a69cfULL, +0xdb92371d2126e970ULL, +0x324977504e8c90eULL, +0x7f0ef58e5894d39fULL, +0xb7246e3a424dd2e0ULL, +0x6492eea09d1921cULL, +0xfe1deb1cb129a73eULL, +0x6e48dc74849ba5c0ULL, +0xc925dd413a32439ULL, +0xfc3bd63962534e7dULL, +0xdc91b8e909374b80ULL, +0x1924bba827464873ULL, +0xf877ac72c4a69cfbULL, +0xb92371d2126e9700ULL, +0x324977504e8c90e7ULL, +0xf0ef58e5894d39f7ULL, +0x7246e3a424dd2e00ULL, +0x6492eea09d1921cfULL, +0xe1deb1cb129a73eeULL, +0xe48dc74849ba5c00ULL, +0xc925dd413a32439fULL, +0xc3bd63962534e7ddULL, +0xc91b8e909374b801ULL, +0x924bba827464873fULL, +0x877ac72c4a69cfbaULL, +0x92371d2126e97003ULL, +0x24977504e8c90e7fULL, +0xef58e5894d39f74ULL, +0x246e3a424dd2e006ULL, +0x492eea09d1921cfeULL, +0x1deb1cb129a73ee8ULL, +0x48dc74849ba5c00cULL, +0x925dd413a32439fcULL, +0x3bd63962534e7dd1ULL, +0x91b8e909374b8019ULL, +0x24bba827464873f8ULL, +0x77ac72c4a69cfba2ULL, +0x2371d2126e970032ULL, +0x4977504e8c90e7f0ULL, +0xef58e5894d39f744ULL, +0x46e3a424dd2e0064ULL, +0x92eea09d1921cfe1ULL, +0xdeb1cb129a73ee88ULL, +0x8dc74849ba5c00c9ULL, +0x25dd413a32439fc3ULL, +0xbd63962534e7dd10ULL, +0x1b8e909374b80192ULL, +0x4bba827464873f87ULL, +0x7ac72c4a69cfba20ULL, +0x371d2126e9700324ULL, +0x977504e8c90e7f0eULL, +0xf58e5894d39f7441ULL, +0x6e3a424dd2e00649ULL, +0x2eea09d1921cfe1dULL, +0xeb1cb129a73ee882ULL, +0xdc74849ba5c00c92ULL, +0x5dd413a32439fc3bULL, +0xd63962534e7dd104ULL, +0xb8e909374b801924ULL, +0xbba827464873f877ULL, +0xac72c4a69cfba208ULL, +0x71d2126e97003249ULL, +0x77504e8c90e7f0efULL, +0x58e5894d39f74411ULL, +0xe3a424dd2e006492ULL, +0xeea09d1921cfe1deULL, +0xb1cb129a73ee8823ULL, +0xc74849ba5c00c925ULL, +0xdd413a32439fc3bdULL, +0x63962534e7dd1046ULL, +0x8e909374b801924bULL, +0xba827464873f877aULL, +0xc72c4a69cfba208dULL, +0x1d2126e970032497ULL, +0x7504e8c90e7f0ef5ULL, +0x8e5894d39f74411aULL, +0x3a424dd2e006492eULL, +0xea09d1921cfe1debULL, +0x1cb129a73ee88235ULL, +0x74849ba5c00c925dULL, +0xd413a32439fc3bd6ULL, +0x3962534e7dd1046bULL, +0xe909374b801924bbULL, +0xa827464873f877acULL, +0x72c4a69cfba208d7ULL, +0xd2126e9700324977ULL, +0x504e8c90e7f0ef58ULL, +0xe5894d39f74411afULL, +0xa424dd2e006492eeULL, +0xa09d1921cfe1deb1ULL, +0xcb129a73ee88235fULL, +0x4849ba5c00c925ddULL, +0x413a32439fc3bd63ULL, +0x962534e7dd1046beULL, +0x909374b801924bbaULL, +0x827464873f877ac7ULL, +0x2c4a69cfba208d7dULL, +0x2126e97003249775ULL, +0x4e8c90e7f0ef58eULL, +0x5894d39f74411afaULL, +0x424dd2e006492eeaULL, +0x9d1921cfe1deb1cULL, +0xb129a73ee88235f5ULL, +0x849ba5c00c925dd4ULL, +0x13a32439fc3bd639ULL, +0x62534e7dd1046beaULL, +0x9374b801924bba8ULL, +0x27464873f877ac72ULL, +0xc4a69cfba208d7d4ULL, +0x126e970032497750ULL, +0x4e8c90e7f0ef58e5ULL, +0x894d39f74411afa9ULL, +0x24dd2e006492eea0ULL, +0x9d1921cfe1deb1cbULL, +0x129a73ee88235f52ULL, +0x49ba5c00c925dd41ULL, +0x3a32439fc3bd6396ULL, +0x2534e7dd1046bea5ULL, +0x9374b801924bba82ULL, +0x7464873f877ac72cULL, +0x4a69cfba208d7d4bULL, +0x26e9700324977504ULL, +0xe8c90e7f0ef58e58ULL, +0x94d39f74411afa97ULL, +0x4dd2e006492eea09ULL, +0xd1921cfe1deb1cb1ULL, +0x29a73ee88235f52eULL, +0x9ba5c00c925dd413ULL, +0xa32439fc3bd63962ULL, +0x534e7dd1046bea5dULL, +0x374b801924bba827ULL, +0x464873f877ac72c4ULL, +0xa69cfba208d7d4baULL, +0x6e9700324977504eULL, +0x8c90e7f0ef58e589ULL, +0x4d39f74411afa975ULL, +0xdd2e006492eea09dULL, +0x1921cfe1deb1cb12ULL, +0x9a73ee88235f52ebULL, +0xba5c00c925dd413aULL, +0x32439fc3bd639625ULL, +0x34e7dd1046bea5d7ULL, +0x74b801924bba8274ULL, +0x64873f877ac72c4aULL, +0x69cfba208d7d4baeULL, +0xe9700324977504e8ULL, +0xc90e7f0ef58e5894ULL, +0xd39f74411afa975dULL, +0xd2e006492eea09d1ULL, +0x921cfe1deb1cb129ULL, +0xa73ee88235f52ebbULL, +0xa5c00c925dd413a3ULL, +0x2439fc3bd6396253ULL, +0x4e7dd1046bea5d76ULL, +0x4b801924bba82746ULL, +0x4873f877ac72c4a6ULL, +0x9cfba208d7d4baedULL, +0x9700324977504e8cULL, +0x90e7f0ef58e5894dULL, +0x39f74411afa975daULL, +0x2e006492eea09d19ULL, +0x21cfe1deb1cb129aULL, +0x73ee88235f52ebb4ULL, +0x5c00c925dd413a32ULL, +0x439fc3bd63962534ULL, +0xe7dd1046bea5d768ULL, +0xb801924bba827464ULL, +0x873f877ac72c4a69ULL, +0xcfba208d7d4baed1ULL, +0x700324977504e8c9ULL, +0xe7f0ef58e5894d3ULL, +0x9f74411afa975da2ULL, +0xe006492eea09d192ULL, +0x1cfe1deb1cb129a7ULL, +0x3ee88235f52ebb44ULL, +0xc00c925dd413a324ULL, +0x39fc3bd63962534eULL, +0x7dd1046bea5d7689ULL, +0x801924bba8274648ULL, +0x73f877ac72c4a69cULL, +0xfba208d7d4baed12ULL, +0x324977504e8c90ULL, +0xe7f0ef58e5894d39ULL, +0xf74411afa975da24ULL, +0x6492eea09d1921ULL, +0xcfe1deb1cb129a73ULL, +0xee88235f52ebb448ULL, +0xc925dd413a3243ULL, +0x9fc3bd63962534e7ULL, +0xdd1046bea5d76890ULL, +0x1924bba82746487ULL, +0x3f877ac72c4a69cfULL, +0xba208d7d4baed121ULL, +0x324977504e8c90eULL, +0x7f0ef58e5894d39fULL, +0x74411afa975da242ULL, +0x6492eea09d1921cULL, +0xfe1deb1cb129a73eULL, +0xe88235f52ebb4484ULL, +0xc925dd413a32439ULL, +0xfc3bd63962534e7dULL, +0xd1046bea5d768909ULL, +0x1924bba827464873ULL, +0xf877ac72c4a69cfbULL, +0xa208d7d4baed1213ULL, +0x324977504e8c90e7ULL, +0xf0ef58e5894d39f7ULL, +0x4411afa975da2427ULL, +0x6492eea09d1921cfULL, +0xe1deb1cb129a73eeULL, +0x88235f52ebb4484eULL, +0xc925dd413a32439fULL, +0xc3bd63962534e7ddULL, +0x1046bea5d768909dULL, +0x924bba827464873fULL, +0x877ac72c4a69cfbaULL, +0x208d7d4baed1213aULL, +0x24977504e8c90e7fULL, +0xef58e5894d39f74ULL, +0x411afa975da24274ULL, +0x492eea09d1921cfeULL, +0x1deb1cb129a73ee8ULL, +0x8235f52ebb4484e9ULL, +0x925dd413a32439fcULL, +0x3bd63962534e7dd1ULL, +0x46bea5d768909d3ULL, +0x24bba827464873f8ULL, +0x77ac72c4a69cfba2ULL, +0x8d7d4baed1213a6ULL, +0x4977504e8c90e7f0ULL, +0xef58e5894d39f744ULL, +0x11afa975da24274cULL, +0x92eea09d1921cfe1ULL, +0xdeb1cb129a73ee88ULL, +0x235f52ebb4484e99ULL, +0x25dd413a32439fc3ULL, +0xbd63962534e7dd10ULL, +0x46bea5d768909d33ULL, +0x4bba827464873f87ULL, +0x7ac72c4a69cfba20ULL, +0x8d7d4baed1213a67ULL, +0x977504e8c90e7f0eULL, +0xf58e5894d39f7441ULL, +0x1afa975da24274ceULL, +0x2eea09d1921cfe1dULL, +0xeb1cb129a73ee882ULL, +0x35f52ebb4484e99cULL, +0x5dd413a32439fc3bULL, +0xd63962534e7dd104ULL, +0x6bea5d768909d338ULL, +0xbba827464873f877ULL, +0xac72c4a69cfba208ULL, +0xd7d4baed1213a671ULL, +0x77504e8c90e7f0efULL, +0x58e5894d39f74411ULL, +0xafa975da24274ce3ULL, +0xeea09d1921cfe1deULL, +0xb1cb129a73ee8823ULL, +0x5f52ebb4484e99c7ULL, +0xdd413a32439fc3bdULL, +0x63962534e7dd1046ULL, +0xbea5d768909d338eULL, +0xba827464873f877aULL, +0xc72c4a69cfba208dULL, +0x7d4baed1213a671cULL, +0x7504e8c90e7f0ef5ULL, +0x8e5894d39f74411aULL, +0xfa975da24274ce38ULL, +0xea09d1921cfe1debULL, +0x1cb129a73ee88235ULL, +0xf52ebb4484e99c70ULL, +0xd413a32439fc3bd6ULL, +0x3962534e7dd1046bULL, +0xea5d768909d338e0ULL, +0xa827464873f877acULL, +0x72c4a69cfba208d7ULL, +0xd4baed1213a671c0ULL, +0x504e8c90e7f0ef58ULL, +0xe5894d39f74411afULL, +0xa975da24274ce381ULL, +0xa09d1921cfe1deb1ULL, +0xcb129a73ee88235fULL, +0x52ebb4484e99c702ULL, +0x413a32439fc3bd63ULL, +0x962534e7dd1046beULL, +0xa5d768909d338e04ULL, +0x827464873f877ac7ULL, +0x2c4a69cfba208d7dULL, +0x4baed1213a671c09ULL, +0x4e8c90e7f0ef58eULL, +0x5894d39f74411afaULL, +0x975da24274ce3813ULL, +0x9d1921cfe1deb1cULL, +0xb129a73ee88235f5ULL, +0x2ebb4484e99c7026ULL, +0x13a32439fc3bd639ULL, +0x62534e7dd1046beaULL, +0x5d768909d338e04dULL, +0x27464873f877ac72ULL, +0xc4a69cfba208d7d4ULL, +0xbaed1213a671c09aULL, +0x4e8c90e7f0ef58e5ULL, +0x894d39f74411afa9ULL, +0x75da24274ce38135ULL, +0x9d1921cfe1deb1cbULL, +0x129a73ee88235f52ULL, +0xebb4484e99c7026bULL, +0x3a32439fc3bd6396ULL, +0x2534e7dd1046bea5ULL, +0xd768909d338e04d6ULL, +0x7464873f877ac72cULL, +0x4a69cfba208d7d4bULL, +0xaed1213a671c09adULL, +0xe8c90e7f0ef58e58ULL, +0x94d39f74411afa97ULL, +0x5da24274ce38135aULL, +0xd1921cfe1deb1cb1ULL, +0x29a73ee88235f52eULL, +0xbb4484e99c7026b4ULL, +0xa32439fc3bd63962ULL, +0x534e7dd1046bea5dULL, +0x768909d338e04d68ULL, +0x464873f877ac72c4ULL, +0xa69cfba208d7d4baULL, +0xed1213a671c09ad1ULL, +0x8c90e7f0ef58e589ULL, +0x4d39f74411afa975ULL, +0xda24274ce38135a2ULL, +0x1921cfe1deb1cb12ULL, +0x9a73ee88235f52ebULL, +0xb4484e99c7026b45ULL, +0x32439fc3bd639625ULL, +0x34e7dd1046bea5d7ULL, +0x68909d338e04d68bULL, +0x64873f877ac72c4aULL, +0x69cfba208d7d4baeULL, +0xd1213a671c09ad17ULL, +0xc90e7f0ef58e5894ULL, +0xd39f74411afa975dULL, +0xa24274ce38135a2fULL, +0x921cfe1deb1cb129ULL, +0xa73ee88235f52ebbULL, +0x4484e99c7026b45fULL, +0x2439fc3bd6396253ULL, +0x4e7dd1046bea5d76ULL, +0x8909d338e04d68beULL, +0x4873f877ac72c4a6ULL, +0x9cfba208d7d4baedULL, +0x1213a671c09ad17dULL, +0x90e7f0ef58e5894dULL, +0x39f74411afa975daULL, +0x24274ce38135a2fbULL, +0x21cfe1deb1cb129aULL, +0x73ee88235f52ebb4ULL, +0x484e99c7026b45f7ULL, +0x439fc3bd63962534ULL, +0xe7dd1046bea5d768ULL, +0x909d338e04d68befULL, +0x873f877ac72c4a69ULL, +0xcfba208d7d4baed1ULL, +0x213a671c09ad17dfULL, +0xe7f0ef58e5894d3ULL, +0x9f74411afa975da2ULL, +0x4274ce38135a2fbfULL, +0x1cfe1deb1cb129a7ULL, +0x3ee88235f52ebb44ULL, +0x84e99c7026b45f7eULL, +0x39fc3bd63962534eULL, +0x7dd1046bea5d7689ULL, +0x9d338e04d68befcULL, +0x73f877ac72c4a69cULL, +0xfba208d7d4baed12ULL, +0x13a671c09ad17df9ULL, +0xe7f0ef58e5894d39ULL, +0xf74411afa975da24ULL, +0x274ce38135a2fbf2ULL, +0xcfe1deb1cb129a73ULL, +0xee88235f52ebb448ULL, +0x4e99c7026b45f7e4ULL, +0x9fc3bd63962534e7ULL, +0xdd1046bea5d76890ULL, +0x9d338e04d68befc8ULL, +0x3f877ac72c4a69cfULL, +0xba208d7d4baed121ULL, +0x3a671c09ad17df90ULL, +0x7f0ef58e5894d39fULL, +0x74411afa975da242ULL, +0x74ce38135a2fbf20ULL, +0xfe1deb1cb129a73eULL, +0xe88235f52ebb4484ULL, +0xe99c7026b45f7e41ULL, +0xfc3bd63962534e7dULL, +0xd1046bea5d768909ULL, +0xd338e04d68befc82ULL, +0xf877ac72c4a69cfbULL, +0xa208d7d4baed1213ULL, +0xa671c09ad17df904ULL, +0xf0ef58e5894d39f7ULL, +0x4411afa975da2427ULL, +0x4ce38135a2fbf208ULL, +0xe1deb1cb129a73eeULL, +0x88235f52ebb4484eULL, +0x99c7026b45f7e410ULL, +0xc3bd63962534e7ddULL, +0x1046bea5d768909dULL, +0x338e04d68befc820ULL, +0x877ac72c4a69cfbaULL, +0x208d7d4baed1213aULL, +0x671c09ad17df9040ULL, +0xef58e5894d39f74ULL, +0x411afa975da24274ULL, +0xce38135a2fbf2080ULL, +0x1deb1cb129a73ee8ULL, +0x8235f52ebb4484e9ULL, +0x9c7026b45f7e4100ULL, +0x3bd63962534e7dd1ULL, +0x46bea5d768909d3ULL, +0x38e04d68befc8200ULL, +0x77ac72c4a69cfba2ULL, +0x8d7d4baed1213a6ULL, +0x71c09ad17df90400ULL, +0xef58e5894d39f744ULL, +0x11afa975da24274cULL, +0xe38135a2fbf20800ULL, +0xdeb1cb129a73ee88ULL, +0x235f52ebb4484e99ULL, +0xc7026b45f7e41000ULL, +0xbd63962534e7dd10ULL, +0x46bea5d768909d33ULL, +0x8e04d68befc82000ULL, +0x7ac72c4a69cfba20ULL, +0x8d7d4baed1213a67ULL, +0x1c09ad17df904000ULL, +0xf58e5894d39f7441ULL, +0x1afa975da24274ceULL, +0x38135a2fbf208000ULL, +0xeb1cb129a73ee882ULL, +0x35f52ebb4484e99cULL, +0x7026b45f7e410000ULL, +0xd63962534e7dd104ULL, +0x6bea5d768909d338ULL, +0xe04d68befc820000ULL, +0xac72c4a69cfba208ULL, +0xd7d4baed1213a671ULL, +0xc09ad17df9040000ULL, +0x58e5894d39f74411ULL, +0xafa975da24274ce3ULL, +0x8135a2fbf2080000ULL, +0xb1cb129a73ee8823ULL, +0x5f52ebb4484e99c7ULL, +0x26b45f7e4100000ULL, +0x63962534e7dd1046ULL, +0xbea5d768909d338eULL, +0x4d68befc8200000ULL, +0xc72c4a69cfba208dULL, +0x7d4baed1213a671cULL, +0x9ad17df90400000ULL, +0x8e5894d39f74411aULL, +0xfa975da24274ce38ULL, +0x135a2fbf20800000ULL, +0x1cb129a73ee88235ULL, +0xf52ebb4484e99c70ULL, +0x26b45f7e41000000ULL, +0x3962534e7dd1046bULL, +0xea5d768909d338e0ULL, +0x4d68befc82000000ULL, +0x72c4a69cfba208d7ULL, +0xd4baed1213a671c0ULL, +0x9ad17df904000000ULL, +0xe5894d39f74411afULL, +0xa975da24274ce381ULL, +0x35a2fbf208000000ULL, +0xcb129a73ee88235fULL, +0x52ebb4484e99c702ULL, +0x6b45f7e410000000ULL, +0x962534e7dd1046beULL, +0xa5d768909d338e04ULL, +0xd68befc820000000ULL, +0x2c4a69cfba208d7dULL, +0x4baed1213a671c09ULL, +0xad17df9040000000ULL, +0x5894d39f74411afaULL, +0x975da24274ce3813ULL, +0x5a2fbf2080000000ULL, +0xb129a73ee88235f5ULL, +0x2ebb4484e99c7026ULL, +0xb45f7e4100000000ULL, +0x62534e7dd1046beaULL, +0x5d768909d338e04dULL, +0x68befc8200000000ULL, +0xc4a69cfba208d7d4ULL, +0xbaed1213a671c09aULL, +0xd17df90400000000ULL, +0x894d39f74411afa9ULL, +0x75da24274ce38135ULL, +0xa2fbf20800000000ULL, +0x129a73ee88235f52ULL, +0xebb4484e99c7026bULL, +0x45f7e41000000000ULL, +0x2534e7dd1046bea5ULL, +0xd768909d338e04d6ULL, +0x8befc82000000000ULL, +0x4a69cfba208d7d4bULL, +0xaed1213a671c09adULL, +0x17df904000000000ULL, +0x94d39f74411afa97ULL, +0x5da24274ce38135aULL, +0x2fbf208000000000ULL, +0x29a73ee88235f52eULL, +0xbb4484e99c7026b4ULL, +0x5f7e410000000000ULL, +0x534e7dd1046bea5dULL, +0x768909d338e04d68ULL, +0xbefc820000000000ULL, +0xa69cfba208d7d4baULL, +0xed1213a671c09ad1ULL, +0x7df9040000000000ULL, +0x4d39f74411afa975ULL, +0xda24274ce38135a2ULL, +0xfbf2080000000000ULL, +0x9a73ee88235f52ebULL, +0xb4484e99c7026b45ULL, +0xf7e4100000000000ULL, +0x34e7dd1046bea5d7ULL, +0x68909d338e04d68bULL, +0xefc8200000000000ULL, +0x69cfba208d7d4baeULL, +0xd1213a671c09ad17ULL, +0xdf90400000000000ULL, +0xd39f74411afa975dULL, +0xa24274ce38135a2fULL, +0xbf20800000000000ULL, +0xa73ee88235f52ebbULL, +0x4484e99c7026b45fULL, +0x7e41000000000000ULL, +0x4e7dd1046bea5d76ULL, +0x8909d338e04d68beULL, +0xfc82000000000000ULL, +0x9cfba208d7d4baedULL, +0x1213a671c09ad17dULL, +0xf904000000000000ULL, +0x39f74411afa975daULL, +0x24274ce38135a2fbULL, +0xf208000000000000ULL, +0x73ee88235f52ebb4ULL, +0x484e99c7026b45f7ULL, +0xe410000000000000ULL, +0xe7dd1046bea5d768ULL, +0x909d338e04d68befULL, +0xc820000000000000ULL, +0xcfba208d7d4baed1ULL, +0x213a671c09ad17dfULL, +0x9040000000000000ULL, +0x9f74411afa975da2ULL, +0x4274ce38135a2fbfULL, +0x2080000000000000ULL, +0x3ee88235f52ebb44ULL, +0x84e99c7026b45f7eULL, +0x4100000000000000ULL, +0x7dd1046bea5d7689ULL, +0x9d338e04d68befcULL, +0x8200000000000000ULL, +0xfba208d7d4baed12ULL, +0x13a671c09ad17df9ULL, +0x400000000000000ULL, +0xf74411afa975da24ULL, +0x274ce38135a2fbf2ULL, +0x800000000000000ULL, +0xee88235f52ebb448ULL, +0x4e99c7026b45f7e4ULL, +0x1000000000000000ULL, +0xdd1046bea5d76890ULL, +0x9d338e04d68befc8ULL, +0x2000000000000000ULL, +0xba208d7d4baed121ULL, +0x3a671c09ad17df90ULL, +0x4000000000000000ULL, +0x74411afa975da242ULL, +0x74ce38135a2fbf20ULL, +0x8000000000000000ULL, +0xe88235f52ebb4484ULL, +0xe99c7026b45f7e41ULL, +0x0ULL, +0xd1046bea5d768909ULL, +0xd338e04d68befc82ULL, +0x0ULL, +0xa208d7d4baed1213ULL, +0xa671c09ad17df904ULL, +0x0ULL, +0x4411afa975da2427ULL, +0x4ce38135a2fbf208ULL, +0x0ULL, +0x88235f52ebb4484eULL, +0x99c7026b45f7e410ULL, +0x0ULL, +0x1046bea5d768909dULL, +0x338e04d68befc820ULL, +0x0ULL, +0x208d7d4baed1213aULL, +0x671c09ad17df9040ULL, +0x0ULL, +0x411afa975da24274ULL, +0xce38135a2fbf2080ULL, +0x0ULL, +0x8235f52ebb4484e9ULL, +0x9c7026b45f7e4100ULL, +0x0ULL, +0x46bea5d768909d3ULL, +0x38e04d68befc8200ULL, +0x0ULL, +0x8d7d4baed1213a6ULL, +0x71c09ad17df90400ULL, +0x0ULL, +0x11afa975da24274cULL, +0xe38135a2fbf20800ULL, +0x0ULL, +0x235f52ebb4484e99ULL, +0xc7026b45f7e41000ULL, +0x0ULL, +0x46bea5d768909d33ULL, +0x8e04d68befc82000ULL, +0x0ULL, +0x8d7d4baed1213a67ULL, +0x1c09ad17df904000ULL, +0x0ULL, +0x1afa975da24274ceULL, +0x38135a2fbf208000ULL, +0x0ULL, +0x35f52ebb4484e99cULL, +0x7026b45f7e410000ULL, +0x0ULL, +0x6bea5d768909d338ULL, +0xe04d68befc820000ULL, +0x0ULL, +0xd7d4baed1213a671ULL, +0xc09ad17df9040000ULL, +0x0ULL, +0xafa975da24274ce3ULL, +0x8135a2fbf2080000ULL, +0x0ULL, +0x5f52ebb4484e99c7ULL, +0x26b45f7e4100000ULL, +0x0ULL, +0xbea5d768909d338eULL, +0x4d68befc8200000ULL, +0x0ULL, +0x7d4baed1213a671cULL, +0x9ad17df90400000ULL, +0x0ULL, +0xfa975da24274ce38ULL, +0x135a2fbf20800000ULL, +0x0ULL, +0xf52ebb4484e99c70ULL, +0x26b45f7e41000000ULL, +0x0ULL, +0xea5d768909d338e0ULL, +0x4d68befc82000000ULL, +0x0ULL, +0xd4baed1213a671c0ULL, +0x9ad17df904000000ULL, +0x0ULL, +0xa975da24274ce381ULL, +0x35a2fbf208000000ULL, +0x0ULL, +0x52ebb4484e99c702ULL, +0x6b45f7e410000000ULL, +0x0ULL, +0xa5d768909d338e04ULL, +0xd68befc820000000ULL, +0x0ULL, +0x4baed1213a671c09ULL, +0xad17df9040000000ULL, +0x0ULL, +0x975da24274ce3813ULL, +0x5a2fbf2080000000ULL, +0x0ULL, +0x2ebb4484e99c7026ULL, +0xb45f7e4100000000ULL, +0x0ULL, +0x5d768909d338e04dULL, +0x68befc8200000000ULL, +0x0ULL, +0xbaed1213a671c09aULL, +0xd17df90400000000ULL, +0x0ULL, +0x75da24274ce38135ULL, +0xa2fbf20800000000ULL, +0x0ULL, +0xebb4484e99c7026bULL, +0x45f7e41000000000ULL, +0x0ULL, +0xd768909d338e04d6ULL, +0x8befc82000000000ULL, +0x0ULL, +0xaed1213a671c09adULL, +0x17df904000000000ULL, +0x0ULL, +0x5da24274ce38135aULL, +0x2fbf208000000000ULL, +0x0ULL, +0xbb4484e99c7026b4ULL, +0x5f7e410000000000ULL, +0x0ULL, +0x768909d338e04d68ULL, +0xbefc820000000000ULL, +0x0ULL, +0xed1213a671c09ad1ULL, +0x7df9040000000000ULL, +0x0ULL, +0xda24274ce38135a2ULL, +0xfbf2080000000000ULL, +0x0ULL, +0xb4484e99c7026b45ULL, +0xf7e4100000000000ULL, +0x0ULL, +0x68909d338e04d68bULL, +0xefc8200000000000ULL, +0x0ULL, +0xd1213a671c09ad17ULL, +0xdf90400000000000ULL, +0x0ULL, +0xa24274ce38135a2fULL, +0xbf20800000000000ULL, +0x0ULL, +0x4484e99c7026b45fULL, +0x7e41000000000000ULL, +0x0ULL, +0x8909d338e04d68beULL, +0xfc82000000000000ULL, +0x0ULL, +0x1213a671c09ad17dULL, +0xf904000000000000ULL, +0x0ULL, +0x24274ce38135a2fbULL, +0xf208000000000000ULL, +0x0ULL, +0x484e99c7026b45f7ULL, +0xe410000000000000ULL, +0x0ULL, +0x909d338e04d68befULL, +0xc820000000000000ULL, +0x0ULL, +0x213a671c09ad17dfULL, +0x9040000000000000ULL, +0x0ULL, +0x4274ce38135a2fbfULL, +0x2080000000000000ULL, +0x0ULL, +0x84e99c7026b45f7eULL, +0x4100000000000000ULL, +0x0ULL, +0x9d338e04d68befcULL, +0x8200000000000000ULL, +0x0ULL, +0x13a671c09ad17df9ULL, +0x400000000000000ULL, +0x0ULL, +0x274ce38135a2fbf2ULL, +0x800000000000000ULL, +0x0ULL, +0x4e99c7026b45f7e4ULL, +0x1000000000000000ULL, +0x0ULL, +0x9d338e04d68befc8ULL, +0x2000000000000000ULL, +0x0ULL, +0x3a671c09ad17df90ULL, +0x4000000000000000ULL, +0x0ULL, +0x74ce38135a2fbf20ULL, +0x8000000000000000ULL, +0x0ULL, +0xe99c7026b45f7e41ULL, +0x0ULL, +0x0ULL, +0xd338e04d68befc82ULL, +0x0ULL, +0x0ULL, +0xa671c09ad17df904ULL, +0x0ULL, +0x0ULL, +0x4ce38135a2fbf208ULL, +0x0ULL, +0x0ULL, +0x99c7026b45f7e410ULL, +0x0ULL, +0x0ULL, +0x338e04d68befc820ULL, +0x0ULL, +0x0ULL, +0x671c09ad17df9040ULL, +0x0ULL, +0x0ULL, +0xce38135a2fbf2080ULL, +0x0ULL, +0x0ULL, +0x9c7026b45f7e4100ULL, +0x0ULL, +0x0ULL, +0x38e04d68befc8200ULL, +0x0ULL, +0x0ULL, +0x71c09ad17df90400ULL, +0x0ULL, +0x0ULL, +0xe38135a2fbf20800ULL, +0x0ULL, +0x0ULL, +0xc7026b45f7e41000ULL, +0x0ULL, +0x0ULL, +0x8e04d68befc82000ULL, +0x0ULL, +0x0ULL, +0x1c09ad17df904000ULL, +0x0ULL, +0x0ULL, +0x38135a2fbf208000ULL, +0x0ULL, +0x0ULL, +0x7026b45f7e410000ULL, +0x0ULL, +0x0ULL, +0xe04d68befc820000ULL, +0x0ULL, +0x0ULL, +0xc09ad17df9040000ULL, +0x0ULL, +0x0ULL, +0x8135a2fbf2080000ULL, +0x0ULL, +0x0ULL, +0x26b45f7e4100000ULL, +0x0ULL, +0x0ULL, +0x4d68befc8200000ULL, +0x0ULL, +0x0ULL, +0x9ad17df90400000ULL, +0x0ULL, +0x0ULL, +0x135a2fbf20800000ULL, +0x0ULL, +0x0ULL, +0x26b45f7e41000000ULL, +0x0ULL, +0x0ULL, +0x4d68befc82000000ULL, +0x0ULL, +0x0ULL, +0x9ad17df904000000ULL, +0x0ULL, +0x0ULL, +0x35a2fbf208000000ULL, +0x0ULL, +0x0ULL, +0x6b45f7e410000000ULL, +0x0ULL, +0x0ULL, +0xd68befc820000000ULL, +0x0ULL, +0x0ULL, +0xad17df9040000000ULL, +0x0ULL, +0x0ULL, +0x5a2fbf2080000000ULL, +0x0ULL, +0x0ULL, +0xb45f7e4100000000ULL, +0x0ULL, +0x0ULL, +0x68befc8200000000ULL, +0x0ULL, +0x0ULL, +0xd17df90400000000ULL, +0x0ULL, +0x0ULL, +0xa2fbf20800000000ULL, +0x0ULL, +0x0ULL, +0x45f7e41000000000ULL, +0x0ULL, +0x0ULL, +0x8befc82000000000ULL, +0x0ULL, +0x0ULL, +0x17df904000000000ULL, +0x0ULL, +0x0ULL, +0x2fbf208000000000ULL, +0x0ULL, +0x0ULL, +0x5f7e410000000000ULL, +0x0ULL, +0x0ULL, +0xbefc820000000000ULL, +0x0ULL, +0x0ULL, +0x7df9040000000000ULL, +0x0ULL, +0x0ULL, +0xfbf2080000000000ULL, +0x0ULL, +0x0ULL, +0xf7e4100000000000ULL, +0x0ULL, +0x0ULL, +0xefc8200000000000ULL, +0x0ULL, +0x0ULL, +0xdf90400000000000ULL, +0x0ULL, +0x0ULL, +0xbf20800000000000ULL, +0x0ULL, +0x0ULL, +0x7e41000000000000ULL, +0x0ULL, +0x0ULL, +0xfc82000000000000ULL, +0x0ULL, +0x0ULL, +0xf904000000000000ULL, +0x0ULL, +0x0ULL, +0xf208000000000000ULL, +0x0ULL, +0x0ULL, +0xe410000000000000ULL, +0x0ULL, +0x0ULL, +0xc820000000000000ULL, +0x0ULL, +0x0ULL, +0x9040000000000000ULL, +0x0ULL, +0x0ULL, +0x2080000000000000ULL, +0x0ULL, +0x0ULL, +0x4100000000000000ULL, +0x0ULL, +0x0ULL, +0x8200000000000000ULL, +0x0ULL, +0x0ULL, +0x400000000000000ULL, +0x0ULL, +0x0ULL, +0x800000000000000ULL, +0x0ULL, +0x0ULL, +0x1000000000000000ULL, +0x0ULL, +0x0ULL, +0x2000000000000000ULL, +0x0ULL, +0x0ULL, +0x4000000000000000ULL, +0x0ULL, +0x0ULL, +0x8000000000000000ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL, +0x0ULL +}; +template <> HWY_ALIGN constexpr double kSinApproxTable[] = { +0, +0, +0, +0x1p0, +-0x1.3bd3bc5fc5ab4p-18, +0x1.921f8becca4bap-9, +0x1.2ba407bcab5b2p-63, +0x1p0, +-0x1.3bd38bab6d94cp-16, +0x1.921f0fe670071p-8, +0x1.ab967fe6b7a9bp-64, +0x1p0, +-0x1.634da1cec522dp-15, +0x1.2d96b0e509703p-7, +-0x1.1e9131ff52dc9p-63, +0x1p0, +-0x1.3bd2c8da49511p-14, +0x1.921d1fcdec784p-7, +0x1.9878ebe836d9dp-61, +0x1p0, +-0x1.ed7875885ea3ap-14, +0x1.f6a296ab997cbp-7, +-0x1.f2943d8fe7033p-61, +0x1p0, +-0x1.634bb4ae5ed49p-13, +0x1.2d936bbe30efdp-6, +0x1.b5f91ee371d64p-61, +0x1p0, +-0x1.e3978f34889d9p-13, +0x1.5fd4d21fab226p-6, +-0x1.0c0a91c37851cp-61, +0x1p0, +-0x1.3bcfbd9979a27p-12, +0x1.92155f7a3667ep-6, +-0x1.b1d63091a013p-64, +0x1p0, +-0x1.8fb18eacc3af8p-12, +0x1.c454f4ce53b1dp-6, +-0x1.d63d7fef0e36cp-60, +0x1p0, +-0x1.ed71071603e86p-12, +0x1.f693731d1cf01p-6, +-0x1.3fe9bc66286c7p-66, +0x1p0, +-0x1.2a86f68094692p-11, +0x1.14685db42c17fp-5, +-0x1.2890d277cb974p-59, +0x1p0, +-0x1.6344004228d8bp-11, +0x1.2d865759455cdp-5, +0x1.686f65ba93acp-61, +0x1p0, +-0x1.a0ef7dcffafabp-11, +0x1.46a396ff86179p-5, +0x1.136ac00fa2da9p-61, +0x1p0, +-0x1.e389491f8833ap-11, +0x1.5fc00d290cd43p-5, +0x1.a2669a693a8e1p-59, +0x1p0, +-0x1.15889c8dd385fp-10, +0x1.78dbaa5874686p-5, +-0x1.4a0ef4035c29cp-60, +0x1p0, +-0x1.3bc390d250439p-10, +0x1.91f65f10dd814p-5, +-0x1.912bd0d569a9p-61, +0x1p0, +-0x1.647569c825ae1p-10, +0x1.ab101bd5f8317p-5, +-0x1.65c6175c6dc68p-59, +0x1p0, +-0x1.8f9e0e5514865p-10, +0x1.c428d12c0d7e3p-5, +-0x1.89bc74b58c513p-60, +0x1p0, +-0x1.bd3d63d9c26efp-10, +0x1.dd406f9808ec9p-5, +0x1.1313a4b4068bdp-62, +0x1p0, +-0x1.ed534e31ca57fp-10, +0x1.f656e79f820ep-5, +-0x1.2e1ebe392bffep-61, +0x1p0, +-0x1.0fefd7d9e6ed8p-9, +0x1.07b614e463064p-4, +-0x1.384f8c3ee7605p-58, +0x1p0, +-0x1.2a713498c3c3dp-9, +0x1.1440134d709b3p-4, +-0x1.fec446daea6adp-58, +0x1p0, +-0x1.462dacfbef0f3p-9, +0x1.20c9674ed444dp-4, +-0x1.f9d48faba7974p-58, +0x1p0, +-0x1.63252fe77c5ebp-9, +0x1.2d52092ce19f6p-4, +-0x1.9a088a8bf6b2cp-59, +0x1p0, +-0x1.8157ab7d29fd9p-9, +0x1.39d9f12c5a299p-4, +0x1.1287ff27ae554p-62, +0x1p0, +-0x1.a0c50d1c6bf93p-9, +0x1.4661179272096p-4, +-0x1.4b109f2406c4cp-58, +0x1p0, +-0x1.c16d4162779e5p-9, +0x1.52e774a4d4d0ap-4, +0x1.b2edf18c730cbp-60, +0x1p0, +-0x1.e350342a4f6e6p-9, +0x1.5f6d00a9aa419p-4, +-0x1.f4022d03f6c9ap-59, +0x1p0, +-0x1.0336e84667c66p-8, +0x1.6bf1b3e79b129p-4, +-0x1.14b6da08765p-58, +0x1p0, +-0x1.156300705d51bp-8, +0x1.787586a5d5b21p-4, +0x1.5f7589f083399p-58, +0x1p0, +-0x1.282c575d639fcp-8, +0x1.84f8712c130a1p-4, +-0x1.e626ebafe374ep-58, +0x1p0, +-0x1.3b92e176d6d31p-8, +0x1.917a6bc29b42cp-4, +-0x1.e2718d26ed688p-60, +0x1p0, +-0x1.4f9692c51b0fbp-8, +0x1.9dfb6eb24a85cp-4, +0x1.e96b47b8c44e6p-59, +0x1p0, +-0x1.64375eefa3dd6p-8, +0x1.aa7b724495c03p-4, +0x1.e5399ba0967b8p-58, +0x1p0, +-0x1.7975393cfbc4dp-8, +0x1.b6fa6ec38f64cp-4, +0x1.db5d943691f09p-58, +0x1p0, +-0x1.8f501492cc296p-8, +0x1.c3785c79ec2d5p-4, +-0x1.4f39df133fb21p-61, +0x1p0, +-0x1.a5c7e375e55dep-8, +0x1.cff533b307dc1p-4, +0x1.8feeb8f9c3334p-59, +0x1p0, +-0x1.bcdc980a46f5ap-8, +0x1.dc70ecbae9fc9p-4, +0x1.2fda2d73295eep-60, +0x1p0, +-0x1.d48e24132851p-8, +0x1.e8eb7fde4aa3fp-4, +-0x1.23758f2d5bb8bp-58, +0x1p0, +-0x1.ecdc78f30165cp-8, +0x1.f564e56a9730ep-4, +0x1.a2704729ae56dp-59, +0x1p0, +-0x1.02e3c3d5c9e17p-7, +0x1.00ee8ad6fb85bp-3, +0x1.673eac8308f11p-58, +0x1p0, +-0x1.0fa7a06ef9e81p-7, +0x1.072a047ba831dp-3, +0x1.19db1f70118cap-58, +0x1p0, +-0x1.1cb9ca654924fp-7, +0x1.0d64dbcb26786p-3, +-0x1.713a562132055p-58, +0x1p0, +-0x1.2a1a39a8a2fb7p-7, +0x1.139f0cedaf577p-3, +-0x1.523434d1b3cfap-57, +0x1p0, +-0x1.37c8e5f8aacep-7, +0x1.19d8940be24e7p-3, +0x1.e8dcdca90cc74p-58, +0x1p0, +-0x1.45c5c6e4c114ap-7, +0x1.20116d4ec7bcfp-3, +-0x1.242c8e1053452p-57, +0x1p0, +-0x1.5410d3cc0891ep-7, +0x1.264994dfd3409p-3, +0x1.a744ce26f39cp-57, +0x1p0, +-0x1.62aa03dd6ba58p-7, +0x1.2c8106e8e613ap-3, +0x1.13000a89a11ep-58, +0x1p0, +-0x1.71914e17a1bc6p-7, +0x1.32b7bf94516a7p-3, +0x1.2a24e2431ef29p-57, +0x1p0, +-0x1.80c6a94934dfp-7, +0x1.38edbb0cd8d14p-3, +-0x1.198c21fbf7718p-57, +0x1p0, +-0x1.904a0c10875cep-7, +0x1.3f22f57db4893p-3, +0x1.bfe7ff2274956p-59, +0x1p0, +-0x1.a01b6cdbd995ep-7, +0x1.45576b1293e5ap-3, +-0x1.285a24119f7b1p-58, +0x1p0, +-0x1.b03ac1e94fe1dp-7, +0x1.4b8b17f79fa88p-3, +0x1.b534fe588f0dp-57, +0x1p0, +-0x1.c0a80146f894cp-7, +0x1.51bdf8597c5f2p-3, +-0x1.9f9976af04aa5p-61, +0x1p0, +-0x1.d16320d2d221ep-7, +0x1.57f008654cbdep-3, +0x1.908c95c4c9118p-58, +0x1p0, +-0x1.e26c163ad15b3p-7, +0x1.5e214448b3fc6p-3, +0x1.531ff779ddac6p-57, +0x1p0, +-0x1.f3c2d6fce7cfap-7, +0x1.6451a831d830dp-3, +0x1.ad16031a34d5p-58, +0x1p0, +-0x1.02b3ac3385232p-6, +0x1.6a81304f64ab2p-3, +0x1.f0cd73fb5d8d4p-58, +0x1p0, +-0x1.0bacc7cb9babap-6, +0x1.70afd8d08c4ffp-3, +0x1.260c3f1369484p-57, +0x1p0, +-0x1.14ccb8bdbf114p-6, +0x1.76dd9de50bf31p-3, +0x1.1d5eeec501b2fp-57, +0x1p0, +-0x1.1e1379690291cp-6, +0x1.7d0a7bbd2cb1cp-3, +-0x1.cf900f27c58efp-57, +0x1p0, +-0x1.278104148891ap-6, +0x1.83366e89c64c6p-3, +-0x1.192952df10db8p-57, +0x1p0, +-0x1.311552ef8623cp-6, +0x1.8961727c41804p-3, +0x1.3fdab4e42640ap-58, +0x1p0, +-0x1.3ad06011469fbp-6, +0x1.8f8b83c69a60bp-3, +-0x1.26d19b9ff8d82p-57, +0x1p0, +-0x1.44b225792f46bp-6, +0x1.95b49e9b62afap-3, +-0x1.100b3d1dbfeaap-59, +0x1p0, +-0x1.4eba9d0ec2f7cp-6, +0x1.9bdcbf2dc4366p-3, +0x1.9632d189956fep-57, +0x1p0, +-0x1.58e9c0a1a5f21p-6, +0x1.a203e1b1831dap-3, +0x1.c1aadb580a1ecp-58, +0x1p0, +-0x1.633f89e9a1a66p-6, +0x1.a82a025b00451p-3, +-0x1.87905ffd084adp-57, +0x1p0, +-0x1.6dbbf286a8971p-6, +0x1.ae4f1d5f3b9abp-3, +0x1.aa8bbcef9b68ep-57, +0x1p0, +-0x1.785ef400da46cp-6, +0x1.b4732ef3d6722p-3, +0x1.bbe5d5d75cbd8p-57, +0x1p0, +-0x1.832887c88735dp-6, +0x1.ba96334f15dadp-3, +-0x1.75098c05dd18ap-57, +0x1p0, +-0x1.8e18a73634ee7p-6, +0x1.c0b826a7e4f63p-3, +-0x1.af1439e521935p-62, +0x1p0, +-0x1.992f4b8aa21f8p-6, +0x1.c6d90535d74ddp-3, +-0x1.bfb2be2264962p-59, +0x1p0, +-0x1.a46c6deecac5fp-6, +0x1.ccf8cb312b286p-3, +0x1.2382b0aecadf8p-58, +0x1p0, +-0x1.afd00773ec64fp-6, +0x1.d31774d2cbdeep-3, +0x1.2fdc8e5791a0bp-57, +0x1p0, +-0x1.bb5a11138a4c9p-6, +0x1.d934fe5454311p-3, +0x1.75b92277107adp-57, +0x1p0, +-0x1.c70a83af71ef5p-6, +0x1.df5163f01099ap-3, +-0x1.01f7d79906e86p-57, +0x1p0, +-0x1.d2e15811bf462p-6, +0x1.e56ca1e101a1bp-3, +0x1.46ac3f9fd0227p-57, +0x1p0, +-0x1.dede86ece142ep-6, +0x1.eb86b462de348p-3, +-0x1.bfcde46f90b62p-57, +0x1p0, +-0x1.eb0208db9e51bp-6, +0x1.f19f97b215f1bp-3, +-0x1.42deef11da2c4p-57, +0x1p0, +-0x1.f74bd66118e8dp-6, +0x1.f7b7480bd3802p-3, +-0x1.9a96d967ee12ep-57, +0x1p0, +-0x1.01ddf3f46a139p-5, +0x1.fdcdc1adfedf9p-3, +-0x1.2dba4580ed7bbp-57, +0x1p0, +-0x1.08291ae35c407p-5, +0x1.01f1806b9fdd2p-2, +-0x1.448135394b8bap-56, +0x1p0, +-0x1.0e875c1b8c3dap-5, +0x1.04fb80e37fdaep-2, +-0x1.412cdb72583ccp-63, +0x1p0, +-0x1.14f8b3af5abb9p-5, +0x1.0804e05eb661ep-2, +0x1.54e583d92d3d8p-56, +0x1p0, +-0x1.1b7d1da562443p-5, +0x1.0b0d9cfdbdb9p-2, +0x1.3b3a7b8d1200dp-58, +0x1p0, +-0x1.221495f879af5p-5, +0x1.0e15b4e1749cep-2, +-0x1.5b7fb156c550ap-56, +0x1p0, +-0x1.28bf1897b69ccp-5, +0x1.111d262b1f677p-2, +0x1.824c20ab7aa9ap-56, +0x1p0, +-0x1.2f7ca1666ff6fp-5, +0x1.1423eefc69378p-2, +0x1.22d3368ec9b62p-56, +0x1p0, +-0x1.364d2c3c407bep-5, +0x1.172a0d7765177p-2, +0x1.22575f33366bep-57, +0x1p0, +-0x1.3d30b4e5094ep-5, +0x1.1a2f7fbe8f243p-2, +0x1.6465ac86ba7b2p-56, +0x1p0, +-0x1.44273720f48bcp-5, +0x1.1d3443f4cdb3ep-2, +-0x1.720d41c13519ep-57, +0x1p0, +-0x1.4b30aea477eeep-5, +0x1.2038583d727bep-2, +-0x1.c69cd46300a3p-57, +0x1p0, +-0x1.524d171857726p-5, +0x1.233bbabc3bb71p-2, +0x1.99b04e23259efp-56, +0x1p0, +-0x1.597c6c19a8003p-5, +0x1.263e6995554bap-2, +0x1.1d350ffc5ff32p-56, +0x1p0, +-0x1.60bea939d225ap-5, +0x1.294062ed59f06p-2, +-0x1.5d28da2c4612dp-56, +0x1p0, +-0x1.6813c9fe94cfbp-5, +0x1.2c41a4e95452p-2, +0x1.9cf0354aad2dcp-56, +0x1p0, +-0x1.6f7bc9e2080d9p-5, +0x1.2f422daec0387p-2, +-0x1.7501ba473da6fp-56, +0x1p0, +-0x1.76f6a4529fdb5p-5, +0x1.3241fb638baafp-2, +0x1.ecee8f76f8c51p-60, +0x1p0, +-0x1.7e8454b32ef34p-5, +0x1.35410c2e18152p-2, +-0x1.3cb002f96e062p-56, +0x1p0, +-0x1.8624d65ae9a63p-5, +0x1.383f5e353b6abp-2, +-0x1.a812a4a5c3d44p-56, +0x1p0, +-0x1.8dd8249568bbbp-5, +0x1.3b3cefa0414b7p-2, +0x1.f36dc4a9c2294p-56, +0x1p0, +-0x1.959e3aa2ac58dp-5, +0x1.3e39be96ec271p-2, +0x1.814c6de9aaaf6p-56, +0x1p0, +-0x1.9d7713b71eee1p-5, +0x1.4135c94176601p-2, +0x1.0c97c4afa2518p-56, +0x1p0, +-0x1.a562aafb982cdp-5, +0x1.44310dc8936fp-2, +0x1.8b694e91d3125p-56, +0x1p0, +-0x1.ad60fb8d6003ap-5, +0x1.472b8a5571054p-2, +-0x1.01ea0fe4dff23p-56, +0x1p0, +-0x1.b572007e31a1bp-5, +0x1.4a253d11b82f3p-2, +-0x1.2afa4d6d42a55p-58, +0x1p0, +-0x1.bd95b4d43e819p-5, +0x1.4d1e24278e76ap-2, +0x1.2417218792858p-57, +0x1p0, +-0x1.c5cc138a317afp-5, +0x1.50163dc197048p-2, +-0x1.ec66cb05c7ea4p-56, +0x1p0, +-0x1.ce15178f31db3p-5, +0x1.530d880af3c24p-2, +-0x1.fab8e2103fbd6p-56, +0x1p0, +-0x1.d670bbc6e685ep-5, +0x1.5604012f467b4p-2, +0x1.a0e0b2a5b25p-56, +0x1p0, +-0x1.dedefb09791b4p-5, +0x1.58f9a75ab1fddp-2, +-0x1.efdc0d58cf62p-62, +0x1p0, +-0x1.e75fd0239926cp-5, +0x1.5bee78b9db3b6p-2, +0x1.e734a63158dfdp-58, +0x1p0, +-0x1.eff335d67f541p-5, +0x1.5ee27379ea693p-2, +0x1.634ff2fa75245p-56, +0x1p0, +-0x1.f89926d7f0ab8p-5, +0x1.61d595c88c202p-2, +0x1.f6b1e333415d7p-56, +0x1p0, +-0x1.00a8cee920eabp-4, +0x1.64c7ddd3f27c6p-2, +0x1.10d2b4a664121p-58, +0x1p0, +-0x1.050e4ab22d321p-4, +0x1.67b949cad63cbp-2, +-0x1.a23369348d7efp-56, +0x1p0, +-0x1.097d0410dc132p-4, +0x1.6aa9d7dc77e17p-2, +-0x1.38b470592c7b3p-56, +0x1p0, +-0x1.0df4f849393f5p-4, +0x1.6d998638a0cb6p-2, +-0x1.1ca14532860dfp-61, +0x1p0, +-0x1.127624999ee1dp-4, +0x1.7088530fa459fp-2, +-0x1.44b19e0864c5dp-56, +0x1p0, +-0x1.1700863ab7533p-4, +0x1.73763c9261092p-2, +-0x1.52324face3b1ap-57, +0x1p0, +-0x1.1b941a5f7ecffp-4, +0x1.766340f2418f6p-2, +0x1.2b2adc9041b2cp-56, +0x1p0, +-0x1.2030de354532cp-4, +0x1.794f5e613dfaep-2, +0x1.820a4b0d21fc5p-57, +0x1p0, +-0x1.24d6cee3afb2ap-4, +0x1.7c3a9311dcce7p-2, +0x1.9a3f21ef3e8d9p-62, +0x1p0, +-0x1.2985e98cbaa3ap-4, +0x1.7f24dd37341e4p-2, +0x1.2791a1b5eb796p-57, +0x1p0, +-0x1.2e3e2b4cbb3c3p-4, +0x1.820e3b04eaac4p-2, +-0x1.92379eb01c6b6p-59, +0x1p0, +-0x1.32ff913a615dp-4, +0x1.84f6aaaf3903fp-2, +0x1.6dcdc2bd47067p-57, +0x1p0, +-0x1.37ca1866b95cfp-4, +0x1.87de2a6aea963p-2, +-0x1.72cedd3d5a61p-57, +0x1p0, +-0x1.3c9dbddd2dd84p-4, +0x1.8ac4b86d5ed44p-2, +0x1.17fa7f944ad5bp-56, +0x1p0, +-0x1.417a7ea389835p-4, +0x1.8daa52ec8a4bp-2, +-0x1.72eb2db8c621ep-57, +0x1p0, +-0x1.466057b9f900ap-4, +0x1.908ef81ef7bd1p-2, +0x1.4c00267012357p-56, +0x1p0, +-0x1.4b4f461b0cbaap-4, +0x1.9372a63bc93d7p-2, +0x1.684319e5ad5b1p-57, +0x1p0, +-0x1.504746bbbac0bp-4, +0x1.96555b7ab948fp-2, +0x1.7afd51eff33adp-56, +0x1p0, +-0x1.5548568b60a7bp-4, +0x1.993716141bdffp-2, +-0x1.15e8cce261c55p-56, +0x1p0, +-0x1.5a527273c56e1p-4, +0x1.9c17d440df9f2p-2, +0x1.923c540a9eec4p-57, +0x1p0, +-0x1.5f6597591b633p-4, +0x1.9ef7943a8ed8ap-2, +0x1.6da81290bdbabp-57, +0x1p0, +-0x1.6481c21a02123p-4, +0x1.a1d6543b50acp-2, +-0x1.0246cfd8779fbp-57, +0x1p0, +-0x1.69a6ef8f8830ap-4, +0x1.a4b4127dea1e5p-2, +-0x1.bec6f01bc22f1p-56, +0x1p0, +-0x1.6ed51c8d2d8fcp-4, +0x1.a790cd3dbf31bp-2, +-0x1.7f786986d9023p-57, +0x1p0, +-0x1.740c45e0e512p-4, +0x1.aa6c82b6d3fcap-2, +-0x1.d5f106ee5ccf7p-56, +0x1p0, +-0x1.794c685316a3cp-4, +0x1.ad473125cdc09p-2, +-0x1.379ede57649dap-58, +0x1p0, +-0x1.7e9580a6a136ep-4, +0x1.b020d6c7f4009p-2, +0x1.414ae7e555208p-58, +0x1p0, +-0x1.83e78b98dcc2bp-4, +0x1.b2f971db31972p-2, +0x1.fa971a4a41f2p-56, +0x1p0, +-0x1.894285e19c468p-4, +0x1.b5d1009e15ccp-2, +0x1.5b362cb974183p-57, +0x1p0, +-0x1.8ea66c332fd01p-4, +0x1.b8a7814fd5693p-2, +0x1.9a9e6651cc119p-56, +0x1p0, +-0x1.94133b3a66851p-4, +0x1.bb7cf2304bd01p-2, +0x1.9e1a5bd9269d4p-57, +0x1p0, +-0x1.9988ef9e90b04p-4, +0x1.be51517ffc0d9p-2, +0x1.2b667131a5f16p-56, +0x1p0, +-0x1.9f07860181d1ep-4, +0x1.c1249d8011ee7p-2, +-0x1.813aabb515206p-56, +0x1p0, +-0x1.a48efaff92b3bp-4, +0x1.c3f6d47263129p-2, +0x1.9c7bd0fcdecddp-56, +0x1p0, +-0x1.aa1f4b2fa37fcp-4, +0x1.c6c7f4997000bp-2, +-0x1.bec2669c68e74p-56, +0x1p0, +-0x1.afb873231ddb9p-4, +0x1.c997fc3865389p-2, +-0x1.6295f8b0ca33bp-56, +0x1p0, +-0x1.b55a6f65f7058p-4, +0x1.cc66e9931c45ep-2, +0x1.6850e59c37f8fp-58, +0x1p0, +-0x1.bb053c7eb1f68p-4, +0x1.cf34baee1cd21p-2, +-0x1.118724d19d014p-56, +0x1p0, +-0x1.c0b8d6ee61867p-4, +0x1.d2016e8e9db5bp-2, +-0x1.c8bce9d93efb8p-57, +0x1p0, +-0x1.c6753b30aa949p-4, +0x1.d4cd02ba8609dp-2, +-0x1.37f33c63033d6p-57, +0x1p0, +-0x1.cc3a65bbc6327p-4, +0x1.d79775b86e389p-2, +0x1.550ec87bc0575p-56, +0x1p0, +-0x1.d208530083d3p-4, +0x1.da60c5cfa10d9p-2, +-0x1.0f38e2143c8d5p-57, +0x1p0, +-0x1.d7deff6a4b7c9p-4, +0x1.dd28f1481cc58p-2, +-0x1.e7576fa6c944ep-59, +0x1p0, +-0x1.ddbe675f1ffdfp-4, +0x1.dfeff66a941dep-2, +-0x1.a756c6e625f96p-56, +0x1p0, +-0x1.e3a6873fa1279p-4, +0x1.e2b5d3806f63bp-2, +0x1.e0d891d3c6841p-58, +0x1p0, +-0x1.e9975b670e077p-4, +0x1.e57a86d3cd825p-2, +-0x1.2c80dcd511e87p-57, +0x1p0, +-0x1.ef90e02b47283p-4, +0x1.e83e0eaf85114p-2, +-0x1.7bc380ef24ba7p-57, +0x1p0, +-0x1.f59311dcd0d44p-4, +0x1.eb00695f2562p-2, +0x1.53c9fd3083e22p-56, +0x1p0, +-0x1.fb9decc6d55b8p-4, +0x1.edc1952ef78d6p-2, +-0x1.dd0f7c33edee6p-56, +0x1p0, +-0x1.00d8b69793ae4p-3, +0x1.f081906bff7fep-2, +-0x1.4cab2d4ff6fccp-56, +0x1p0, +-0x1.03e6c7ab2208cp-3, +0x1.f3405963fd067p-2, +0x1.06846d44a238fp-56, +0x1p0, +-0x1.06f927bbaacfep-3, +0x1.f5fdee656cda3p-2, +-0x1.7bf9780816b05p-58, +0x1p0, +-0x1.0a0fd4e41ab5ap-3, +0x1.f8ba4dbf89abap-2, +-0x1.2ec1fc1b776b8p-60, +0x1p0, +-0x1.0d2acd3cb7364p-3, +0x1.fb7575c24d2dep-2, +-0x1.5bfdc883c8664p-57, +0x1p0, +-0x1.104a0edb1fc58p-3, +0x1.fe2f64be7121p-2, +-0x1.297ab1ca2d7dbp-56, +0x1p0, +-0x1.136d97d24efccp-3, +0x1.00740c82b82e1p-1, +-0x1.6d48563c60e87p-55, +0x1p0, +-0x1.169566329bcb7p-3, +0x1.01cfc874c3eb7p-1, +-0x1.34a35e7c2368cp-56, +0x1p0, +-0x1.19c17809baa87p-3, +0x1.032ae55edbd96p-1, +-0x1.bdb022b40107ap-55, +0x1p0, +-0x1.1cf1cb62bec5dp-3, +0x1.0485626ae221ap-1, +0x1.b937d9091ff7p-55, +0x1p0, +-0x1.20265e461b45ap-3, +0x1.05df3ec31b8b7p-1, +-0x1.e2dcad34d9c1dp-57, +0x1p0, +-0x1.235f2eb9a470ap-3, +0x1.073879922ffeep-1, +-0x1.a5a014347406cp-55, +0x1p0, +-0x1.269c3ac090ee4p-3, +0x1.089112032b08cp-1, +0x1.3248ddf9fe619p-57, +0x1p0, +-0x1.29dd805b7afecp-3, +0x1.09e907417c5e1p-1, +-0x1.fe573741a9bd4p-55, +0x1p0, +-0x1.2d22fd8861b6bp-3, +0x1.0b405878f85ecp-1, +-0x1.ad66c3bb80da5p-55, +0x1p0, +-0x1.306cb042aa3bap-3, +0x1.0c9704d5d898fp-1, +-0x1.8d3d7de6ee9b2p-55, +0x1p0, +-0x1.33ba968321032p-3, +0x1.0ded0b84bc4b6p-1, +-0x1.8540fa327c55cp-55, +0x1p0, +-0x1.370cae3ffb12fp-3, +0x1.0f426bb2a8e7ep-1, +-0x1.bb58fb774f8eep-55, +0x1p0, +-0x1.3a62f56cd742ep-3, +0x1.1097248d0a957p-1, +-0x1.7a58759ba80ddp-55, +0x1p0, +-0x1.3dbd69fabf802p-3, +0x1.11eb3541b4b23p-1, +-0x1.ef23b69abe4f1p-55, +0x1p0, +-0x1.411c09d82a128p-3, +0x1.133e9cfee254fp-1, +-0x1.a1377cfd5ce5p-56, +0x1p0, +-0x1.447ed2f0fae31p-3, +0x1.14915af336cebp-1, +0x1.f3660558a0213p-56, +0x1p0, +-0x1.47e5c32e84c45p-3, +0x1.15e36e4dbe2bcp-1, +0x1.3c545f7d79eaep-56, +0x1p0, +-0x1.4b50d8778abbdp-3, +0x1.1734d63dedb49p-1, +-0x1.7eef2ccc50575p-55, +0x1p0, +-0x1.4ec010b0414e1p-3, +0x1.188591f3a46e5p-1, +-0x1.bbefe5a524346p-56, +0x1p0, +-0x1.523369ba4fcaep-3, +0x1.19d5a09f2b9b8p-1, +-0x1.33656c68a1d4ap-57, +0x1p0, +-0x1.55aae174d19c8p-3, +0x1.1b250171373bfp-1, +-0x1.b210e95e1ca4cp-55, +0x1p0, +-0x1.592675bc57974p-3, +0x1.1c73b39ae68c8p-1, +0x1.b25dd267f66p-55, +0x1p0, +-0x1.5ca6246ae94b8p-3, +0x1.1dc1b64dc4872p-1, +0x1.f15e1c468be78p-57, +0x1p0, +-0x1.6029eb580658ep-3, +0x1.1f0f08bbc861bp-1, +-0x1.10d9dcafb74cbp-57, +0x1p0, +-0x1.63b1c858a7c2ep-3, +0x1.205baa17560d6p-1, +0x1.b7b144016c7a3p-56, +0x1p0, +-0x1.673db93f41479p-3, +0x1.21a799933eb59p-1, +-0x1.3a7b177c68fb2p-55, +0x1p0, +-0x1.6acdbbdbc2b73p-3, +0x1.22f2d662c13e2p-1, +-0x1.d5cc7580cb6d2p-55, +0x1p0, +-0x1.6e61cdfb994dfp-3, +0x1.243d5fb98ac1fp-1, +0x1.c533d0a284a8dp-56, +0x1p0, +-0x1.71f9ed69b10eap-3, +0x1.258734cbb711p-1, +0x1.3a3f0903ce09dp-57, +0x1p0, +-0x1.759617ee761f9p-3, +0x1.26d054cdd12dfp-1, +-0x1.5da743ef3770cp-55, +0x1p0, +-0x1.79364b4fd6288p-3, +0x1.2818bef4d3cbap-1, +-0x1.e3fffeb76568ap-56, +0x1p0, +-0x1.7cda855141b26p-3, +0x1.2960727629ca8p-1, +0x1.56d6c7af02d5cp-56, +0x1p0, +-0x1.8082c3b3ad887p-3, +0x1.2aa76e87aeb58p-1, +0x1.fd600833287a7p-59, +0x1p0, +-0x1.842f0435941afp-3, +0x1.2bedb25faf3eap-1, +-0x1.14981c796ee46p-58, +0x1p0, +-0x1.87df4492f6e38p-3, +0x1.2d333d34e9bb8p-1, +-0x1.0e2c2c5549e26p-55, +0x1p0, +-0x1.8b9382855fcaap-3, +0x1.2e780e3e8ea17p-1, +-0x1.b19fafe36587ap-55, +0x1p0, +-0x1.8f4bbbc3e28f6p-3, +0x1.2fbc24b441015p-1, +0x1.dba4875410874p-57, +0x1p0, +-0x1.9307ee031e2fdp-3, +0x1.30ff7fce17035p-1, +-0x1.efcc626f74a6fp-57, +0x1p0, +-0x1.96c816f53e539p-3, +0x1.32421ec49a61fp-1, +0x1.65e25cc951bfep-55, +0x1p0, +-0x1.9a8c3449fcb77p-3, +0x1.338400d0c8e57p-1, +-0x1.abf2a5e95e6e5p-55, +0x1p0, +-0x1.9e5443aea29b2p-3, +0x1.34c5252c14de1p-1, +0x1.583f49632ab2bp-55, +0x1p0, +-0x1.a22042ce0a2f9p-3, +0x1.36058b10659f3p-1, +-0x1.1fcb3a35857e7p-55, +0x1p0, +-0x1.a5f02f50a007cp-3, +0x1.374531b817f8dp-1, +0x1.444d2b0a747fep-55, +0x1p0, +-0x1.a9c406dc648a5p-3, +0x1.3884185dfeb22p-1, +-0x1.a038026abe6b2p-56, +0x1p0, +-0x1.ad9bc714ed64fp-3, +0x1.39c23e3d63029p-1, +-0x1.3b05b276085c1p-58, +0x1p0, +-0x1.b1776d9b67013p-3, +0x1.3affa292050b9p-1, +0x1.e3e25e3954964p-56, +0x1p0, +-0x1.b556f80e95facp-3, +0x1.3c3c44981c518p-1, +-0x1.b5e9a9644151bp-55, +0x1p0, +-0x1.b93a640ad8978p-3, +0x1.3d78238c58344p-1, +-0x1.0219f5f0f79cep-55, +0x1p0, +-0x1.bd21af2a28408p-3, +0x1.3eb33eabe068p-1, +0x1.86a2357d1a0d3p-58, +0x1p0, +-0x1.c10cd7041afccp-3, +0x1.3fed9534556d4p-1, +0x1.36916608c5061p-55, +0x1p0, +-0x1.c4fbd92de4eddp-3, +0x1.41272663d108cp-1, +0x1.1bbe7636fadf5p-55, +0x1p0, +-0x1.c8eeb33a59cdp-3, +0x1.425ff178e6bb1p-1, +0x1.7b38d675140cap-55, +0x1p0, +-0x1.cce562b9ee6aep-3, +0x1.4397f5b2a438p-1, +-0x1.7274c9e48c226p-55, +0x1p0, +-0x1.d0dfe53aba2fdp-3, +0x1.44cf325091dd6p-1, +0x1.8076a2cfdc6b3p-57, +0x1p0, +-0x1.d4de3848789e2p-3, +0x1.4605a692b32a2p-1, +0x1.21ca219b97107p-55, +0x1p0, +-0x1.d8e0596c8ad56p-3, +0x1.473b51b987347p-1, +0x1.ca1953514e41bp-57, +0x1p0, +-0x1.dce6462df917dp-3, +0x1.48703306091ffp-1, +-0x1.70813b86159fdp-57, +0x1p0, +-0x1.e0effc1174505p-3, +0x1.49a449b9b0939p-1, +-0x1.27ee16d719b94p-55, +0x1p0, +-0x1.e4fd7899579acp-3, +0x1.4ad79516722f1p-1, +-0x1.1273b163000f7p-55, +0x1p0, +-0x1.e90eb945a9ccfp-3, +0x1.4c0a145ec0004p-1, +0x1.2630cfafceaa1p-58, +0x1p0, +-0x1.ed23bb941f019p-3, +0x1.4d3bc6d589f7fp-1, +0x1.6e4d9d6b72011p-55, +0x1p0, +-0x1.f13c7d001a249p-3, +0x1.4e6cabbe3e5e9p-1, +0x1.3c293edceb327p-57, +0x1p0, +-0x1.f558fb02ae805p-3, +0x1.4f9cc25cca486p-1, +0x1.48b5951cfc2b5p-55, +0x1p0, +-0x1.f9793312a14d1p-3, +0x1.50cc09f59a09bp-1, +0x1.693463a2c2e6fp-56, +0x1p0, +-0x1.fd9d22a46b416p-3, +0x1.51fa81cd99aa6p-1, +-0x1.499f59d8560e9p-63, +0x1p0, +-0x1.00e263951d11fp-2, +0x1.5328292a35596p-1, +-0x1.a12eb89da0257p-56, +0x1p0, +-0x1.02f80f09f92f4p-2, +0x1.5454ff5159dfcp-1, +-0x1.4e247588bf256p-55, +0x1p0, +-0x1.050f92679849cp-2, +0x1.5581038975137p-1, +0x1.4570d9efe26dfp-55, +0x1p0, +-0x1.0728ec63a599ap-2, +0x1.56ac35197649fp-1, +-0x1.f7874188cb279p-55, +0x1p0, +-0x1.09441bb2aa0a2p-2, +0x1.57d69348cecap-1, +-0x1.75720992bfbb2p-55, +0x1p0, +-0x1.0b611f080d05bp-2, +0x1.59001d5f723dfp-1, +0x1.a9f86ba0dde98p-56, +0x1p0, +-0x1.0d7ff51615437p-2, +0x1.5a28d2a5d725p-1, +0x1.57a25f8b1343p-55, +0x1p0, +-0x1.0fa09c8de994bp-2, +0x1.5b50b264f7448p-1, +0x1.519d30d4cfebp-56, +0x1p0, +-0x1.11c3141f91b3ep-2, +0x1.5c77bbe65018cp-1, +0x1.069ea9c0bc32ap-55, +0x1p0, +-0x1.13e75a79f7139p-2, +0x1.5d9dee73e345cp-1, +-0x1.de1165ecdf7a3p-57, +0x1p0, +-0x1.160d6e4ae5ae6p-2, +0x1.5ec3495837074p-1, +0x1.dea89a9b8f727p-56, +0x1p0, +-0x1.18354e3f0cd7dp-2, +0x1.5fe7cbde56a1p-1, +-0x1.fcb9cc30cc01ep-55, +0x1p0, +-0x1.1a5ef902000d3p-2, +0x1.610b7551d2cdfp-1, +-0x1.251b352ff2a37p-56, +0x1p0, +-0x1.1c8a6d3e37c82p-2, +0x1.622e44fec22ffp-1, +0x1.f98d8be132d57p-56, +0x1p0, +-0x1.1eb7a99d1250cp-2, +0x1.63503a31c1be9p-1, +0x1.1248f09e6587cp-57, +0x1p0, +-0x1.20e6acc6d4916p-2, +0x1.64715437f535bp-1, +-0x1.7c399c15a17dp-55, +0x1p0, +-0x1.23177562aaea3p-2, +0x1.6591925f0783dp-1, +0x1.c3d64fbf5de23p-55, +0x1p0, +-0x1.254a0216aa067p-2, +0x1.66b0f3f52b386p-1, +0x1.1e2eb31a8848bp-55, +0x1p0, +-0x1.277e5187cfb16p-2, +0x1.67cf78491af1p-1, +0x1.750ab23477b61p-59, +0x1p0, +-0x1.29b4625a03ac9p-2, +0x1.68ed1eaa19c71p-1, +0x1.fd4a85350f69p-56, +0x1p0, +0, +0x1.6a09e667f3bcdp-1, +-0x1.bdd3413b26456p-55, +0, +0x1.a3b47aa8671c5p-3, +0x1.6b25ced2fe29cp-1, +-0x1.5ac64116beda5p-55, +0x1p-1, +0x1.9f3de1246bc4p-3, +0x1.6c40d73c18275p-1, +0x1.25d4f802be257p-57, +0x1p-1, +0x1.9ac3cfd4ace19p-3, +0x1.6d5afef4aafcdp-1, +-0x1.868a696b8835ep-55, +0x1p-1, +0x1.9646497c1e0f6p-3, +0x1.6e74454eaa8afp-1, +-0x1.dbc03c84e226ep-55, +0x1p-1, +0x1.91c550dfd4d6bp-3, +0x1.6f8ca99c95b75p-1, +0x1.f22e7a35723f4p-56, +0x1p-1, +0x1.8d40e8c706fa4p-3, +0x1.70a42b3176d7ap-1, +-0x1.d9e3fbe2e15ap-56, +0x1p-1, +0x1.88b913fb08bfdp-3, +0x1.71bac960e41bfp-1, +-0x1.b858d90b0f7d8p-56, +0x1p-1, +0x1.842dd5474b37bp-3, +0x1.72d0837efff96p-1, +0x1.0d4ef0f1d915cp-55, +0x1p-1, +0x1.7f9f2f795a83ep-3, +0x1.73e558e079942p-1, +-0x1.2663126697f5ep-55, +0x1p-1, +0x1.7b0d2560dc1d1p-3, +0x1.74f948da8d28dp-1, +0x1.19900a3b9a3a2p-63, +0x1p-1, +0x1.7677b9cf8d17p-3, +0x1.760c52c304764p-1, +-0x1.11d76f8e50f1fp-55, +0x1p-1, +0x1.71deef9940631p-3, +0x1.771e75f037261p-1, +0x1.5cfce8d84068fp-56, +0x1p-1, +0x1.6d42c993dd121p-3, +0x1.782fb1b90b35bp-1, +-0x1.3e46c1dfd001cp-55, +0x1p-1, +0x1.68a34a975c941p-3, +0x1.79400574f55e5p-1, +-0x1.0adadbdb4c65ap-55, +0x1p-1, +0x1.6400757dc8f7dp-3, +0x1.7a4f707bf97d2p-1, +0x1.3c9751b491eafp-55, +0x1p-1, +0x1.5f5a4d233b27fp-3, +0x1.7b5df226aafafp-1, +-0x1.0f537acdf0ad7p-56, +0x1p-1, +0x1.5ab0d465d927ap-3, +0x1.7c6b89ce2d333p-1, +-0x1.cfd628084982cp-56, +0x1p-1, +0x1.56040e25d44ddp-3, +0x1.7d7836cc33db2p-1, +0x1.162715ef03f85p-56, +0x1p-1, +0x1.5153fd45677efp-3, +0x1.7e83f87b03686p-1, +0x1.b61a8ccabad6p-57, +0x1p-1, +0x1.4ca0a4a8d5657p-3, +0x1.7f8ece3571771p-1, +-0x1.9c8d8ce93c917p-55, +0x1p-1, +0x1.47ea073666a98p-3, +0x1.8098b756e52fap-1, +0x1.9136e834b4707p-55, +0x1p-1, +0x1.433027d66826dp-3, +0x1.81a1b33b57accp-1, +-0x1.5dea12d66bb66p-55, +0x1p-1, +0x1.3e73097329219p-3, +0x1.82a9c13f545ffp-1, +-0x1.65e87a7a8cde9p-56, +0x1p-1, +0x1.39b2aef8f97a4p-3, +0x1.83b0e0bff976ep-1, +-0x1.6f420f8ea3475p-56, +0x1p-1, +0x1.34ef1b5627dfdp-3, +0x1.84b7111af83fap-1, +-0x1.63a47df0b21bap-55, +0x1p-1, +0x1.3028517b0001p-3, +0x1.85bc51ae958ccp-1, +0x1.45ba6478086ccp-55, +0x1p-1, +0x1.2b5e5459c8bc3p-3, +0x1.86c0a1d9aa195p-1, +0x1.84564f09c3726p-59, +0x1p-1, +0x1.269126e6c24e3p-3, +0x1.87c400fba2ebfp-1, +-0x1.2dabc0c3f64cdp-55, +0x1p-1, +0x1.21c0cc18247fcp-3, +0x1.88c66e7481ba1p-1, +-0x1.5c6228970cf35p-56, +0x1p-1, +0x1.1ced46e61cd1cp-3, +0x1.89c7e9a4dd4aap-1, +0x1.db6ea04a8678fp-55, +0x1p-1, +0x1.18169a4acca89p-3, +0x1.8ac871ede1d88p-1, +-0x1.9afaa5b7cfc55p-55, +0x1p-1, +0x1.133cc94247758p-3, +0x1.8bc806b151741p-1, +-0x1.2c5e12ed1336dp-55, +0x1p-1, +0x1.0e5fd6ca90dffp-3, +0x1.8cc6a75184655p-1, +-0x1.e18b3657e2285p-55, +0x1p-1, +0x1.097fc5e39aec5p-3, +0x1.8dc45331698ccp-1, +0x1.1d9fcd83634d7p-57, +0x1p-1, +0x1.049c998f44231p-3, +0x1.8ec109b486c49p-1, +-0x1.cb2a3eb6af617p-56, +0x1p-1, +0x1.ff6ca9a2ab6a2p-4, +0x1.8fbcca3ef940dp-1, +-0x1.6dfa99c86f2f1p-57, +0x1p-1, +0x1.f599f55f034p-4, +0x1.90b7943575efep-1, +0x1.4ecb0c5273706p-57, +0x1p-1, +0x1.ebc11c62c1a1ep-4, +0x1.91b166fd49da2p-1, +-0x1.3be953a7fe996p-57, +0x1p-1, +0x1.e1e224c0e28bdp-4, +0x1.92aa41fc5a815p-1, +-0x1.68f89e2d23db7p-57, +0x1p-1, +0x1.d7fd1490285cap-4, +0x1.93a22499263fbp-1, +0x1.3d419a920df0bp-55, +0x1p-1, +0x1.ce11f1eb18148p-4, +0x1.94990e3ac4a6cp-1, +0x1.a95328edeb3e6p-56, +0x1p-1, +0x1.c420c2eff590ep-4, +0x1.958efe48e6dd7p-1, +-0x1.561335da0f4e7p-55, +0x1p-1, +0x1.ba298dc0bfc6bp-4, +0x1.9683f42bd7fe1p-1, +-0x1.11bad933c835ep-57, +0x1p-1, +0x1.b02c58832cf96p-4, +0x1.9777ef4c7d742p-1, +-0x1.15479a240665ep-55, +0x1p-1, +0x1.a6292960a6f0bp-4, +0x1.986aef1457594p-1, +-0x1.af03e318f38fcp-55, +0x1p-1, +0x1.9c200686472b5p-4, +0x1.995cf2ed80d22p-1, +0x1.7783e907fbd7bp-56, +0x1p-1, +0x1.9210f624d30fbp-4, +0x1.9a4dfa42b06b2p-1, +-0x1.829b6b8b1c947p-56, +0x1p-1, +0x1.87fbfe70b81a7p-4, +0x1.9b3e047f38741p-1, +-0x1.30ee286712474p-55, +0x1p-1, +0x1.7de125a2080a9p-4, +0x1.9c2d110f075c2p-1, +0x1.d9c9f1c8c30dp-55, +0x1p-1, +0x1.73c071f4750b5p-4, +0x1.9d1b1f5ea80d5p-1, +0x1.c5fadd5ffb36fp-55, +0x1p-1, +0x1.6999e9a74ddbep-4, +0x1.9e082edb42472p-1, +0x1.5809a4e121e22p-57, +0x1p-1, +0x1.5f6d92fd79f5p-4, +0x1.9ef43ef29af94p-1, +0x1.b1dfcb60445c2p-56, +0x1p-1, +0x1.553b743d75acp-4, +0x1.9fdf4f13149dep-1, +0x1.1e6d79006ec09p-55, +0x1p-1, +0x1.4b0393b14e541p-4, +0x1.a0c95eabaf937p-1, +-0x1.e0ca3acbd049ap-55, +0x1p-1, +0x1.40c5f7a69e5cep-4, +0x1.a1b26d2c0a75ep-1, +0x1.30ef431d627a6p-57, +0x1p-1, +0x1.3682a66e896f5p-4, +0x1.a29a7a0462782p-1, +-0x1.128bb015df175p-56, +0x1p-1, +0x1.2c39a65db8881p-4, +0x1.a38184a593bc6p-1, +-0x1.bc92c5bd2d288p-55, +0x1p-1, +0x1.21eafdcc560fap-4, +0x1.a4678c8119ac8p-1, +0x1.1b4c0dd3f212ap-55, +0x1p-1, +0x1.1796b31609f0cp-4, +0x1.a54c91090f523p-1, +0x1.184300fd1c1cep-56, +0x1p-1, +0x1.0d3ccc99f5ac6p-4, +0x1.a63091b02fae2p-1, +-0x1.e911152248d1p-56, +0x1p-1, +0x1.02dd50bab06b2p-4, +0x1.a7138de9d60f5p-1, +-0x1.f1ab82a9c5f2dp-55, +0x1p-1, +0x1.f0f08bbc861afp-5, +0x1.a7f58529fe69dp-1, +-0x1.97a441584a179p-55, +0x1p-1, +0x1.dc1b64dc48722p-5, +0x1.a8d676e545ad2p-1, +-0x1.b11dcce2e74bdp-59, +0x1p-1, +0x1.c73b39ae68c87p-5, +0x1.a9b66290ea1a3p-1, +0x1.9f630e8b6dac8p-60, +0x1p-1, +0x1.b250171373be9p-5, +0x1.aa9547a2cb98ep-1, +0x1.87d00ae97abaap-60, +0x1p-1, +0x1.9d5a09f2b9b7fp-5, +0x1.ab7325916c0d4p-1, +0x1.a8b8c85baaa9bp-55, +0x1p-1, +0x1.88591f3a46e4dp-5, +0x1.ac4ffbd3efac8p-1, +-0x1.818504103fa16p-56, +0x1p-1, +0x1.734d63dedb48ap-5, +0x1.ad2bc9e21d511p-1, +-0x1.47fbe07bea548p-55, +0x1p-1, +0x1.5e36e4dbe2bc2p-5, +0x1.ae068f345ecefp-1, +-0x1.33934c4029a4cp-56, +0x1p-1, +0x1.4915af336ceb4p-5, +0x1.aee04b43c1474p-1, +-0x1.3a79a438bf8ccp-55, +0x1p-1, +0x1.33e9cfee254edp-5, +0x1.afb8fd89f57b6p-1, +0x1.1ced12d2899b8p-60, +0x1p-1, +0x1.1eb3541b4b228p-5, +0x1.b090a581502p-1, +-0x1.926da300ffccep-55, +0x1p-1, +0x1.097248d0a956ap-5, +0x1.b16742a4ca2f5p-1, +-0x1.ba70972b80438p-55, +0x1p-1, +0x1.e84d76551cfb2p-6, +0x1.b23cd470013b4p-1, +0x1.5a1bb35ad6d2ep-56, +0x1p-1, +0x1.bda17097896b4p-6, +0x1.b3115a5f37bf3p-1, +0x1.dde2726e34fe1p-55, +0x1p-1, +0x1.92e09abb131d4p-6, +0x1.b3e4d3ef55712p-1, +-0x1.eb6b8bf11a493p-55, +0x1p-1, +0x1.680b0f1f0bd73p-6, +0x1.b4b7409de7925p-1, +0x1.f4e257bde73d8p-56, +0x1p-1, +0x1.3d20e82f8bc1p-6, +0x1.b5889fe921405p-1, +-0x1.df49b307c8602p-57, +0x1p-1, +0x1.1222406561182p-6, +0x1.b658f14fdbc47p-1, +0x1.52b5308f397dep-57, +0x1p-1, +0x1.ce1e648bffb66p-7, +0x1.b728345196e3ep-1, +-0x1.bc69f324e6d61p-55, +0x1p-1, +0x1.77cfb0c6e2db8p-7, +0x1.b7f6686e792e9p-1, +0x1.87665bfea06aap-55, +0x1p-1, +0x1.21589ab88869cp-7, +0x1.b8c38d27504e9p-1, +-0x1.1529abff40e45p-55, +0x1p-1, +0x1.9572af6decac8p-8, +0x1.b98fa1fd9155ep-1, +0x1.5559034fe85a4p-55, +0x1p-1, +0x1.cfc874c3eb6d9p-9, +0x1.ba5aa673590d2p-1, +0x1.7ea4e370753b6p-55, +0x1p-1, +0x1.d0320ae0b8293p-11, +0x1.bb249a0b6c40dp-1, +-0x1.d6318ee919f7ap-58, +0x1p-1, +-0x1.d09b418edf04ap-10, +0x1.bbed7c49380eap-1, +0x1.beacbd88500b4p-59, +0x1p-1, +-0x1.22a28f6cb488bp-8, +0x1.bcb54cb0d2327p-1, +0x1.410923c55523ep-62, +0x1p-1, +-0x1.d16c901d95181p-8, +0x1.bd7c0ac6f952ap-1, +-0x1.825a732ac700ap-55, +0x1p-1, +-0x1.4042335264ba3p-7, +0x1.be41b611154c1p-1, +-0x1.fdcdad3a6877ep-55, +0x1p-1, +-0x1.97f4d3805f318p-7, +0x1.bf064e15377ddp-1, +0x1.2156026a1e028p-57, +0x1p-1, +-0x1.efcdf2801004ap-7, +0x1.bfc9d25a1b147p-1, +-0x1.51bf4ee01357p-61, +0x1p-1, +-0x1.23e6ad10872a7p-6, +0x1.c08c426725549p-1, +0x1.b157fd80e2946p-58, +0x1p-1, +-0x1.4ff96a0da9dfbp-6, +0x1.c14d9dc465e57p-1, +0x1.ce36b64c7f3ccp-55, +0x1p-1, +-0x1.7c1f1507aeec3p-6, +0x1.c20de3fa971bp-1, +-0x1.b4ca2bab1322cp-55, +0x1p-1, +-0x1.a85792c327db2p-6, +0x1.c2cd14931e3f1p-1, +0x1.2ce2f9d4600f5p-56, +0x1p-1, +-0x1.d4a2c7f909c4ep-6, +0x1.c38b2f180bdb1p-1, +-0x1.6e0b1757c8d07p-56, +0x1p-1, +-0x1.00804cab5f113p-5, +0x1.c44833141c004p-1, +0x1.23e0521df01a2p-56, +0x1p-1, +-0x1.16b875bf19d4p-5, +0x1.c5042012b6907p-1, +-0x1.5c058dd8eaba5p-57, +0x1p-1, +-0x1.2cf9d182f7939p-5, +0x1.c5bef59fef85ap-1, +-0x1.f0a406c8b7468p-58, +0x1p-1, +-0x1.4344523c8e3b5p-5, +0x1.c678b3488739bp-1, +0x1.d86cac7c5ff5bp-57, +0x1p-1, +-0x1.5997ea2bcfb19p-5, +0x1.c7315899eaad7p-1, +-0x1.9be5dcd047da7p-57, +0x1p-1, +-0x1.6ff48b8b1252ap-5, +0x1.c7e8e52233cf3p-1, +0x1.b2ad324aa35c1p-57, +0x1p-1, +-0x1.865a288f196fap-5, +0x1.c89f587029c13p-1, +0x1.588358ed6e78fp-58, +0x1p-1, +-0x1.9cc8b3671dd0fp-5, +0x1.c954b213411f5p-1, +-0x1.2fb761e946603p-58, +0x1p-1, +-0x1.b3401e3cd63bbp-5, +0x1.ca08f19b9c449p-1, +-0x1.431e0a5a737fdp-56, +0x1p-1, +-0x1.c9c05b347ffabp-5, +0x1.cabc169a0b9p-1, +0x1.c42d3e10851d1p-55, +0x1p-1, +-0x1.e0495c6ce76b5p-5, +0x1.cb6e20a00da99p-1, +-0x1.4fb24b5194c1bp-55, +0x1p-1, +-0x1.f6db13ff708cbp-5, +0x1.cc1f0f3fcfc5cp-1, +0x1.e57613b68f6abp-56, +0x1p-1, +-0x1.06baba000fc9bp-4, +0x1.cccee20c2deap-1, +-0x1.d3116ae0e69e4p-55, +0x1p-1, +-0x1.120c373ed0bfbp-4, +0x1.cd7d9898b32f6p-1, +-0x1.f2fa062496738p-57, +0x1p-1, +-0x1.1d61fac0aa5b2p-4, +0x1.ce2b32799a06p-1, +-0x1.631d457e46317p-56, +0x1p-1, +-0x1.28bbfd87a8cffp-4, +0x1.ced7af43cc773p-1, +-0x1.e7b6bb5ab58aep-58, +0x1p-1, +-0x1.341a389339a36p-4, +0x1.cf830e8ce467bp-1, +-0x1.7b9202780d49dp-55, +0x1p-1, +-0x1.3f7ca4e02ffdcp-4, +0x1.d02d4feb2bd92p-1, +0x1.195ff41bc55fep-55, +0x1p-1, +-0x1.4ae33b68c8fdcp-4, +0x1.d0d672f59d2b9p-1, +-0x1.c83009f0c39dep-55, +0x1p-1, +-0x1.564df524b00dap-4, +0x1.d17e7743e35dcp-1, +-0x1.101da3540130ap-58, +0x1p-1, +-0x1.61bccb0903395p-4, +0x1.d2255c6e5a4e1p-1, +-0x1.d129a71ecafc9p-55, +0x1p-1, +-0x1.6d2fb6085786ep-4, +0x1.d2cb220e0ef9fp-1, +-0x1.f07656d4e6652p-56, +0x1p-1, +-0x1.78a6af12bd501p-4, +0x1.d36fc7bcbfbdcp-1, +-0x1.ba196d95a177dp-55, +0x1p-1, +-0x1.8421af15c49d7p-4, +0x1.d4134d14dc93ap-1, +-0x1.4ef5295d25af2p-55, +0x1p-1, +-0x1.8fa0aefc81837p-4, +0x1.d4b5b1b187524p-1, +-0x1.f56be6b42b76dp-57, +0x1p-1, +-0x1.9b23a7af90805p-4, +0x1.d556f52e93eb1p-1, +-0x1.80ed9233a963p-55, +0x1p-1, +-0x1.a6aa92151adc3p-4, +0x1.d5f7172888a7fp-1, +-0x1.68663e2225755p-55, +0x1p-1, +-0x1.b2356710db0a3p-4, +0x1.d696173c9e68bp-1, +-0x1.e8c61c6393d55p-56, +0x1p-1, +-0x1.bdc41f84210bbp-4, +0x1.d733f508c0dffp-1, +-0x1.007928e770cd5p-55, +0x1p-1, +-0x1.c956b44dd6d41p-4, +0x1.d7d0b02b8ecf9p-1, +0x1.800f4ce65cd6ep-55, +0x1p-1, +-0x1.d4ed1e4a84aefp-4, +0x1.d86c48445a44fp-1, +0x1.e8813c023d71fp-55, +0x1p-1, +-0x1.e087565455a75p-4, +0x1.d906bcf328d46p-1, +0x1.457e610231ac2p-56, +0x1p-1, +-0x1.ec2555431bf03p-4, +0x1.d9a00dd8b3d46p-1, +0x1.bea0e4bac8e16p-58, +0x1p-1, +-0x1.f7c713ec554fp-4, +0x1.da383a9668988p-1, +-0x1.5811000b39d84p-55, +0x1p-1, +-0x1.01b6459197c38p-3, +0x1.dacf42ce68ab9p-1, +-0x1.fe8d76efdf896p-56, +0x1p-1, +-0x1.078ad9dc46632p-3, +0x1.db6526238a09bp-1, +-0x1.adee7eae6946p-56, +0x1p-1, +-0x1.0d61433d840a4p-3, +0x1.dbf9e4395759ap-1, +0x1.d8ff7350f75fdp-55, +0x1p-1, +-0x1.13397e1b7ce13p-3, +0x1.dc8d7cb41026p-1, +0x1.6b7872773830dp-56, +0x1p-1, +-0x1.191386db3dedcp-3, +0x1.dd1fef38a915ap-1, +-0x1.782f169e17f3bp-55, +0x1p-1, +-0x1.1eef59e0b74c3p-3, +0x1.ddb13b6ccc23cp-1, +0x1.83c37c6107db3p-55, +0x1p-1, +-0x1.24ccf38ebe694p-3, +0x1.de4160f6d8d81p-1, +0x1.9bf11cc5f8776p-55, +0x1p-1, +-0x1.2aac5047103d3p-3, +0x1.ded05f7de47dap-1, +-0x1.2cc4c1f8ba966p-55, +0x1p-1, +0x1.9ee5272b58f2ap-4, +0x1.df5e36a9ba59cp-1, +-0x1.e01f8bceb43d3p-57, +0x1p-2, +0x1.931f774fc9f18p-4, +0x1.dfeae622dbe2bp-1, +-0x1.514ea88425567p-55, +0x1p-2, +0x1.875657223080ap-4, +0x1.e0766d9280f54p-1, +0x1.f44c969cf62e3p-55, +0x1p-2, +0x1.7b89cde7a9a4dp-4, +0x1.e100cca2980acp-1, +-0x1.02d182acdf825p-57, +0x1p-2, +0x1.6fb9e2e76ced8p-4, +0x1.e18a02fdc66d9p-1, +0x1.07e272abd88cfp-55, +0x1p-2, +0x1.63e69d6ac7f74p-4, +0x1.e212104f686e5p-1, +-0x1.014c76c126527p-55, +0x1p-2, +0x1.581004bd19ed2p-4, +0x1.e298f4439197ap-1, +0x1.e84e601038eb2p-57, +0x1p-2, +0x1.4c36202bcf08ep-4, +0x1.e31eae870ce25p-1, +-0x1.bc7094538d678p-56, +0x1p-2, +0x1.4058f7065c11ep-4, +0x1.e3a33ec75ce85p-1, +0x1.45089cd46bbb8p-57, +0x1p-2, +0x1.3478909e39da9p-4, +0x1.e426a4b2bc17ep-1, +0x1.a873889744882p-55, +0x1p-2, +0x1.2894f446e0bccp-4, +0x1.e4a8dff81ce5ep-1, +0x1.43578776c0f46p-55, +0x1p-2, +0x1.1cae2955c414fp-4, +0x1.e529f04729ffcp-1, +0x1.9075d6e6dfc8bp-55, +0x1p-2, +0x1.10c437224dbc2p-4, +0x1.e5a9d550467d3p-1, +0x1.7d431be53f92fp-56, +0x1p-2, +0x1.04d72505d9805p-4, +0x1.e6288ec48e112p-1, +-0x1.16b56f2847754p-57, +0x1p-2, +0x1.f1cdf4b76138bp-5, +0x1.e6a61c55d53a7p-1, +0x1.660d981acdcf7p-56, +0x1p-2, +0x1.d9e77d020a5bcp-5, +0x1.e7227db6a9744p-1, +0x1.2128794da5a5p-55, +0x1p-2, +0x1.c1faf1a9db555p-5, +0x1.e79db29a5165ap-1, +-0x1.75e710aca58p-56, +0x1p-2, +0x1.aa086170c0a8ep-5, +0x1.e817bab4cd10dp-1, +-0x1.d0afe686b5e0ap-56, +0x1p-2, +0x1.920fdb1c5d578p-5, +0x1.e89095bad6025p-1, +-0x1.5a4cc0fcbccap-55, +0x1p-2, +0x1.7a116d7601c35p-5, +0x1.e9084361df7f2p-1, +0x1.cdfc7ce9dc3e9p-55, +0x1p-2, +0x1.620d274aa2903p-5, +0x1.e97ec36016b3p-1, +0x1.5bc48562557d3p-55, +0x1p-2, +0x1.4a03176acf82dp-5, +0x1.e9f4156c62ddap-1, +0x1.760b1e2e3f81ep-55, +0x1p-2, +0x1.31f34caaaa5d2p-5, +0x1.ea68393e658p-1, +-0x1.467259bb7b556p-56, +0x1p-2, +0x1.19ddd5e1ddb8bp-5, +0x1.eadb2e8e7a88ep-1, +-0x1.92ec52ea226a3p-55, +0x1p-2, +0x1.01c2c1eb93deep-5, +0x1.eb4cf515b8811p-1, +0x1.95da1ba97ec5ep-57, +0x1p-2, +0x1.d3443f4cdb3ddp-6, +0x1.ebbd8c8df0b74p-1, +0x1.c6c8c615e7277p-56, +0x1p-2, +0x1.a2f7fbe8f2436p-6, +0x1.ec2cf4b1af6b2p-1, +0x1.34ee3f2caa62dp-59, +0x1p-2, +0x1.72a0d77651772p-6, +0x1.ec9b2d3c3bf84p-1, +0x1.19119d358de05p-56, +0x1p-2, +0x1.423eefc693785p-6, +0x1.ed0835e999009p-1, +0x1.499d188aa32fap-57, +0x1p-2, +0x1.11d262b1f6776p-6, +0x1.ed740e7684963p-1, +0x1.e82c791f59cc2p-56, +0x1p-2, +0x1.c2b69c2e939b5p-7, +0x1.eddeb6a078651p-1, +-0x1.3b579af740a74p-55, +0x1p-2, +0x1.61b39fb7b7202p-7, +0x1.ee482e25a9dbcp-1, +-0x1.b6066ef81af2ap-56, +0x1p-2, +0x1.009c0bd6cc3cbp-7, +0x1.eeb074c50a544p-1, +0x1.d925f656c43b4p-55, +0x1p-2, +0x1.3ee038dff6b8p-8, +0x1.ef178a3e473c2p-1, +0x1.6310a67fe774fp-55, +0x1p-2, +0x1.f1806b9fdd1afp-10, +0x1.ef7d6e51ca3cp-1, +-0x1.a3c67c3d3f604p-55, +0x1p-2, +-0x1.191f2900903a6p-10, +0x1.efe220c0b95ecp-1, +0x1.c853b7bf7e0cdp-55, +0x1p-2, +-0x1.0916fe858ffcdp-8, +0x1.f045a14cf738cp-1, +-0x1.a52c44f45216cp-55, +0x1p-2, +-0x1.cc0d09bd41caap-8, +0x1.f0a7efb9230d7p-1, +0x1.52c7adc6b4989p-56, +0x1p-2, +-0x1.4794b9d21cb87p-7, +0x1.f1090bc898f5fp-1, +-0x1.baa64ab102a93p-55, +0x1p-2, +-0x1.a935e1efe5e4bp-7, +0x1.f168f53f7205dp-1, +-0x1.26a6c1f015601p-57, +0x1p-2, +-0x1.0574e07f7b332p-6, +0x1.f1c7abe284708p-1, +0x1.504b80c8a63fcp-55, +0x1p-2, +-0x1.36580d5d5e775p-6, +0x1.f2252f7763adap-1, +-0x1.20cb81c8d94abp-55, +0x1p-2, +-0x1.67445969a108ep-6, +0x1.f2817fc4609cep-1, +-0x1.dd1f8eaf65689p-55, +0x1p-2, +-0x1.9839a676a6bcfp-6, +0x1.f2dc9c9089a9dp-1, +0x1.5407460bdfc07p-59, +0x1p-2, +-0x1.c937d65145919p-6, +0x1.f33685a3aaefp-1, +0x1.eb78685d850f8p-56, +0x1p-2, +-0x1.fa3ecac0d84e8p-6, +0x1.f38f3ac64e589p-1, +-0x1.d7bafb51f72e6p-56, +0x1p-2, +-0x1.15a732c3a894dp-5, +0x1.f3e6bbc1bbc65p-1, +0x1.5774bb7e8a21ep-57, +0x1p-2, +-0x1.2e334430a6376p-5, +0x1.f43d085ff92ddp-1, +-0x1.8fde71e361c05p-55, +0x1p-2, +-0x1.46c38a8311952p-5, +0x1.f492206bcabb4p-1, +0x1.d1e921bbe3bd3p-55, +0x1p-2, +-0x1.5f57f693feebep-5, +0x1.f4e603b0b2f2dp-1, +-0x1.8ee01e695ac05p-56, +0x1p-2, +-0x1.77f07939f3897p-5, +0x1.f538b1faf2d07p-1, +-0x1.5f7cd5099519cp-59, +0x1p-2, +-0x1.908d0348ef266p-5, +0x1.f58a2b1789e84p-1, +0x1.1f4a188aa368p-56, +0x1p-2, +-0x1.a92d859275418p-5, +0x1.f5da6ed43685dp-1, +-0x1.536fc33bf9dd8p-55, +0x1p-2, +-0x1.c1d1f0e5967d5p-5, +0x1.f6297cff75cbp-1, +0x1.562172a361fd3p-56, +0x1p-2, +-0x1.da7a360ef9fefp-5, +0x1.f677556883ceep-1, +0x1.ef696a8d070f4p-57, +0x1p-2, +-0x1.f32645d8e6ce9p-5, +0x1.f6c3f7df5bbb7p-1, +0x1.8561ce9d5ef5bp-56, +0x1p-2, +-0x1.05eb0885a69c9p-4, +0x1.f70f6434b7eb7p-1, +0x1.1775df66f0ec4p-56, +0x1p-2, +-0x1.1244c435e819dp-4, +0x1.f7599a3a12077p-1, +0x1.84f31d743195cp-55, +0x1p-2, +-0x1.1ea04e5ee7601p-4, +0x1.f7a299c1a322ap-1, +0x1.6e7190c94899ep-56, +0x1p-2, +-0x1.2afd9f6136a9cp-4, +0x1.f7ea629e63d6ep-1, +0x1.ba92d57ebfeddp-55, +0x1p-2, +0x1.9146a0c760c35p-5, +0x1.f830f4a40c60cp-1, +0x1.8528676925128p-57, +0x1p-3, +0x1.78851122cff19p-5, +0x1.f8764fa714ba9p-1, +0x1.ab256778ffcb6p-56, +0x1p-3, +0x1.5fc0219532f79p-5, +0x1.f8ba737cb4b78p-1, +-0x1.da71f96d5a49cp-55, +0x1p-3, +0x1.46f7e165f17c8p-5, +0x1.f8fd5ffae41dbp-1, +-0x1.8cfd77fd970d2p-56, +0x1p-3, +0x1.2e2c5fde7ea22p-5, +0x1.f93f14f85ac08p-1, +-0x1.cfd153e9a9c1ap-55, +0x1p-3, +0x1.155dac4a4f967p-5, +0x1.f97f924c9099bp-1, +-0x1.e2ae0eea5963bp-55, +0x1p-3, +0x1.f917abeda4499p-6, +0x1.f9bed7cfbde29p-1, +-0x1.b35b1f9bcf70bp-56, +0x1p-3, +0x1.c76dd866c689ep-6, +0x1.f9fce55adb2c8p-1, +0x1.f2a06fab9f9d1p-56, +0x1p-3, +0x1.95bdfca28b53ap-6, +0x1.fa39bac7a1791p-1, +-0x1.94f388f1b4e1ep-57, +0x1p-3, +0x1.64083747309d1p-6, +0x1.fa7557f08a517p-1, +-0x1.7a0a8ca13571fp-55, +0x1p-3, +0x1.324ca6fe9a04bp-6, +0x1.faafbcb0cfddcp-1, +-0x1.e349cb4d3e866p-55, +0x1p-3, +0x1.008b6a763de76p-6, +0x1.fae8e8e46cfbbp-1, +-0x1.3a9e414732d97p-56, +0x1p-3, +0x1.9d8940be24e74p-7, +0x1.fb20dc681d54dp-1, +-0x1.ff148ec7c5fafp-55, +0x1p-3, +0x1.39f0cedaf576bp-7, +0x1.fb5797195d741p-1, +0x1.1bfac7397cc08p-56, +0x1p-3, +0x1.ac9b7964cf0bap-8, +0x1.fb8d18d66adb7p-1, +-0x1.d0b66224cce2ep-56, +0x1p-3, +0x1.ca811eea0c749p-9, +0x1.fbc1617e44186p-1, +-0x1.58ec496dc4ecbp-59, +0x1p-3, +0x1.dd15adf70b65ap-12, +0x1.fbf470f0a8d88p-1, +-0x1.6bb200d1d70b7p-55, +0x1p-3, +-0x1.536352ad19e39p-9, +0x1.fc26470e19fd3p-1, +0x1.1ec8668ecaceep-55, +0x1p-3, +-0x1.7148021b55c15p-8, +0x1.fc56e3b7d9af6p-1, +-0x1.03ff7a673d3bdp-56, +0x1p-3, +-0x1.1c789a28b01b7p-7, +0x1.fc8646cfeb721p-1, +0x1.3143dc43a9b9dp-55, +0x1p-3, +-0x1.80566267c11f6p-7, +0x1.fcb4703914354p-1, +0x1.126aa7d51b25cp-55, +0x1p-3, +-0x1.e43d1c309e958p-7, +0x1.fce15fd6da67bp-1, +-0x1.5dd6f830d4c09p-56, +0x1p-3, +-0x1.241644f1c26cep-6, +0x1.fd0d158d86087p-1, +0x1.9705a7b864883p-55, +0x1p-3, +-0x1.561236eda8ff2p-6, +0x1.fd37914220b84p-1, +0x1.52e9d7b772791p-55, +0x1p-3, +-0x1.88124536d5e8fp-6, +0x1.fd60d2da75c9ep-1, +0x1.36dedb314f0ebp-58, +0x1p-3, +-0x1.ba1650f592f5p-6, +0x1.fd88da3d12526p-1, +-0x1.87df6378811c7p-55, +0x1p-3, +-0x1.ec1e3b4fb3d7ep-6, +0x1.fdafa7514538cp-1, +0x1.d97c45ca4d398p-59, +0x1p-3, +-0x1.0f14f2b4549bdp-5, +0x1.fdd539ff1f456p-1, +-0x1.ab13cbbec1781p-56, +0x1p-3, +-0x1.281c9830c9dafp-5, +0x1.fdf9922f73307p-1, +0x1.a5e0abd3a9b65p-56, +0x1p-3, +0x1.7db402a6a9063p-6, +0x1.fe1cafcbd5b09p-1, +0x1.a23e3202a884ep-57, +0x1p-4, +0x1.4b9dd29353428p-6, +0x1.fe3e92be9d886p-1, +0x1.afeb2e264d46bp-57, +0x1p-4, +0x1.19845e49c8257p-6, +0x1.fe5f3af2e394p-1, +0x1.b213f18c9cf17p-55, +0x1p-4, +0x1.cecf8962d14c8p-7, +0x1.fe7ea85482d6p-1, +0x1.34b085c1828f7p-56, +0x1p-4, +0x1.6a9049670cfaep-7, +0x1.fe9cdad01883ap-1, +0x1.521ecd0c67e35p-57, +0x1p-4, +0x1.064b3a76a2264p-7, +0x1.feb9d2530410fp-1, +0x1.9d429eeda9bb9p-58, +0x1p-4, +0x1.440134d709b28p-8, +0x1.fed58ecb673c4p-1, +-0x1.e6e462a7ae686p-56, +0x1p-4, +0x1.ed853918c18ecp-10, +0x1.fef0102826191p-1, +0x1.3c3ea4f30addap-56, +0x1p-4, +-0x1.35230c0fbe402p-10, +0x1.ff095658e71adp-1, +0x1.01a8ce18a4b9ep-55, +0x1p-4, +-0x1.15fc833fb89b8p-8, +0x1.ff21614e131edp-1, +-0x1.de692a167353p-55, +0x1p-4, +-0x1.deb9769f940eap-8, +0x1.ff3830f8d575cp-1, +-0x1.95e1e79d335f7p-56, +0x1p-4, +-0x1.53bf90a81f3a5p-7, +0x1.ff4dc54b1bed3p-1, +-0x1.c1169ccd1e92ep-55, +0x1p-4, +-0x1.b82683bc89fbp-7, +0x1.ff621e3796d7ep-1, +-0x1.c57bc2e24aa15p-57, +0x1p-4, +-0x1.0e48ab4f172f4p-6, +0x1.ff753bb1b9164p-1, +-0x1.7c330129f56efp-56, +0x1p-4, +0x1.7f0034a43350ep-7, +0x1.ff871dadb81dfp-1, +0x1.8b1c676208aa4p-56, +0x1p-5, +0x1.1a8e5bfe185e4p-7, +0x1.ff97c4208c014p-1, +0x1.52ab2b947e843p-57, +0x1p-5, +0x1.6c32baca2ae69p-8, +0x1.ffa72effef75dp-1, +-0x1.8b4cdcdb25956p-55, +0x1p-5, +0x1.4685db42c17ebp-9, +0x1.ffb55e425fdaep-1, +0x1.6da7ec781c225p-55, +0x1p-5, +-0x1.2d919c5c61fep-11, +0x1.ffc251df1d3f8p-1, +0x1.7a7d209f32d43p-56, +0x1p-5, +-0x1.dd58598d6271cp-9, +0x1.ffce09ce2a679p-1, +-0x1.7bd62ab5ee228p-55, +0x1p-5, +-0x1.b7aa821726608p-8, +0x1.ffd886084cd0dp-1, +-0x1.1354d4556e4cbp-55, +0x1p-5, +0x1.7f53487eac897p-8, +0x1.ffe1c6870cb77p-1, +0x1.89aa14768323ep-55, +0x1p-6, +0x1.6c9b5df1877eap-9, +0x1.ffe9cb44b51a1p-1, +0x1.5b43366df667p-56, +0x1p-6, +-0x1.2bad2a8cd06bp-12, +0x1.fff0943c53bd1p-1, +-0x1.47399f361d158p-55, +0x1p-6, +-0x1.b78b80c84e1eep-9, +0x1.fff62169b92dbp-1, +0x1.5dda3c81fbd0dp-55, +0x1p-6, +0x1.6cb587284b817p-10, +0x1.fffa72c978c4fp-1, +-0x1.22cb000328f91p-55, +0x1p-7, +-0x1.b783c0663fe3cp-10, +0x1.fffd8858e8a92p-1, +0x1.359c71883bcf7p-55, +0x1p-7, +-0x1.b781d04cd6d17p-11, +0x1.ffff621621d02p-1, +-0x1.6acfcebc82813p-56, +0x1p-8, +0, +0x1p0, +0, +0, +0x1.b781d04cd6d17p-11, +0x1.ffff621621d02p-1, +-0x1.6acfcebc82813p-56, +-0x1p-8, +0x1.b783c0663fe3cp-10, +0x1.fffd8858e8a92p-1, +0x1.359c71883bcf7p-55, +-0x1p-7, +-0x1.6cb587284b817p-10, +0x1.fffa72c978c4fp-1, +-0x1.22cb000328f91p-55, +-0x1p-7, +0x1.b78b80c84e1eep-9, +0x1.fff62169b92dbp-1, +0x1.5dda3c81fbd0dp-55, +-0x1p-6, +0x1.2bad2a8cd06bp-12, +0x1.fff0943c53bd1p-1, +-0x1.47399f361d158p-55, +-0x1p-6, +-0x1.6c9b5df1877eap-9, +0x1.ffe9cb44b51a1p-1, +0x1.5b43366df667p-56, +-0x1p-6, +-0x1.7f53487eac897p-8, +0x1.ffe1c6870cb77p-1, +0x1.89aa14768323ep-55, +-0x1p-6, +0x1.b7aa821726608p-8, +0x1.ffd886084cd0dp-1, +-0x1.1354d4556e4cbp-55, +-0x1p-5, +0x1.dd58598d6271cp-9, +0x1.ffce09ce2a679p-1, +-0x1.7bd62ab5ee228p-55, +-0x1p-5, +0x1.2d919c5c61fep-11, +0x1.ffc251df1d3f8p-1, +0x1.7a7d209f32d43p-56, +-0x1p-5, +-0x1.4685db42c17ebp-9, +0x1.ffb55e425fdaep-1, +0x1.6da7ec781c225p-55, +-0x1p-5, +-0x1.6c32baca2ae69p-8, +0x1.ffa72effef75dp-1, +-0x1.8b4cdcdb25956p-55, +-0x1p-5, +-0x1.1a8e5bfe185e4p-7, +0x1.ff97c4208c014p-1, +0x1.52ab2b947e843p-57, +-0x1p-5, +-0x1.7f0034a43350ep-7, +0x1.ff871dadb81dfp-1, +0x1.8b1c676208aa4p-56, +-0x1p-5, +0x1.0e48ab4f172f4p-6, +0x1.ff753bb1b9164p-1, +-0x1.7c330129f56efp-56, +-0x1p-4, +0x1.b82683bc89fbp-7, +0x1.ff621e3796d7ep-1, +-0x1.c57bc2e24aa15p-57, +-0x1p-4, +0x1.53bf90a81f3a5p-7, +0x1.ff4dc54b1bed3p-1, +-0x1.c1169ccd1e92ep-55, +-0x1p-4, +0x1.deb9769f940eap-8, +0x1.ff3830f8d575cp-1, +-0x1.95e1e79d335f7p-56, +-0x1p-4, +0x1.15fc833fb89b8p-8, +0x1.ff21614e131edp-1, +-0x1.de692a167353p-55, +-0x1p-4, +0x1.35230c0fbe402p-10, +0x1.ff095658e71adp-1, +0x1.01a8ce18a4b9ep-55, +-0x1p-4, +-0x1.ed853918c18ecp-10, +0x1.fef0102826191p-1, +0x1.3c3ea4f30addap-56, +-0x1p-4, +-0x1.440134d709b28p-8, +0x1.fed58ecb673c4p-1, +-0x1.e6e462a7ae686p-56, +-0x1p-4, +-0x1.064b3a76a2264p-7, +0x1.feb9d2530410fp-1, +0x1.9d429eeda9bb9p-58, +-0x1p-4, +-0x1.6a9049670cfaep-7, +0x1.fe9cdad01883ap-1, +0x1.521ecd0c67e35p-57, +-0x1p-4, +-0x1.cecf8962d14c8p-7, +0x1.fe7ea85482d6p-1, +0x1.34b085c1828f7p-56, +-0x1p-4, +-0x1.19845e49c8257p-6, +0x1.fe5f3af2e394p-1, +0x1.b213f18c9cf17p-55, +-0x1p-4, +-0x1.4b9dd29353428p-6, +0x1.fe3e92be9d886p-1, +0x1.afeb2e264d46bp-57, +-0x1p-4, +-0x1.7db402a6a9063p-6, +0x1.fe1cafcbd5b09p-1, +0x1.a23e3202a884ep-57, +-0x1p-4, +0x1.281c9830c9dafp-5, +0x1.fdf9922f73307p-1, +0x1.a5e0abd3a9b65p-56, +-0x1p-3, +0x1.0f14f2b4549bdp-5, +0x1.fdd539ff1f456p-1, +-0x1.ab13cbbec1781p-56, +-0x1p-3, +0x1.ec1e3b4fb3d7ep-6, +0x1.fdafa7514538cp-1, +0x1.d97c45ca4d398p-59, +-0x1p-3, +0x1.ba1650f592f5p-6, +0x1.fd88da3d12526p-1, +-0x1.87df6378811c7p-55, +-0x1p-3, +0x1.88124536d5e8fp-6, +0x1.fd60d2da75c9ep-1, +0x1.36dedb314f0ebp-58, +-0x1p-3, +0x1.561236eda8ff2p-6, +0x1.fd37914220b84p-1, +0x1.52e9d7b772791p-55, +-0x1p-3, +0x1.241644f1c26cep-6, +0x1.fd0d158d86087p-1, +0x1.9705a7b864883p-55, +-0x1p-3, +0x1.e43d1c309e958p-7, +0x1.fce15fd6da67bp-1, +-0x1.5dd6f830d4c09p-56, +-0x1p-3, +0x1.80566267c11f6p-7, +0x1.fcb4703914354p-1, +0x1.126aa7d51b25cp-55, +-0x1p-3, +0x1.1c789a28b01b7p-7, +0x1.fc8646cfeb721p-1, +0x1.3143dc43a9b9dp-55, +-0x1p-3, +0x1.7148021b55c15p-8, +0x1.fc56e3b7d9af6p-1, +-0x1.03ff7a673d3bdp-56, +-0x1p-3, +0x1.536352ad19e39p-9, +0x1.fc26470e19fd3p-1, +0x1.1ec8668ecaceep-55, +-0x1p-3, +-0x1.dd15adf70b65ap-12, +0x1.fbf470f0a8d88p-1, +-0x1.6bb200d1d70b7p-55, +-0x1p-3, +-0x1.ca811eea0c749p-9, +0x1.fbc1617e44186p-1, +-0x1.58ec496dc4ecbp-59, +-0x1p-3, +-0x1.ac9b7964cf0bap-8, +0x1.fb8d18d66adb7p-1, +-0x1.d0b66224cce2ep-56, +-0x1p-3, +-0x1.39f0cedaf576bp-7, +0x1.fb5797195d741p-1, +0x1.1bfac7397cc08p-56, +-0x1p-3, +-0x1.9d8940be24e74p-7, +0x1.fb20dc681d54dp-1, +-0x1.ff148ec7c5fafp-55, +-0x1p-3, +-0x1.008b6a763de76p-6, +0x1.fae8e8e46cfbbp-1, +-0x1.3a9e414732d97p-56, +-0x1p-3, +-0x1.324ca6fe9a04bp-6, +0x1.faafbcb0cfddcp-1, +-0x1.e349cb4d3e866p-55, +-0x1p-3, +-0x1.64083747309d1p-6, +0x1.fa7557f08a517p-1, +-0x1.7a0a8ca13571fp-55, +-0x1p-3, +-0x1.95bdfca28b53ap-6, +0x1.fa39bac7a1791p-1, +-0x1.94f388f1b4e1ep-57, +-0x1p-3, +-0x1.c76dd866c689ep-6, +0x1.f9fce55adb2c8p-1, +0x1.f2a06fab9f9d1p-56, +-0x1p-3, +-0x1.f917abeda4499p-6, +0x1.f9bed7cfbde29p-1, +-0x1.b35b1f9bcf70bp-56, +-0x1p-3, +-0x1.155dac4a4f967p-5, +0x1.f97f924c9099bp-1, +-0x1.e2ae0eea5963bp-55, +-0x1p-3, +-0x1.2e2c5fde7ea22p-5, +0x1.f93f14f85ac08p-1, +-0x1.cfd153e9a9c1ap-55, +-0x1p-3, +-0x1.46f7e165f17c8p-5, +0x1.f8fd5ffae41dbp-1, +-0x1.8cfd77fd970d2p-56, +-0x1p-3, +-0x1.5fc0219532f79p-5, +0x1.f8ba737cb4b78p-1, +-0x1.da71f96d5a49cp-55, +-0x1p-3, +-0x1.78851122cff19p-5, +0x1.f8764fa714ba9p-1, +0x1.ab256778ffcb6p-56, +-0x1p-3, +-0x1.9146a0c760c35p-5, +0x1.f830f4a40c60cp-1, +0x1.8528676925128p-57, +-0x1p-3, +0x1.2afd9f6136a9cp-4, +0x1.f7ea629e63d6ep-1, +0x1.ba92d57ebfeddp-55, +-0x1p-2, +0x1.1ea04e5ee7601p-4, +0x1.f7a299c1a322ap-1, +0x1.6e7190c94899ep-56, +-0x1p-2, +0x1.1244c435e819dp-4, +0x1.f7599a3a12077p-1, +0x1.84f31d743195cp-55, +-0x1p-2, +0x1.05eb0885a69c9p-4, +0x1.f70f6434b7eb7p-1, +0x1.1775df66f0ec4p-56, +-0x1p-2, +0x1.f32645d8e6ce9p-5, +0x1.f6c3f7df5bbb7p-1, +0x1.8561ce9d5ef5bp-56, +-0x1p-2, +0x1.da7a360ef9fefp-5, +0x1.f677556883ceep-1, +0x1.ef696a8d070f4p-57, +-0x1p-2, +0x1.c1d1f0e5967d5p-5, +0x1.f6297cff75cbp-1, +0x1.562172a361fd3p-56, +-0x1p-2, +0x1.a92d859275418p-5, +0x1.f5da6ed43685dp-1, +-0x1.536fc33bf9dd8p-55, +-0x1p-2, +0x1.908d0348ef266p-5, +0x1.f58a2b1789e84p-1, +0x1.1f4a188aa368p-56, +-0x1p-2, +0x1.77f07939f3897p-5, +0x1.f538b1faf2d07p-1, +-0x1.5f7cd5099519cp-59, +-0x1p-2, +0x1.5f57f693feebep-5, +0x1.f4e603b0b2f2dp-1, +-0x1.8ee01e695ac05p-56, +-0x1p-2, +0x1.46c38a8311952p-5, +0x1.f492206bcabb4p-1, +0x1.d1e921bbe3bd3p-55, +-0x1p-2, +0x1.2e334430a6376p-5, +0x1.f43d085ff92ddp-1, +-0x1.8fde71e361c05p-55, +-0x1p-2, +0x1.15a732c3a894dp-5, +0x1.f3e6bbc1bbc65p-1, +0x1.5774bb7e8a21ep-57, +-0x1p-2, +0x1.fa3ecac0d84e8p-6, +0x1.f38f3ac64e589p-1, +-0x1.d7bafb51f72e6p-56, +-0x1p-2, +0x1.c937d65145919p-6, +0x1.f33685a3aaefp-1, +0x1.eb78685d850f8p-56, +-0x1p-2, +0x1.9839a676a6bcfp-6, +0x1.f2dc9c9089a9dp-1, +0x1.5407460bdfc07p-59, +-0x1p-2, +0x1.67445969a108ep-6, +0x1.f2817fc4609cep-1, +-0x1.dd1f8eaf65689p-55, +-0x1p-2, +0x1.36580d5d5e775p-6, +0x1.f2252f7763adap-1, +-0x1.20cb81c8d94abp-55, +-0x1p-2, +0x1.0574e07f7b332p-6, +0x1.f1c7abe284708p-1, +0x1.504b80c8a63fcp-55, +-0x1p-2, +0x1.a935e1efe5e4bp-7, +0x1.f168f53f7205dp-1, +-0x1.26a6c1f015601p-57, +-0x1p-2, +0x1.4794b9d21cb87p-7, +0x1.f1090bc898f5fp-1, +-0x1.baa64ab102a93p-55, +-0x1p-2, +0x1.cc0d09bd41caap-8, +0x1.f0a7efb9230d7p-1, +0x1.52c7adc6b4989p-56, +-0x1p-2, +0x1.0916fe858ffcdp-8, +0x1.f045a14cf738cp-1, +-0x1.a52c44f45216cp-55, +-0x1p-2, +0x1.191f2900903a6p-10, +0x1.efe220c0b95ecp-1, +0x1.c853b7bf7e0cdp-55, +-0x1p-2, +-0x1.f1806b9fdd1afp-10, +0x1.ef7d6e51ca3cp-1, +-0x1.a3c67c3d3f604p-55, +-0x1p-2, +-0x1.3ee038dff6b8p-8, +0x1.ef178a3e473c2p-1, +0x1.6310a67fe774fp-55, +-0x1p-2, +-0x1.009c0bd6cc3cbp-7, +0x1.eeb074c50a544p-1, +0x1.d925f656c43b4p-55, +-0x1p-2, +-0x1.61b39fb7b7202p-7, +0x1.ee482e25a9dbcp-1, +-0x1.b6066ef81af2ap-56, +-0x1p-2, +-0x1.c2b69c2e939b5p-7, +0x1.eddeb6a078651p-1, +-0x1.3b579af740a74p-55, +-0x1p-2, +-0x1.11d262b1f6776p-6, +0x1.ed740e7684963p-1, +0x1.e82c791f59cc2p-56, +-0x1p-2, +-0x1.423eefc693785p-6, +0x1.ed0835e999009p-1, +0x1.499d188aa32fap-57, +-0x1p-2, +-0x1.72a0d77651772p-6, +0x1.ec9b2d3c3bf84p-1, +0x1.19119d358de05p-56, +-0x1p-2, +-0x1.a2f7fbe8f2436p-6, +0x1.ec2cf4b1af6b2p-1, +0x1.34ee3f2caa62dp-59, +-0x1p-2, +-0x1.d3443f4cdb3ddp-6, +0x1.ebbd8c8df0b74p-1, +0x1.c6c8c615e7277p-56, +-0x1p-2, +-0x1.01c2c1eb93deep-5, +0x1.eb4cf515b8811p-1, +0x1.95da1ba97ec5ep-57, +-0x1p-2, +-0x1.19ddd5e1ddb8bp-5, +0x1.eadb2e8e7a88ep-1, +-0x1.92ec52ea226a3p-55, +-0x1p-2, +-0x1.31f34caaaa5d2p-5, +0x1.ea68393e658p-1, +-0x1.467259bb7b556p-56, +-0x1p-2, +-0x1.4a03176acf82dp-5, +0x1.e9f4156c62ddap-1, +0x1.760b1e2e3f81ep-55, +-0x1p-2, +-0x1.620d274aa2903p-5, +0x1.e97ec36016b3p-1, +0x1.5bc48562557d3p-55, +-0x1p-2, +-0x1.7a116d7601c35p-5, +0x1.e9084361df7f2p-1, +0x1.cdfc7ce9dc3e9p-55, +-0x1p-2, +-0x1.920fdb1c5d578p-5, +0x1.e89095bad6025p-1, +-0x1.5a4cc0fcbccap-55, +-0x1p-2, +-0x1.aa086170c0a8ep-5, +0x1.e817bab4cd10dp-1, +-0x1.d0afe686b5e0ap-56, +-0x1p-2, +-0x1.c1faf1a9db555p-5, +0x1.e79db29a5165ap-1, +-0x1.75e710aca58p-56, +-0x1p-2, +-0x1.d9e77d020a5bcp-5, +0x1.e7227db6a9744p-1, +0x1.2128794da5a5p-55, +-0x1p-2, +-0x1.f1cdf4b76138bp-5, +0x1.e6a61c55d53a7p-1, +0x1.660d981acdcf7p-56, +-0x1p-2, +-0x1.04d72505d9805p-4, +0x1.e6288ec48e112p-1, +-0x1.16b56f2847754p-57, +-0x1p-2, +-0x1.10c437224dbc2p-4, +0x1.e5a9d550467d3p-1, +0x1.7d431be53f92fp-56, +-0x1p-2, +-0x1.1cae2955c414fp-4, +0x1.e529f04729ffcp-1, +0x1.9075d6e6dfc8bp-55, +-0x1p-2, +-0x1.2894f446e0bccp-4, +0x1.e4a8dff81ce5ep-1, +0x1.43578776c0f46p-55, +-0x1p-2, +-0x1.3478909e39da9p-4, +0x1.e426a4b2bc17ep-1, +0x1.a873889744882p-55, +-0x1p-2, +-0x1.4058f7065c11ep-4, +0x1.e3a33ec75ce85p-1, +0x1.45089cd46bbb8p-57, +-0x1p-2, +-0x1.4c36202bcf08ep-4, +0x1.e31eae870ce25p-1, +-0x1.bc7094538d678p-56, +-0x1p-2, +-0x1.581004bd19ed2p-4, +0x1.e298f4439197ap-1, +0x1.e84e601038eb2p-57, +-0x1p-2, +-0x1.63e69d6ac7f74p-4, +0x1.e212104f686e5p-1, +-0x1.014c76c126527p-55, +-0x1p-2, +-0x1.6fb9e2e76ced8p-4, +0x1.e18a02fdc66d9p-1, +0x1.07e272abd88cfp-55, +-0x1p-2, +-0x1.7b89cde7a9a4dp-4, +0x1.e100cca2980acp-1, +-0x1.02d182acdf825p-57, +-0x1p-2, +-0x1.875657223080ap-4, +0x1.e0766d9280f54p-1, +0x1.f44c969cf62e3p-55, +-0x1p-2, +-0x1.931f774fc9f18p-4, +0x1.dfeae622dbe2bp-1, +-0x1.514ea88425567p-55, +-0x1p-2, +-0x1.9ee5272b58f2ap-4, +0x1.df5e36a9ba59cp-1, +-0x1.e01f8bceb43d3p-57, +-0x1p-2, +0x1.2aac5047103d3p-3, +0x1.ded05f7de47dap-1, +-0x1.2cc4c1f8ba966p-55, +-0x1p-1, +0x1.24ccf38ebe694p-3, +0x1.de4160f6d8d81p-1, +0x1.9bf11cc5f8776p-55, +-0x1p-1, +0x1.1eef59e0b74c3p-3, +0x1.ddb13b6ccc23cp-1, +0x1.83c37c6107db3p-55, +-0x1p-1, +0x1.191386db3dedcp-3, +0x1.dd1fef38a915ap-1, +-0x1.782f169e17f3bp-55, +-0x1p-1, +0x1.13397e1b7ce13p-3, +0x1.dc8d7cb41026p-1, +0x1.6b7872773830dp-56, +-0x1p-1, +0x1.0d61433d840a4p-3, +0x1.dbf9e4395759ap-1, +0x1.d8ff7350f75fdp-55, +-0x1p-1, +0x1.078ad9dc46632p-3, +0x1.db6526238a09bp-1, +-0x1.adee7eae6946p-56, +-0x1p-1, +0x1.01b6459197c38p-3, +0x1.dacf42ce68ab9p-1, +-0x1.fe8d76efdf896p-56, +-0x1p-1, +0x1.f7c713ec554fp-4, +0x1.da383a9668988p-1, +-0x1.5811000b39d84p-55, +-0x1p-1, +0x1.ec2555431bf03p-4, +0x1.d9a00dd8b3d46p-1, +0x1.bea0e4bac8e16p-58, +-0x1p-1, +0x1.e087565455a75p-4, +0x1.d906bcf328d46p-1, +0x1.457e610231ac2p-56, +-0x1p-1, +0x1.d4ed1e4a84aefp-4, +0x1.d86c48445a44fp-1, +0x1.e8813c023d71fp-55, +-0x1p-1, +0x1.c956b44dd6d41p-4, +0x1.d7d0b02b8ecf9p-1, +0x1.800f4ce65cd6ep-55, +-0x1p-1, +0x1.bdc41f84210bbp-4, +0x1.d733f508c0dffp-1, +-0x1.007928e770cd5p-55, +-0x1p-1, +0x1.b2356710db0a3p-4, +0x1.d696173c9e68bp-1, +-0x1.e8c61c6393d55p-56, +-0x1p-1, +0x1.a6aa92151adc3p-4, +0x1.d5f7172888a7fp-1, +-0x1.68663e2225755p-55, +-0x1p-1, +0x1.9b23a7af90805p-4, +0x1.d556f52e93eb1p-1, +-0x1.80ed9233a963p-55, +-0x1p-1, +0x1.8fa0aefc81837p-4, +0x1.d4b5b1b187524p-1, +-0x1.f56be6b42b76dp-57, +-0x1p-1, +0x1.8421af15c49d7p-4, +0x1.d4134d14dc93ap-1, +-0x1.4ef5295d25af2p-55, +-0x1p-1, +0x1.78a6af12bd501p-4, +0x1.d36fc7bcbfbdcp-1, +-0x1.ba196d95a177dp-55, +-0x1p-1, +0x1.6d2fb6085786ep-4, +0x1.d2cb220e0ef9fp-1, +-0x1.f07656d4e6652p-56, +-0x1p-1, +0x1.61bccb0903395p-4, +0x1.d2255c6e5a4e1p-1, +-0x1.d129a71ecafc9p-55, +-0x1p-1, +0x1.564df524b00dap-4, +0x1.d17e7743e35dcp-1, +-0x1.101da3540130ap-58, +-0x1p-1, +0x1.4ae33b68c8fdcp-4, +0x1.d0d672f59d2b9p-1, +-0x1.c83009f0c39dep-55, +-0x1p-1, +0x1.3f7ca4e02ffdcp-4, +0x1.d02d4feb2bd92p-1, +0x1.195ff41bc55fep-55, +-0x1p-1, +0x1.341a389339a36p-4, +0x1.cf830e8ce467bp-1, +-0x1.7b9202780d49dp-55, +-0x1p-1, +0x1.28bbfd87a8cffp-4, +0x1.ced7af43cc773p-1, +-0x1.e7b6bb5ab58aep-58, +-0x1p-1, +0x1.1d61fac0aa5b2p-4, +0x1.ce2b32799a06p-1, +-0x1.631d457e46317p-56, +-0x1p-1, +0x1.120c373ed0bfbp-4, +0x1.cd7d9898b32f6p-1, +-0x1.f2fa062496738p-57, +-0x1p-1, +0x1.06baba000fc9bp-4, +0x1.cccee20c2deap-1, +-0x1.d3116ae0e69e4p-55, +-0x1p-1, +0x1.f6db13ff708cbp-5, +0x1.cc1f0f3fcfc5cp-1, +0x1.e57613b68f6abp-56, +-0x1p-1, +0x1.e0495c6ce76b5p-5, +0x1.cb6e20a00da99p-1, +-0x1.4fb24b5194c1bp-55, +-0x1p-1, +0x1.c9c05b347ffabp-5, +0x1.cabc169a0b9p-1, +0x1.c42d3e10851d1p-55, +-0x1p-1, +0x1.b3401e3cd63bbp-5, +0x1.ca08f19b9c449p-1, +-0x1.431e0a5a737fdp-56, +-0x1p-1, +0x1.9cc8b3671dd0fp-5, +0x1.c954b213411f5p-1, +-0x1.2fb761e946603p-58, +-0x1p-1, +0x1.865a288f196fap-5, +0x1.c89f587029c13p-1, +0x1.588358ed6e78fp-58, +-0x1p-1, +0x1.6ff48b8b1252ap-5, +0x1.c7e8e52233cf3p-1, +0x1.b2ad324aa35c1p-57, +-0x1p-1, +0x1.5997ea2bcfb19p-5, +0x1.c7315899eaad7p-1, +-0x1.9be5dcd047da7p-57, +-0x1p-1, +0x1.4344523c8e3b5p-5, +0x1.c678b3488739bp-1, +0x1.d86cac7c5ff5bp-57, +-0x1p-1, +0x1.2cf9d182f7939p-5, +0x1.c5bef59fef85ap-1, +-0x1.f0a406c8b7468p-58, +-0x1p-1, +0x1.16b875bf19d4p-5, +0x1.c5042012b6907p-1, +-0x1.5c058dd8eaba5p-57, +-0x1p-1, +0x1.00804cab5f113p-5, +0x1.c44833141c004p-1, +0x1.23e0521df01a2p-56, +-0x1p-1, +0x1.d4a2c7f909c4ep-6, +0x1.c38b2f180bdb1p-1, +-0x1.6e0b1757c8d07p-56, +-0x1p-1, +0x1.a85792c327db2p-6, +0x1.c2cd14931e3f1p-1, +0x1.2ce2f9d4600f5p-56, +-0x1p-1, +0x1.7c1f1507aeec3p-6, +0x1.c20de3fa971bp-1, +-0x1.b4ca2bab1322cp-55, +-0x1p-1, +0x1.4ff96a0da9dfbp-6, +0x1.c14d9dc465e57p-1, +0x1.ce36b64c7f3ccp-55, +-0x1p-1, +0x1.23e6ad10872a7p-6, +0x1.c08c426725549p-1, +0x1.b157fd80e2946p-58, +-0x1p-1, +0x1.efcdf2801004ap-7, +0x1.bfc9d25a1b147p-1, +-0x1.51bf4ee01357p-61, +-0x1p-1, +0x1.97f4d3805f318p-7, +0x1.bf064e15377ddp-1, +0x1.2156026a1e028p-57, +-0x1p-1, +0x1.4042335264ba3p-7, +0x1.be41b611154c1p-1, +-0x1.fdcdad3a6877ep-55, +-0x1p-1, +0x1.d16c901d95181p-8, +0x1.bd7c0ac6f952ap-1, +-0x1.825a732ac700ap-55, +-0x1p-1, +0x1.22a28f6cb488bp-8, +0x1.bcb54cb0d2327p-1, +0x1.410923c55523ep-62, +-0x1p-1, +0x1.d09b418edf04ap-10, +0x1.bbed7c49380eap-1, +0x1.beacbd88500b4p-59, +-0x1p-1, +-0x1.d0320ae0b8293p-11, +0x1.bb249a0b6c40dp-1, +-0x1.d6318ee919f7ap-58, +-0x1p-1, +-0x1.cfc874c3eb6d9p-9, +0x1.ba5aa673590d2p-1, +0x1.7ea4e370753b6p-55, +-0x1p-1, +-0x1.9572af6decac8p-8, +0x1.b98fa1fd9155ep-1, +0x1.5559034fe85a4p-55, +-0x1p-1, +-0x1.21589ab88869cp-7, +0x1.b8c38d27504e9p-1, +-0x1.1529abff40e45p-55, +-0x1p-1, +-0x1.77cfb0c6e2db8p-7, +0x1.b7f6686e792e9p-1, +0x1.87665bfea06aap-55, +-0x1p-1, +-0x1.ce1e648bffb66p-7, +0x1.b728345196e3ep-1, +-0x1.bc69f324e6d61p-55, +-0x1p-1, +-0x1.1222406561182p-6, +0x1.b658f14fdbc47p-1, +0x1.52b5308f397dep-57, +-0x1p-1, +-0x1.3d20e82f8bc1p-6, +0x1.b5889fe921405p-1, +-0x1.df49b307c8602p-57, +-0x1p-1, +-0x1.680b0f1f0bd73p-6, +0x1.b4b7409de7925p-1, +0x1.f4e257bde73d8p-56, +-0x1p-1, +-0x1.92e09abb131d4p-6, +0x1.b3e4d3ef55712p-1, +-0x1.eb6b8bf11a493p-55, +-0x1p-1, +-0x1.bda17097896b4p-6, +0x1.b3115a5f37bf3p-1, +0x1.dde2726e34fe1p-55, +-0x1p-1, +-0x1.e84d76551cfb2p-6, +0x1.b23cd470013b4p-1, +0x1.5a1bb35ad6d2ep-56, +-0x1p-1, +-0x1.097248d0a956ap-5, +0x1.b16742a4ca2f5p-1, +-0x1.ba70972b80438p-55, +-0x1p-1, +-0x1.1eb3541b4b228p-5, +0x1.b090a581502p-1, +-0x1.926da300ffccep-55, +-0x1p-1, +-0x1.33e9cfee254edp-5, +0x1.afb8fd89f57b6p-1, +0x1.1ced12d2899b8p-60, +-0x1p-1, +-0x1.4915af336ceb4p-5, +0x1.aee04b43c1474p-1, +-0x1.3a79a438bf8ccp-55, +-0x1p-1, +-0x1.5e36e4dbe2bc2p-5, +0x1.ae068f345ecefp-1, +-0x1.33934c4029a4cp-56, +-0x1p-1, +-0x1.734d63dedb48ap-5, +0x1.ad2bc9e21d511p-1, +-0x1.47fbe07bea548p-55, +-0x1p-1, +-0x1.88591f3a46e4dp-5, +0x1.ac4ffbd3efac8p-1, +-0x1.818504103fa16p-56, +-0x1p-1, +-0x1.9d5a09f2b9b7fp-5, +0x1.ab7325916c0d4p-1, +0x1.a8b8c85baaa9bp-55, +-0x1p-1, +-0x1.b250171373be9p-5, +0x1.aa9547a2cb98ep-1, +0x1.87d00ae97abaap-60, +-0x1p-1, +-0x1.c73b39ae68c87p-5, +0x1.a9b66290ea1a3p-1, +0x1.9f630e8b6dac8p-60, +-0x1p-1, +-0x1.dc1b64dc48722p-5, +0x1.a8d676e545ad2p-1, +-0x1.b11dcce2e74bdp-59, +-0x1p-1, +-0x1.f0f08bbc861afp-5, +0x1.a7f58529fe69dp-1, +-0x1.97a441584a179p-55, +-0x1p-1, +-0x1.02dd50bab06b2p-4, +0x1.a7138de9d60f5p-1, +-0x1.f1ab82a9c5f2dp-55, +-0x1p-1, +-0x1.0d3ccc99f5ac6p-4, +0x1.a63091b02fae2p-1, +-0x1.e911152248d1p-56, +-0x1p-1, +-0x1.1796b31609f0cp-4, +0x1.a54c91090f523p-1, +0x1.184300fd1c1cep-56, +-0x1p-1, +-0x1.21eafdcc560fap-4, +0x1.a4678c8119ac8p-1, +0x1.1b4c0dd3f212ap-55, +-0x1p-1, +-0x1.2c39a65db8881p-4, +0x1.a38184a593bc6p-1, +-0x1.bc92c5bd2d288p-55, +-0x1p-1, +-0x1.3682a66e896f5p-4, +0x1.a29a7a0462782p-1, +-0x1.128bb015df175p-56, +-0x1p-1, +-0x1.40c5f7a69e5cep-4, +0x1.a1b26d2c0a75ep-1, +0x1.30ef431d627a6p-57, +-0x1p-1, +-0x1.4b0393b14e541p-4, +0x1.a0c95eabaf937p-1, +-0x1.e0ca3acbd049ap-55, +-0x1p-1, +-0x1.553b743d75acp-4, +0x1.9fdf4f13149dep-1, +0x1.1e6d79006ec09p-55, +-0x1p-1, +-0x1.5f6d92fd79f5p-4, +0x1.9ef43ef29af94p-1, +0x1.b1dfcb60445c2p-56, +-0x1p-1, +-0x1.6999e9a74ddbep-4, +0x1.9e082edb42472p-1, +0x1.5809a4e121e22p-57, +-0x1p-1, +-0x1.73c071f4750b5p-4, +0x1.9d1b1f5ea80d5p-1, +0x1.c5fadd5ffb36fp-55, +-0x1p-1, +-0x1.7de125a2080a9p-4, +0x1.9c2d110f075c2p-1, +0x1.d9c9f1c8c30dp-55, +-0x1p-1, +-0x1.87fbfe70b81a7p-4, +0x1.9b3e047f38741p-1, +-0x1.30ee286712474p-55, +-0x1p-1, +-0x1.9210f624d30fbp-4, +0x1.9a4dfa42b06b2p-1, +-0x1.829b6b8b1c947p-56, +-0x1p-1, +-0x1.9c200686472b5p-4, +0x1.995cf2ed80d22p-1, +0x1.7783e907fbd7bp-56, +-0x1p-1, +-0x1.a6292960a6f0bp-4, +0x1.986aef1457594p-1, +-0x1.af03e318f38fcp-55, +-0x1p-1, +-0x1.b02c58832cf96p-4, +0x1.9777ef4c7d742p-1, +-0x1.15479a240665ep-55, +-0x1p-1, +-0x1.ba298dc0bfc6bp-4, +0x1.9683f42bd7fe1p-1, +-0x1.11bad933c835ep-57, +-0x1p-1, +-0x1.c420c2eff590ep-4, +0x1.958efe48e6dd7p-1, +-0x1.561335da0f4e7p-55, +-0x1p-1, +-0x1.ce11f1eb18148p-4, +0x1.94990e3ac4a6cp-1, +0x1.a95328edeb3e6p-56, +-0x1p-1, +-0x1.d7fd1490285cap-4, +0x1.93a22499263fbp-1, +0x1.3d419a920df0bp-55, +-0x1p-1, +-0x1.e1e224c0e28bdp-4, +0x1.92aa41fc5a815p-1, +-0x1.68f89e2d23db7p-57, +-0x1p-1, +-0x1.ebc11c62c1a1ep-4, +0x1.91b166fd49da2p-1, +-0x1.3be953a7fe996p-57, +-0x1p-1, +-0x1.f599f55f034p-4, +0x1.90b7943575efep-1, +0x1.4ecb0c5273706p-57, +-0x1p-1, +-0x1.ff6ca9a2ab6a2p-4, +0x1.8fbcca3ef940dp-1, +-0x1.6dfa99c86f2f1p-57, +-0x1p-1, +-0x1.049c998f44231p-3, +0x1.8ec109b486c49p-1, +-0x1.cb2a3eb6af617p-56, +-0x1p-1, +-0x1.097fc5e39aec5p-3, +0x1.8dc45331698ccp-1, +0x1.1d9fcd83634d7p-57, +-0x1p-1, +-0x1.0e5fd6ca90dffp-3, +0x1.8cc6a75184655p-1, +-0x1.e18b3657e2285p-55, +-0x1p-1, +-0x1.133cc94247758p-3, +0x1.8bc806b151741p-1, +-0x1.2c5e12ed1336dp-55, +-0x1p-1, +-0x1.18169a4acca89p-3, +0x1.8ac871ede1d88p-1, +-0x1.9afaa5b7cfc55p-55, +-0x1p-1, +-0x1.1ced46e61cd1cp-3, +0x1.89c7e9a4dd4aap-1, +0x1.db6ea04a8678fp-55, +-0x1p-1, +-0x1.21c0cc18247fcp-3, +0x1.88c66e7481ba1p-1, +-0x1.5c6228970cf35p-56, +-0x1p-1, +-0x1.269126e6c24e3p-3, +0x1.87c400fba2ebfp-1, +-0x1.2dabc0c3f64cdp-55, +-0x1p-1, +-0x1.2b5e5459c8bc3p-3, +0x1.86c0a1d9aa195p-1, +0x1.84564f09c3726p-59, +-0x1p-1, +-0x1.3028517b0001p-3, +0x1.85bc51ae958ccp-1, +0x1.45ba6478086ccp-55, +-0x1p-1, +-0x1.34ef1b5627dfdp-3, +0x1.84b7111af83fap-1, +-0x1.63a47df0b21bap-55, +-0x1p-1, +-0x1.39b2aef8f97a4p-3, +0x1.83b0e0bff976ep-1, +-0x1.6f420f8ea3475p-56, +-0x1p-1, +-0x1.3e73097329219p-3, +0x1.82a9c13f545ffp-1, +-0x1.65e87a7a8cde9p-56, +-0x1p-1, +-0x1.433027d66826dp-3, +0x1.81a1b33b57accp-1, +-0x1.5dea12d66bb66p-55, +-0x1p-1, +-0x1.47ea073666a98p-3, +0x1.8098b756e52fap-1, +0x1.9136e834b4707p-55, +-0x1p-1, +-0x1.4ca0a4a8d5657p-3, +0x1.7f8ece3571771p-1, +-0x1.9c8d8ce93c917p-55, +-0x1p-1, +-0x1.5153fd45677efp-3, +0x1.7e83f87b03686p-1, +0x1.b61a8ccabad6p-57, +-0x1p-1, +-0x1.56040e25d44ddp-3, +0x1.7d7836cc33db2p-1, +0x1.162715ef03f85p-56, +-0x1p-1, +-0x1.5ab0d465d927ap-3, +0x1.7c6b89ce2d333p-1, +-0x1.cfd628084982cp-56, +-0x1p-1, +-0x1.5f5a4d233b27fp-3, +0x1.7b5df226aafafp-1, +-0x1.0f537acdf0ad7p-56, +-0x1p-1, +-0x1.6400757dc8f7dp-3, +0x1.7a4f707bf97d2p-1, +0x1.3c9751b491eafp-55, +-0x1p-1, +-0x1.68a34a975c941p-3, +0x1.79400574f55e5p-1, +-0x1.0adadbdb4c65ap-55, +-0x1p-1, +-0x1.6d42c993dd121p-3, +0x1.782fb1b90b35bp-1, +-0x1.3e46c1dfd001cp-55, +-0x1p-1, +-0x1.71deef9940631p-3, +0x1.771e75f037261p-1, +0x1.5cfce8d84068fp-56, +-0x1p-1, +-0x1.7677b9cf8d17p-3, +0x1.760c52c304764p-1, +-0x1.11d76f8e50f1fp-55, +-0x1p-1, +-0x1.7b0d2560dc1d1p-3, +0x1.74f948da8d28dp-1, +0x1.19900a3b9a3a2p-63, +-0x1p-1, +-0x1.7f9f2f795a83ep-3, +0x1.73e558e079942p-1, +-0x1.2663126697f5ep-55, +-0x1p-1, +-0x1.842dd5474b37bp-3, +0x1.72d0837efff96p-1, +0x1.0d4ef0f1d915cp-55, +-0x1p-1, +-0x1.88b913fb08bfdp-3, +0x1.71bac960e41bfp-1, +-0x1.b858d90b0f7d8p-56, +-0x1p-1, +-0x1.8d40e8c706fa4p-3, +0x1.70a42b3176d7ap-1, +-0x1.d9e3fbe2e15ap-56, +-0x1p-1, +-0x1.91c550dfd4d6bp-3, +0x1.6f8ca99c95b75p-1, +0x1.f22e7a35723f4p-56, +-0x1p-1, +-0x1.9646497c1e0f6p-3, +0x1.6e74454eaa8afp-1, +-0x1.dbc03c84e226ep-55, +-0x1p-1, +-0x1.9ac3cfd4ace19p-3, +0x1.6d5afef4aafcdp-1, +-0x1.868a696b8835ep-55, +-0x1p-1, +-0x1.9f3de1246bc4p-3, +0x1.6c40d73c18275p-1, +0x1.25d4f802be257p-57, +-0x1p-1, +-0x1.a3b47aa8671c5p-3, +0x1.6b25ced2fe29cp-1, +-0x1.5ac64116beda5p-55, +-0x1p-1, +0, +0x1.6a09e667f3bcdp-1, +-0x1.bdd3413b26456p-55, +0, +0x1.29b4625a03ac9p-2, +0x1.68ed1eaa19c71p-1, +0x1.fd4a85350f69p-56, +-0x1p0, +0x1.277e5187cfb16p-2, +0x1.67cf78491af1p-1, +0x1.750ab23477b61p-59, +-0x1p0, +0x1.254a0216aa067p-2, +0x1.66b0f3f52b386p-1, +0x1.1e2eb31a8848bp-55, +-0x1p0, +0x1.23177562aaea3p-2, +0x1.6591925f0783dp-1, +0x1.c3d64fbf5de23p-55, +-0x1p0, +0x1.20e6acc6d4916p-2, +0x1.64715437f535bp-1, +-0x1.7c399c15a17dp-55, +-0x1p0, +0x1.1eb7a99d1250cp-2, +0x1.63503a31c1be9p-1, +0x1.1248f09e6587cp-57, +-0x1p0, +0x1.1c8a6d3e37c82p-2, +0x1.622e44fec22ffp-1, +0x1.f98d8be132d57p-56, +-0x1p0, +0x1.1a5ef902000d3p-2, +0x1.610b7551d2cdfp-1, +-0x1.251b352ff2a37p-56, +-0x1p0, +0x1.18354e3f0cd7dp-2, +0x1.5fe7cbde56a1p-1, +-0x1.fcb9cc30cc01ep-55, +-0x1p0, +0x1.160d6e4ae5ae6p-2, +0x1.5ec3495837074p-1, +0x1.dea89a9b8f727p-56, +-0x1p0, +0x1.13e75a79f7139p-2, +0x1.5d9dee73e345cp-1, +-0x1.de1165ecdf7a3p-57, +-0x1p0, +0x1.11c3141f91b3ep-2, +0x1.5c77bbe65018cp-1, +0x1.069ea9c0bc32ap-55, +-0x1p0, +0x1.0fa09c8de994bp-2, +0x1.5b50b264f7448p-1, +0x1.519d30d4cfebp-56, +-0x1p0, +0x1.0d7ff51615437p-2, +0x1.5a28d2a5d725p-1, +0x1.57a25f8b1343p-55, +-0x1p0, +0x1.0b611f080d05bp-2, +0x1.59001d5f723dfp-1, +0x1.a9f86ba0dde98p-56, +-0x1p0, +0x1.09441bb2aa0a2p-2, +0x1.57d69348cecap-1, +-0x1.75720992bfbb2p-55, +-0x1p0, +0x1.0728ec63a599ap-2, +0x1.56ac35197649fp-1, +-0x1.f7874188cb279p-55, +-0x1p0, +0x1.050f92679849cp-2, +0x1.5581038975137p-1, +0x1.4570d9efe26dfp-55, +-0x1p0, +0x1.02f80f09f92f4p-2, +0x1.5454ff5159dfcp-1, +-0x1.4e247588bf256p-55, +-0x1p0, +0x1.00e263951d11fp-2, +0x1.5328292a35596p-1, +-0x1.a12eb89da0257p-56, +-0x1p0, +0x1.fd9d22a46b416p-3, +0x1.51fa81cd99aa6p-1, +-0x1.499f59d8560e9p-63, +-0x1p0, +0x1.f9793312a14d1p-3, +0x1.50cc09f59a09bp-1, +0x1.693463a2c2e6fp-56, +-0x1p0, +0x1.f558fb02ae805p-3, +0x1.4f9cc25cca486p-1, +0x1.48b5951cfc2b5p-55, +-0x1p0, +0x1.f13c7d001a249p-3, +0x1.4e6cabbe3e5e9p-1, +0x1.3c293edceb327p-57, +-0x1p0, +0x1.ed23bb941f019p-3, +0x1.4d3bc6d589f7fp-1, +0x1.6e4d9d6b72011p-55, +-0x1p0, +0x1.e90eb945a9ccfp-3, +0x1.4c0a145ec0004p-1, +0x1.2630cfafceaa1p-58, +-0x1p0, +0x1.e4fd7899579acp-3, +0x1.4ad79516722f1p-1, +-0x1.1273b163000f7p-55, +-0x1p0, +0x1.e0effc1174505p-3, +0x1.49a449b9b0939p-1, +-0x1.27ee16d719b94p-55, +-0x1p0, +0x1.dce6462df917dp-3, +0x1.48703306091ffp-1, +-0x1.70813b86159fdp-57, +-0x1p0, +0x1.d8e0596c8ad56p-3, +0x1.473b51b987347p-1, +0x1.ca1953514e41bp-57, +-0x1p0, +0x1.d4de3848789e2p-3, +0x1.4605a692b32a2p-1, +0x1.21ca219b97107p-55, +-0x1p0, +0x1.d0dfe53aba2fdp-3, +0x1.44cf325091dd6p-1, +0x1.8076a2cfdc6b3p-57, +-0x1p0, +0x1.cce562b9ee6aep-3, +0x1.4397f5b2a438p-1, +-0x1.7274c9e48c226p-55, +-0x1p0, +0x1.c8eeb33a59cdp-3, +0x1.425ff178e6bb1p-1, +0x1.7b38d675140cap-55, +-0x1p0, +0x1.c4fbd92de4eddp-3, +0x1.41272663d108cp-1, +0x1.1bbe7636fadf5p-55, +-0x1p0, +0x1.c10cd7041afccp-3, +0x1.3fed9534556d4p-1, +0x1.36916608c5061p-55, +-0x1p0, +0x1.bd21af2a28408p-3, +0x1.3eb33eabe068p-1, +0x1.86a2357d1a0d3p-58, +-0x1p0, +0x1.b93a640ad8978p-3, +0x1.3d78238c58344p-1, +-0x1.0219f5f0f79cep-55, +-0x1p0, +0x1.b556f80e95facp-3, +0x1.3c3c44981c518p-1, +-0x1.b5e9a9644151bp-55, +-0x1p0, +0x1.b1776d9b67013p-3, +0x1.3affa292050b9p-1, +0x1.e3e25e3954964p-56, +-0x1p0, +0x1.ad9bc714ed64fp-3, +0x1.39c23e3d63029p-1, +-0x1.3b05b276085c1p-58, +-0x1p0, +0x1.a9c406dc648a5p-3, +0x1.3884185dfeb22p-1, +-0x1.a038026abe6b2p-56, +-0x1p0, +0x1.a5f02f50a007cp-3, +0x1.374531b817f8dp-1, +0x1.444d2b0a747fep-55, +-0x1p0, +0x1.a22042ce0a2f9p-3, +0x1.36058b10659f3p-1, +-0x1.1fcb3a35857e7p-55, +-0x1p0, +0x1.9e5443aea29b2p-3, +0x1.34c5252c14de1p-1, +0x1.583f49632ab2bp-55, +-0x1p0, +0x1.9a8c3449fcb77p-3, +0x1.338400d0c8e57p-1, +-0x1.abf2a5e95e6e5p-55, +-0x1p0, +0x1.96c816f53e539p-3, +0x1.32421ec49a61fp-1, +0x1.65e25cc951bfep-55, +-0x1p0, +0x1.9307ee031e2fdp-3, +0x1.30ff7fce17035p-1, +-0x1.efcc626f74a6fp-57, +-0x1p0, +0x1.8f4bbbc3e28f6p-3, +0x1.2fbc24b441015p-1, +0x1.dba4875410874p-57, +-0x1p0, +0x1.8b9382855fcaap-3, +0x1.2e780e3e8ea17p-1, +-0x1.b19fafe36587ap-55, +-0x1p0, +0x1.87df4492f6e38p-3, +0x1.2d333d34e9bb8p-1, +-0x1.0e2c2c5549e26p-55, +-0x1p0, +0x1.842f0435941afp-3, +0x1.2bedb25faf3eap-1, +-0x1.14981c796ee46p-58, +-0x1p0, +0x1.8082c3b3ad887p-3, +0x1.2aa76e87aeb58p-1, +0x1.fd600833287a7p-59, +-0x1p0, +0x1.7cda855141b26p-3, +0x1.2960727629ca8p-1, +0x1.56d6c7af02d5cp-56, +-0x1p0, +0x1.79364b4fd6288p-3, +0x1.2818bef4d3cbap-1, +-0x1.e3fffeb76568ap-56, +-0x1p0, +0x1.759617ee761f9p-3, +0x1.26d054cdd12dfp-1, +-0x1.5da743ef3770cp-55, +-0x1p0, +0x1.71f9ed69b10eap-3, +0x1.258734cbb711p-1, +0x1.3a3f0903ce09dp-57, +-0x1p0, +0x1.6e61cdfb994dfp-3, +0x1.243d5fb98ac1fp-1, +0x1.c533d0a284a8dp-56, +-0x1p0, +0x1.6acdbbdbc2b73p-3, +0x1.22f2d662c13e2p-1, +-0x1.d5cc7580cb6d2p-55, +-0x1p0, +0x1.673db93f41479p-3, +0x1.21a799933eb59p-1, +-0x1.3a7b177c68fb2p-55, +-0x1p0, +0x1.63b1c858a7c2ep-3, +0x1.205baa17560d6p-1, +0x1.b7b144016c7a3p-56, +-0x1p0, +0x1.6029eb580658ep-3, +0x1.1f0f08bbc861bp-1, +-0x1.10d9dcafb74cbp-57, +-0x1p0, +0x1.5ca6246ae94b8p-3, +0x1.1dc1b64dc4872p-1, +0x1.f15e1c468be78p-57, +-0x1p0, +0x1.592675bc57974p-3, +0x1.1c73b39ae68c8p-1, +0x1.b25dd267f66p-55, +-0x1p0, +0x1.55aae174d19c8p-3, +0x1.1b250171373bfp-1, +-0x1.b210e95e1ca4cp-55, +-0x1p0, +0x1.523369ba4fcaep-3, +0x1.19d5a09f2b9b8p-1, +-0x1.33656c68a1d4ap-57, +-0x1p0, +0x1.4ec010b0414e1p-3, +0x1.188591f3a46e5p-1, +-0x1.bbefe5a524346p-56, +-0x1p0, +0x1.4b50d8778abbdp-3, +0x1.1734d63dedb49p-1, +-0x1.7eef2ccc50575p-55, +-0x1p0, +0x1.47e5c32e84c45p-3, +0x1.15e36e4dbe2bcp-1, +0x1.3c545f7d79eaep-56, +-0x1p0, +0x1.447ed2f0fae31p-3, +0x1.14915af336cebp-1, +0x1.f3660558a0213p-56, +-0x1p0, +0x1.411c09d82a128p-3, +0x1.133e9cfee254fp-1, +-0x1.a1377cfd5ce5p-56, +-0x1p0, +0x1.3dbd69fabf802p-3, +0x1.11eb3541b4b23p-1, +-0x1.ef23b69abe4f1p-55, +-0x1p0, +0x1.3a62f56cd742ep-3, +0x1.1097248d0a957p-1, +-0x1.7a58759ba80ddp-55, +-0x1p0, +0x1.370cae3ffb12fp-3, +0x1.0f426bb2a8e7ep-1, +-0x1.bb58fb774f8eep-55, +-0x1p0, +0x1.33ba968321032p-3, +0x1.0ded0b84bc4b6p-1, +-0x1.8540fa327c55cp-55, +-0x1p0, +0x1.306cb042aa3bap-3, +0x1.0c9704d5d898fp-1, +-0x1.8d3d7de6ee9b2p-55, +-0x1p0, +0x1.2d22fd8861b6bp-3, +0x1.0b405878f85ecp-1, +-0x1.ad66c3bb80da5p-55, +-0x1p0, +0x1.29dd805b7afecp-3, +0x1.09e907417c5e1p-1, +-0x1.fe573741a9bd4p-55, +-0x1p0, +0x1.269c3ac090ee4p-3, +0x1.089112032b08cp-1, +0x1.3248ddf9fe619p-57, +-0x1p0, +0x1.235f2eb9a470ap-3, +0x1.073879922ffeep-1, +-0x1.a5a014347406cp-55, +-0x1p0, +0x1.20265e461b45ap-3, +0x1.05df3ec31b8b7p-1, +-0x1.e2dcad34d9c1dp-57, +-0x1p0, +0x1.1cf1cb62bec5dp-3, +0x1.0485626ae221ap-1, +0x1.b937d9091ff7p-55, +-0x1p0, +0x1.19c17809baa87p-3, +0x1.032ae55edbd96p-1, +-0x1.bdb022b40107ap-55, +-0x1p0, +0x1.169566329bcb7p-3, +0x1.01cfc874c3eb7p-1, +-0x1.34a35e7c2368cp-56, +-0x1p0, +0x1.136d97d24efccp-3, +0x1.00740c82b82e1p-1, +-0x1.6d48563c60e87p-55, +-0x1p0, +0x1.104a0edb1fc58p-3, +0x1.fe2f64be7121p-2, +-0x1.297ab1ca2d7dbp-56, +-0x1p0, +0x1.0d2acd3cb7364p-3, +0x1.fb7575c24d2dep-2, +-0x1.5bfdc883c8664p-57, +-0x1p0, +0x1.0a0fd4e41ab5ap-3, +0x1.f8ba4dbf89abap-2, +-0x1.2ec1fc1b776b8p-60, +-0x1p0, +0x1.06f927bbaacfep-3, +0x1.f5fdee656cda3p-2, +-0x1.7bf9780816b05p-58, +-0x1p0, +0x1.03e6c7ab2208cp-3, +0x1.f3405963fd067p-2, +0x1.06846d44a238fp-56, +-0x1p0, +0x1.00d8b69793ae4p-3, +0x1.f081906bff7fep-2, +-0x1.4cab2d4ff6fccp-56, +-0x1p0, +0x1.fb9decc6d55b8p-4, +0x1.edc1952ef78d6p-2, +-0x1.dd0f7c33edee6p-56, +-0x1p0, +0x1.f59311dcd0d44p-4, +0x1.eb00695f2562p-2, +0x1.53c9fd3083e22p-56, +-0x1p0, +0x1.ef90e02b47283p-4, +0x1.e83e0eaf85114p-2, +-0x1.7bc380ef24ba7p-57, +-0x1p0, +0x1.e9975b670e077p-4, +0x1.e57a86d3cd825p-2, +-0x1.2c80dcd511e87p-57, +-0x1p0, +0x1.e3a6873fa1279p-4, +0x1.e2b5d3806f63bp-2, +0x1.e0d891d3c6841p-58, +-0x1p0, +0x1.ddbe675f1ffdfp-4, +0x1.dfeff66a941dep-2, +-0x1.a756c6e625f96p-56, +-0x1p0, +0x1.d7deff6a4b7c9p-4, +0x1.dd28f1481cc58p-2, +-0x1.e7576fa6c944ep-59, +-0x1p0, +0x1.d208530083d3p-4, +0x1.da60c5cfa10d9p-2, +-0x1.0f38e2143c8d5p-57, +-0x1p0, +0x1.cc3a65bbc6327p-4, +0x1.d79775b86e389p-2, +0x1.550ec87bc0575p-56, +-0x1p0, +0x1.c6753b30aa949p-4, +0x1.d4cd02ba8609dp-2, +-0x1.37f33c63033d6p-57, +-0x1p0, +0x1.c0b8d6ee61867p-4, +0x1.d2016e8e9db5bp-2, +-0x1.c8bce9d93efb8p-57, +-0x1p0, +0x1.bb053c7eb1f68p-4, +0x1.cf34baee1cd21p-2, +-0x1.118724d19d014p-56, +-0x1p0, +0x1.b55a6f65f7058p-4, +0x1.cc66e9931c45ep-2, +0x1.6850e59c37f8fp-58, +-0x1p0, +0x1.afb873231ddb9p-4, +0x1.c997fc3865389p-2, +-0x1.6295f8b0ca33bp-56, +-0x1p0, +0x1.aa1f4b2fa37fcp-4, +0x1.c6c7f4997000bp-2, +-0x1.bec2669c68e74p-56, +-0x1p0, +0x1.a48efaff92b3bp-4, +0x1.c3f6d47263129p-2, +0x1.9c7bd0fcdecddp-56, +-0x1p0, +0x1.9f07860181d1ep-4, +0x1.c1249d8011ee7p-2, +-0x1.813aabb515206p-56, +-0x1p0, +0x1.9988ef9e90b04p-4, +0x1.be51517ffc0d9p-2, +0x1.2b667131a5f16p-56, +-0x1p0, +0x1.94133b3a66851p-4, +0x1.bb7cf2304bd01p-2, +0x1.9e1a5bd9269d4p-57, +-0x1p0, +0x1.8ea66c332fd01p-4, +0x1.b8a7814fd5693p-2, +0x1.9a9e6651cc119p-56, +-0x1p0, +0x1.894285e19c468p-4, +0x1.b5d1009e15ccp-2, +0x1.5b362cb974183p-57, +-0x1p0, +0x1.83e78b98dcc2bp-4, +0x1.b2f971db31972p-2, +0x1.fa971a4a41f2p-56, +-0x1p0, +0x1.7e9580a6a136ep-4, +0x1.b020d6c7f4009p-2, +0x1.414ae7e555208p-58, +-0x1p0, +0x1.794c685316a3cp-4, +0x1.ad473125cdc09p-2, +-0x1.379ede57649dap-58, +-0x1p0, +0x1.740c45e0e512p-4, +0x1.aa6c82b6d3fcap-2, +-0x1.d5f106ee5ccf7p-56, +-0x1p0, +0x1.6ed51c8d2d8fcp-4, +0x1.a790cd3dbf31bp-2, +-0x1.7f786986d9023p-57, +-0x1p0, +0x1.69a6ef8f8830ap-4, +0x1.a4b4127dea1e5p-2, +-0x1.bec6f01bc22f1p-56, +-0x1p0, +0x1.6481c21a02123p-4, +0x1.a1d6543b50acp-2, +-0x1.0246cfd8779fbp-57, +-0x1p0, +0x1.5f6597591b633p-4, +0x1.9ef7943a8ed8ap-2, +0x1.6da81290bdbabp-57, +-0x1p0, +0x1.5a527273c56e1p-4, +0x1.9c17d440df9f2p-2, +0x1.923c540a9eec4p-57, +-0x1p0, +0x1.5548568b60a7bp-4, +0x1.993716141bdffp-2, +-0x1.15e8cce261c55p-56, +-0x1p0, +0x1.504746bbbac0bp-4, +0x1.96555b7ab948fp-2, +0x1.7afd51eff33adp-56, +-0x1p0, +0x1.4b4f461b0cbaap-4, +0x1.9372a63bc93d7p-2, +0x1.684319e5ad5b1p-57, +-0x1p0, +0x1.466057b9f900ap-4, +0x1.908ef81ef7bd1p-2, +0x1.4c00267012357p-56, +-0x1p0, +0x1.417a7ea389835p-4, +0x1.8daa52ec8a4bp-2, +-0x1.72eb2db8c621ep-57, +-0x1p0, +0x1.3c9dbddd2dd84p-4, +0x1.8ac4b86d5ed44p-2, +0x1.17fa7f944ad5bp-56, +-0x1p0, +0x1.37ca1866b95cfp-4, +0x1.87de2a6aea963p-2, +-0x1.72cedd3d5a61p-57, +-0x1p0, +0x1.32ff913a615dp-4, +0x1.84f6aaaf3903fp-2, +0x1.6dcdc2bd47067p-57, +-0x1p0, +0x1.2e3e2b4cbb3c3p-4, +0x1.820e3b04eaac4p-2, +-0x1.92379eb01c6b6p-59, +-0x1p0, +0x1.2985e98cbaa3ap-4, +0x1.7f24dd37341e4p-2, +0x1.2791a1b5eb796p-57, +-0x1p0, +0x1.24d6cee3afb2ap-4, +0x1.7c3a9311dcce7p-2, +0x1.9a3f21ef3e8d9p-62, +-0x1p0, +0x1.2030de354532cp-4, +0x1.794f5e613dfaep-2, +0x1.820a4b0d21fc5p-57, +-0x1p0, +0x1.1b941a5f7ecffp-4, +0x1.766340f2418f6p-2, +0x1.2b2adc9041b2cp-56, +-0x1p0, +0x1.1700863ab7533p-4, +0x1.73763c9261092p-2, +-0x1.52324face3b1ap-57, +-0x1p0, +0x1.127624999ee1dp-4, +0x1.7088530fa459fp-2, +-0x1.44b19e0864c5dp-56, +-0x1p0, +0x1.0df4f849393f5p-4, +0x1.6d998638a0cb6p-2, +-0x1.1ca14532860dfp-61, +-0x1p0, +0x1.097d0410dc132p-4, +0x1.6aa9d7dc77e17p-2, +-0x1.38b470592c7b3p-56, +-0x1p0, +0x1.050e4ab22d321p-4, +0x1.67b949cad63cbp-2, +-0x1.a23369348d7efp-56, +-0x1p0, +0x1.00a8cee920eabp-4, +0x1.64c7ddd3f27c6p-2, +0x1.10d2b4a664121p-58, +-0x1p0, +0x1.f89926d7f0ab8p-5, +0x1.61d595c88c202p-2, +0x1.f6b1e333415d7p-56, +-0x1p0, +0x1.eff335d67f541p-5, +0x1.5ee27379ea693p-2, +0x1.634ff2fa75245p-56, +-0x1p0, +0x1.e75fd0239926cp-5, +0x1.5bee78b9db3b6p-2, +0x1.e734a63158dfdp-58, +-0x1p0, +0x1.dedefb09791b4p-5, +0x1.58f9a75ab1fddp-2, +-0x1.efdc0d58cf62p-62, +-0x1p0, +0x1.d670bbc6e685ep-5, +0x1.5604012f467b4p-2, +0x1.a0e0b2a5b25p-56, +-0x1p0, +0x1.ce15178f31db3p-5, +0x1.530d880af3c24p-2, +-0x1.fab8e2103fbd6p-56, +-0x1p0, +0x1.c5cc138a317afp-5, +0x1.50163dc197048p-2, +-0x1.ec66cb05c7ea4p-56, +-0x1p0, +0x1.bd95b4d43e819p-5, +0x1.4d1e24278e76ap-2, +0x1.2417218792858p-57, +-0x1p0, +0x1.b572007e31a1bp-5, +0x1.4a253d11b82f3p-2, +-0x1.2afa4d6d42a55p-58, +-0x1p0, +0x1.ad60fb8d6003ap-5, +0x1.472b8a5571054p-2, +-0x1.01ea0fe4dff23p-56, +-0x1p0, +0x1.a562aafb982cdp-5, +0x1.44310dc8936fp-2, +0x1.8b694e91d3125p-56, +-0x1p0, +0x1.9d7713b71eee1p-5, +0x1.4135c94176601p-2, +0x1.0c97c4afa2518p-56, +-0x1p0, +0x1.959e3aa2ac58dp-5, +0x1.3e39be96ec271p-2, +0x1.814c6de9aaaf6p-56, +-0x1p0, +0x1.8dd8249568bbbp-5, +0x1.3b3cefa0414b7p-2, +0x1.f36dc4a9c2294p-56, +-0x1p0, +0x1.8624d65ae9a63p-5, +0x1.383f5e353b6abp-2, +-0x1.a812a4a5c3d44p-56, +-0x1p0, +0x1.7e8454b32ef34p-5, +0x1.35410c2e18152p-2, +-0x1.3cb002f96e062p-56, +-0x1p0, +0x1.76f6a4529fdb5p-5, +0x1.3241fb638baafp-2, +0x1.ecee8f76f8c51p-60, +-0x1p0, +0x1.6f7bc9e2080d9p-5, +0x1.2f422daec0387p-2, +-0x1.7501ba473da6fp-56, +-0x1p0, +0x1.6813c9fe94cfbp-5, +0x1.2c41a4e95452p-2, +0x1.9cf0354aad2dcp-56, +-0x1p0, +0x1.60bea939d225ap-5, +0x1.294062ed59f06p-2, +-0x1.5d28da2c4612dp-56, +-0x1p0, +0x1.597c6c19a8003p-5, +0x1.263e6995554bap-2, +0x1.1d350ffc5ff32p-56, +-0x1p0, +0x1.524d171857726p-5, +0x1.233bbabc3bb71p-2, +0x1.99b04e23259efp-56, +-0x1p0, +0x1.4b30aea477eeep-5, +0x1.2038583d727bep-2, +-0x1.c69cd46300a3p-57, +-0x1p0, +0x1.44273720f48bcp-5, +0x1.1d3443f4cdb3ep-2, +-0x1.720d41c13519ep-57, +-0x1p0, +0x1.3d30b4e5094ep-5, +0x1.1a2f7fbe8f243p-2, +0x1.6465ac86ba7b2p-56, +-0x1p0, +0x1.364d2c3c407bep-5, +0x1.172a0d7765177p-2, +0x1.22575f33366bep-57, +-0x1p0, +0x1.2f7ca1666ff6fp-5, +0x1.1423eefc69378p-2, +0x1.22d3368ec9b62p-56, +-0x1p0, +0x1.28bf1897b69ccp-5, +0x1.111d262b1f677p-2, +0x1.824c20ab7aa9ap-56, +-0x1p0, +0x1.221495f879af5p-5, +0x1.0e15b4e1749cep-2, +-0x1.5b7fb156c550ap-56, +-0x1p0, +0x1.1b7d1da562443p-5, +0x1.0b0d9cfdbdb9p-2, +0x1.3b3a7b8d1200dp-58, +-0x1p0, +0x1.14f8b3af5abb9p-5, +0x1.0804e05eb661ep-2, +0x1.54e583d92d3d8p-56, +-0x1p0, +0x1.0e875c1b8c3dap-5, +0x1.04fb80e37fdaep-2, +-0x1.412cdb72583ccp-63, +-0x1p0, +0x1.08291ae35c407p-5, +0x1.01f1806b9fdd2p-2, +-0x1.448135394b8bap-56, +-0x1p0, +0x1.01ddf3f46a139p-5, +0x1.fdcdc1adfedf9p-3, +-0x1.2dba4580ed7bbp-57, +-0x1p0, +0x1.f74bd66118e8dp-6, +0x1.f7b7480bd3802p-3, +-0x1.9a96d967ee12ep-57, +-0x1p0, +0x1.eb0208db9e51bp-6, +0x1.f19f97b215f1bp-3, +-0x1.42deef11da2c4p-57, +-0x1p0, +0x1.dede86ece142ep-6, +0x1.eb86b462de348p-3, +-0x1.bfcde46f90b62p-57, +-0x1p0, +0x1.d2e15811bf462p-6, +0x1.e56ca1e101a1bp-3, +0x1.46ac3f9fd0227p-57, +-0x1p0, +0x1.c70a83af71ef5p-6, +0x1.df5163f01099ap-3, +-0x1.01f7d79906e86p-57, +-0x1p0, +0x1.bb5a11138a4c9p-6, +0x1.d934fe5454311p-3, +0x1.75b92277107adp-57, +-0x1p0, +0x1.afd00773ec64fp-6, +0x1.d31774d2cbdeep-3, +0x1.2fdc8e5791a0bp-57, +-0x1p0, +0x1.a46c6deecac5fp-6, +0x1.ccf8cb312b286p-3, +0x1.2382b0aecadf8p-58, +-0x1p0, +0x1.992f4b8aa21f8p-6, +0x1.c6d90535d74ddp-3, +-0x1.bfb2be2264962p-59, +-0x1p0, +0x1.8e18a73634ee7p-6, +0x1.c0b826a7e4f63p-3, +-0x1.af1439e521935p-62, +-0x1p0, +0x1.832887c88735dp-6, +0x1.ba96334f15dadp-3, +-0x1.75098c05dd18ap-57, +-0x1p0, +0x1.785ef400da46cp-6, +0x1.b4732ef3d6722p-3, +0x1.bbe5d5d75cbd8p-57, +-0x1p0, +0x1.6dbbf286a8971p-6, +0x1.ae4f1d5f3b9abp-3, +0x1.aa8bbcef9b68ep-57, +-0x1p0, +0x1.633f89e9a1a66p-6, +0x1.a82a025b00451p-3, +-0x1.87905ffd084adp-57, +-0x1p0, +0x1.58e9c0a1a5f21p-6, +0x1.a203e1b1831dap-3, +0x1.c1aadb580a1ecp-58, +-0x1p0, +0x1.4eba9d0ec2f7cp-6, +0x1.9bdcbf2dc4366p-3, +0x1.9632d189956fep-57, +-0x1p0, +0x1.44b225792f46bp-6, +0x1.95b49e9b62afap-3, +-0x1.100b3d1dbfeaap-59, +-0x1p0, +0x1.3ad06011469fbp-6, +0x1.8f8b83c69a60bp-3, +-0x1.26d19b9ff8d82p-57, +-0x1p0, +0x1.311552ef8623cp-6, +0x1.8961727c41804p-3, +0x1.3fdab4e42640ap-58, +-0x1p0, +0x1.278104148891ap-6, +0x1.83366e89c64c6p-3, +-0x1.192952df10db8p-57, +-0x1p0, +0x1.1e1379690291cp-6, +0x1.7d0a7bbd2cb1cp-3, +-0x1.cf900f27c58efp-57, +-0x1p0, +0x1.14ccb8bdbf114p-6, +0x1.76dd9de50bf31p-3, +0x1.1d5eeec501b2fp-57, +-0x1p0, +0x1.0bacc7cb9babap-6, +0x1.70afd8d08c4ffp-3, +0x1.260c3f1369484p-57, +-0x1p0, +0x1.02b3ac3385232p-6, +0x1.6a81304f64ab2p-3, +0x1.f0cd73fb5d8d4p-58, +-0x1p0, +0x1.f3c2d6fce7cfap-7, +0x1.6451a831d830dp-3, +0x1.ad16031a34d5p-58, +-0x1p0, +0x1.e26c163ad15b3p-7, +0x1.5e214448b3fc6p-3, +0x1.531ff779ddac6p-57, +-0x1p0, +0x1.d16320d2d221ep-7, +0x1.57f008654cbdep-3, +0x1.908c95c4c9118p-58, +-0x1p0, +0x1.c0a80146f894cp-7, +0x1.51bdf8597c5f2p-3, +-0x1.9f9976af04aa5p-61, +-0x1p0, +0x1.b03ac1e94fe1dp-7, +0x1.4b8b17f79fa88p-3, +0x1.b534fe588f0dp-57, +-0x1p0, +0x1.a01b6cdbd995ep-7, +0x1.45576b1293e5ap-3, +-0x1.285a24119f7b1p-58, +-0x1p0, +0x1.904a0c10875cep-7, +0x1.3f22f57db4893p-3, +0x1.bfe7ff2274956p-59, +-0x1p0, +0x1.80c6a94934dfp-7, +0x1.38edbb0cd8d14p-3, +-0x1.198c21fbf7718p-57, +-0x1p0, +0x1.71914e17a1bc6p-7, +0x1.32b7bf94516a7p-3, +0x1.2a24e2431ef29p-57, +-0x1p0, +0x1.62aa03dd6ba58p-7, +0x1.2c8106e8e613ap-3, +0x1.13000a89a11ep-58, +-0x1p0, +0x1.5410d3cc0891ep-7, +0x1.264994dfd3409p-3, +0x1.a744ce26f39cp-57, +-0x1p0, +0x1.45c5c6e4c114ap-7, +0x1.20116d4ec7bcfp-3, +-0x1.242c8e1053452p-57, +-0x1p0, +0x1.37c8e5f8aacep-7, +0x1.19d8940be24e7p-3, +0x1.e8dcdca90cc74p-58, +-0x1p0, +0x1.2a1a39a8a2fb7p-7, +0x1.139f0cedaf577p-3, +-0x1.523434d1b3cfap-57, +-0x1p0, +0x1.1cb9ca654924fp-7, +0x1.0d64dbcb26786p-3, +-0x1.713a562132055p-58, +-0x1p0, +0x1.0fa7a06ef9e81p-7, +0x1.072a047ba831dp-3, +0x1.19db1f70118cap-58, +-0x1p0, +0x1.02e3c3d5c9e17p-7, +0x1.00ee8ad6fb85bp-3, +0x1.673eac8308f11p-58, +-0x1p0, +0x1.ecdc78f30165cp-8, +0x1.f564e56a9730ep-4, +0x1.a2704729ae56dp-59, +-0x1p0, +0x1.d48e24132851p-8, +0x1.e8eb7fde4aa3fp-4, +-0x1.23758f2d5bb8bp-58, +-0x1p0, +0x1.bcdc980a46f5ap-8, +0x1.dc70ecbae9fc9p-4, +0x1.2fda2d73295eep-60, +-0x1p0, +0x1.a5c7e375e55dep-8, +0x1.cff533b307dc1p-4, +0x1.8feeb8f9c3334p-59, +-0x1p0, +0x1.8f501492cc296p-8, +0x1.c3785c79ec2d5p-4, +-0x1.4f39df133fb21p-61, +-0x1p0, +0x1.7975393cfbc4dp-8, +0x1.b6fa6ec38f64cp-4, +0x1.db5d943691f09p-58, +-0x1p0, +0x1.64375eefa3dd6p-8, +0x1.aa7b724495c03p-4, +0x1.e5399ba0967b8p-58, +-0x1p0, +0x1.4f9692c51b0fbp-8, +0x1.9dfb6eb24a85cp-4, +0x1.e96b47b8c44e6p-59, +-0x1p0, +0x1.3b92e176d6d31p-8, +0x1.917a6bc29b42cp-4, +-0x1.e2718d26ed688p-60, +-0x1p0, +0x1.282c575d639fcp-8, +0x1.84f8712c130a1p-4, +-0x1.e626ebafe374ep-58, +-0x1p0, +0x1.156300705d51bp-8, +0x1.787586a5d5b21p-4, +0x1.5f7589f083399p-58, +-0x1p0, +0x1.0336e84667c66p-8, +0x1.6bf1b3e79b129p-4, +-0x1.14b6da08765p-58, +-0x1p0, +0x1.e350342a4f6e6p-9, +0x1.5f6d00a9aa419p-4, +-0x1.f4022d03f6c9ap-59, +-0x1p0, +0x1.c16d4162779e5p-9, +0x1.52e774a4d4d0ap-4, +0x1.b2edf18c730cbp-60, +-0x1p0, +0x1.a0c50d1c6bf93p-9, +0x1.4661179272096p-4, +-0x1.4b109f2406c4cp-58, +-0x1p0, +0x1.8157ab7d29fd9p-9, +0x1.39d9f12c5a299p-4, +0x1.1287ff27ae554p-62, +-0x1p0, +0x1.63252fe77c5ebp-9, +0x1.2d52092ce19f6p-4, +-0x1.9a088a8bf6b2cp-59, +-0x1p0, +0x1.462dacfbef0f3p-9, +0x1.20c9674ed444dp-4, +-0x1.f9d48faba7974p-58, +-0x1p0, +0x1.2a713498c3c3dp-9, +0x1.1440134d709b3p-4, +-0x1.fec446daea6adp-58, +-0x1p0, +0x1.0fefd7d9e6ed8p-9, +0x1.07b614e463064p-4, +-0x1.384f8c3ee7605p-58, +-0x1p0, +0x1.ed534e31ca57fp-10, +0x1.f656e79f820ep-5, +-0x1.2e1ebe392bffep-61, +-0x1p0, +0x1.bd3d63d9c26efp-10, +0x1.dd406f9808ec9p-5, +0x1.1313a4b4068bdp-62, +-0x1p0, +0x1.8f9e0e5514865p-10, +0x1.c428d12c0d7e3p-5, +-0x1.89bc74b58c513p-60, +-0x1p0, +0x1.647569c825ae1p-10, +0x1.ab101bd5f8317p-5, +-0x1.65c6175c6dc68p-59, +-0x1p0, +0x1.3bc390d250439p-10, +0x1.91f65f10dd814p-5, +-0x1.912bd0d569a9p-61, +-0x1p0, +0x1.15889c8dd385fp-10, +0x1.78dbaa5874686p-5, +-0x1.4a0ef4035c29cp-60, +-0x1p0, +0x1.e389491f8833ap-11, +0x1.5fc00d290cd43p-5, +0x1.a2669a693a8e1p-59, +-0x1p0, +0x1.a0ef7dcffafabp-11, +0x1.46a396ff86179p-5, +0x1.136ac00fa2da9p-61, +-0x1p0, +0x1.6344004228d8bp-11, +0x1.2d865759455cdp-5, +0x1.686f65ba93acp-61, +-0x1p0, +0x1.2a86f68094692p-11, +0x1.14685db42c17fp-5, +-0x1.2890d277cb974p-59, +-0x1p0, +0x1.ed71071603e86p-12, +0x1.f693731d1cf01p-6, +-0x1.3fe9bc66286c7p-66, +-0x1p0, +0x1.8fb18eacc3af8p-12, +0x1.c454f4ce53b1dp-6, +-0x1.d63d7fef0e36cp-60, +-0x1p0, +0x1.3bcfbd9979a27p-12, +0x1.92155f7a3667ep-6, +-0x1.b1d63091a013p-64, +-0x1p0, +0x1.e3978f34889d9p-13, +0x1.5fd4d21fab226p-6, +-0x1.0c0a91c37851cp-61, +-0x1p0, +0x1.634bb4ae5ed49p-13, +0x1.2d936bbe30efdp-6, +0x1.b5f91ee371d64p-61, +-0x1p0, +0x1.ed7875885ea3ap-14, +0x1.f6a296ab997cbp-7, +-0x1.f2943d8fe7033p-61, +-0x1p0, +0x1.3bd2c8da49511p-14, +0x1.921d1fcdec784p-7, +0x1.9878ebe836d9dp-61, +-0x1p0, +0x1.634da1cec522dp-15, +0x1.2d96b0e509703p-7, +-0x1.1e9131ff52dc9p-63, +-0x1p0, +0x1.3bd38bab6d94cp-16, +0x1.921f0fe670071p-8, +0x1.ab967fe6b7a9bp-64, +-0x1p0, +0x1.3bd3bc5fc5ab4p-18, +0x1.921f8becca4bap-9, +0x1.2ba407bcab5b2p-63, +-0x1p0, +0, +0, +0, +-0x1p0, +0x1.3bd3bc5fc5ab4p-18, +-0x1.921f8becca4bap-9, +-0x1.2ba407bcab5b2p-63, +-0x1p0, +0x1.3bd38bab6d94cp-16, +-0x1.921f0fe670071p-8, +-0x1.ab967fe6b7a9bp-64, +-0x1p0, +0x1.634da1cec522dp-15, +-0x1.2d96b0e509703p-7, +0x1.1e9131ff52dc9p-63, +-0x1p0, +0x1.3bd2c8da49511p-14, +-0x1.921d1fcdec784p-7, +-0x1.9878ebe836d9dp-61, +-0x1p0, +0x1.ed7875885ea3ap-14, +-0x1.f6a296ab997cbp-7, +0x1.f2943d8fe7033p-61, +-0x1p0, +0x1.634bb4ae5ed49p-13, +-0x1.2d936bbe30efdp-6, +-0x1.b5f91ee371d64p-61, +-0x1p0, +0x1.e3978f34889d9p-13, +-0x1.5fd4d21fab226p-6, +0x1.0c0a91c37851cp-61, +-0x1p0, +0x1.3bcfbd9979a27p-12, +-0x1.92155f7a3667ep-6, +0x1.b1d63091a013p-64, +-0x1p0, +0x1.8fb18eacc3af8p-12, +-0x1.c454f4ce53b1dp-6, +0x1.d63d7fef0e36cp-60, +-0x1p0, +0x1.ed71071603e86p-12, +-0x1.f693731d1cf01p-6, +0x1.3fe9bc66286c7p-66, +-0x1p0, +0x1.2a86f68094692p-11, +-0x1.14685db42c17fp-5, +0x1.2890d277cb974p-59, +-0x1p0, +0x1.6344004228d8bp-11, +-0x1.2d865759455cdp-5, +-0x1.686f65ba93acp-61, +-0x1p0, +0x1.a0ef7dcffafabp-11, +-0x1.46a396ff86179p-5, +-0x1.136ac00fa2da9p-61, +-0x1p0, +0x1.e389491f8833ap-11, +-0x1.5fc00d290cd43p-5, +-0x1.a2669a693a8e1p-59, +-0x1p0, +0x1.15889c8dd385fp-10, +-0x1.78dbaa5874686p-5, +0x1.4a0ef4035c29cp-60, +-0x1p0, +0x1.3bc390d250439p-10, +-0x1.91f65f10dd814p-5, +0x1.912bd0d569a9p-61, +-0x1p0, +0x1.647569c825ae1p-10, +-0x1.ab101bd5f8317p-5, +0x1.65c6175c6dc68p-59, +-0x1p0, +0x1.8f9e0e5514865p-10, +-0x1.c428d12c0d7e3p-5, +0x1.89bc74b58c513p-60, +-0x1p0, +0x1.bd3d63d9c26efp-10, +-0x1.dd406f9808ec9p-5, +-0x1.1313a4b4068bdp-62, +-0x1p0, +0x1.ed534e31ca57fp-10, +-0x1.f656e79f820ep-5, +0x1.2e1ebe392bffep-61, +-0x1p0, +0x1.0fefd7d9e6ed8p-9, +-0x1.07b614e463064p-4, +0x1.384f8c3ee7605p-58, +-0x1p0, +0x1.2a713498c3c3dp-9, +-0x1.1440134d709b3p-4, +0x1.fec446daea6adp-58, +-0x1p0, +0x1.462dacfbef0f3p-9, +-0x1.20c9674ed444dp-4, +0x1.f9d48faba7974p-58, +-0x1p0, +0x1.63252fe77c5ebp-9, +-0x1.2d52092ce19f6p-4, +0x1.9a088a8bf6b2cp-59, +-0x1p0, +0x1.8157ab7d29fd9p-9, +-0x1.39d9f12c5a299p-4, +-0x1.1287ff27ae554p-62, +-0x1p0, +0x1.a0c50d1c6bf93p-9, +-0x1.4661179272096p-4, +0x1.4b109f2406c4cp-58, +-0x1p0, +0x1.c16d4162779e5p-9, +-0x1.52e774a4d4d0ap-4, +-0x1.b2edf18c730cbp-60, +-0x1p0, +0x1.e350342a4f6e6p-9, +-0x1.5f6d00a9aa419p-4, +0x1.f4022d03f6c9ap-59, +-0x1p0, +0x1.0336e84667c66p-8, +-0x1.6bf1b3e79b129p-4, +0x1.14b6da08765p-58, +-0x1p0, +0x1.156300705d51bp-8, +-0x1.787586a5d5b21p-4, +-0x1.5f7589f083399p-58, +-0x1p0, +0x1.282c575d639fcp-8, +-0x1.84f8712c130a1p-4, +0x1.e626ebafe374ep-58, +-0x1p0, +0x1.3b92e176d6d31p-8, +-0x1.917a6bc29b42cp-4, +0x1.e2718d26ed688p-60, +-0x1p0, +0x1.4f9692c51b0fbp-8, +-0x1.9dfb6eb24a85cp-4, +-0x1.e96b47b8c44e6p-59, +-0x1p0, +0x1.64375eefa3dd6p-8, +-0x1.aa7b724495c03p-4, +-0x1.e5399ba0967b8p-58, +-0x1p0, +0x1.7975393cfbc4dp-8, +-0x1.b6fa6ec38f64cp-4, +-0x1.db5d943691f09p-58, +-0x1p0, +0x1.8f501492cc296p-8, +-0x1.c3785c79ec2d5p-4, +0x1.4f39df133fb21p-61, +-0x1p0, +0x1.a5c7e375e55dep-8, +-0x1.cff533b307dc1p-4, +-0x1.8feeb8f9c3334p-59, +-0x1p0, +0x1.bcdc980a46f5ap-8, +-0x1.dc70ecbae9fc9p-4, +-0x1.2fda2d73295eep-60, +-0x1p0, +0x1.d48e24132851p-8, +-0x1.e8eb7fde4aa3fp-4, +0x1.23758f2d5bb8bp-58, +-0x1p0, +0x1.ecdc78f30165cp-8, +-0x1.f564e56a9730ep-4, +-0x1.a2704729ae56dp-59, +-0x1p0, +0x1.02e3c3d5c9e17p-7, +-0x1.00ee8ad6fb85bp-3, +-0x1.673eac8308f11p-58, +-0x1p0, +0x1.0fa7a06ef9e81p-7, +-0x1.072a047ba831dp-3, +-0x1.19db1f70118cap-58, +-0x1p0, +0x1.1cb9ca654924fp-7, +-0x1.0d64dbcb26786p-3, +0x1.713a562132055p-58, +-0x1p0, +0x1.2a1a39a8a2fb7p-7, +-0x1.139f0cedaf577p-3, +0x1.523434d1b3cfap-57, +-0x1p0, +0x1.37c8e5f8aacep-7, +-0x1.19d8940be24e7p-3, +-0x1.e8dcdca90cc74p-58, +-0x1p0, +0x1.45c5c6e4c114ap-7, +-0x1.20116d4ec7bcfp-3, +0x1.242c8e1053452p-57, +-0x1p0, +0x1.5410d3cc0891ep-7, +-0x1.264994dfd3409p-3, +-0x1.a744ce26f39cp-57, +-0x1p0, +0x1.62aa03dd6ba58p-7, +-0x1.2c8106e8e613ap-3, +-0x1.13000a89a11ep-58, +-0x1p0, +0x1.71914e17a1bc6p-7, +-0x1.32b7bf94516a7p-3, +-0x1.2a24e2431ef29p-57, +-0x1p0, +0x1.80c6a94934dfp-7, +-0x1.38edbb0cd8d14p-3, +0x1.198c21fbf7718p-57, +-0x1p0, +0x1.904a0c10875cep-7, +-0x1.3f22f57db4893p-3, +-0x1.bfe7ff2274956p-59, +-0x1p0, +0x1.a01b6cdbd995ep-7, +-0x1.45576b1293e5ap-3, +0x1.285a24119f7b1p-58, +-0x1p0, +0x1.b03ac1e94fe1dp-7, +-0x1.4b8b17f79fa88p-3, +-0x1.b534fe588f0dp-57, +-0x1p0, +0x1.c0a80146f894cp-7, +-0x1.51bdf8597c5f2p-3, +0x1.9f9976af04aa5p-61, +-0x1p0, +0x1.d16320d2d221ep-7, +-0x1.57f008654cbdep-3, +-0x1.908c95c4c9118p-58, +-0x1p0, +0x1.e26c163ad15b3p-7, +-0x1.5e214448b3fc6p-3, +-0x1.531ff779ddac6p-57, +-0x1p0, +0x1.f3c2d6fce7cfap-7, +-0x1.6451a831d830dp-3, +-0x1.ad16031a34d5p-58, +-0x1p0, +0x1.02b3ac3385232p-6, +-0x1.6a81304f64ab2p-3, +-0x1.f0cd73fb5d8d4p-58, +-0x1p0, +0x1.0bacc7cb9babap-6, +-0x1.70afd8d08c4ffp-3, +-0x1.260c3f1369484p-57, +-0x1p0, +0x1.14ccb8bdbf114p-6, +-0x1.76dd9de50bf31p-3, +-0x1.1d5eeec501b2fp-57, +-0x1p0, +0x1.1e1379690291cp-6, +-0x1.7d0a7bbd2cb1cp-3, +0x1.cf900f27c58efp-57, +-0x1p0, +0x1.278104148891ap-6, +-0x1.83366e89c64c6p-3, +0x1.192952df10db8p-57, +-0x1p0, +0x1.311552ef8623cp-6, +-0x1.8961727c41804p-3, +-0x1.3fdab4e42640ap-58, +-0x1p0, +0x1.3ad06011469fbp-6, +-0x1.8f8b83c69a60bp-3, +0x1.26d19b9ff8d82p-57, +-0x1p0, +0x1.44b225792f46bp-6, +-0x1.95b49e9b62afap-3, +0x1.100b3d1dbfeaap-59, +-0x1p0, +0x1.4eba9d0ec2f7cp-6, +-0x1.9bdcbf2dc4366p-3, +-0x1.9632d189956fep-57, +-0x1p0, +0x1.58e9c0a1a5f21p-6, +-0x1.a203e1b1831dap-3, +-0x1.c1aadb580a1ecp-58, +-0x1p0, +0x1.633f89e9a1a66p-6, +-0x1.a82a025b00451p-3, +0x1.87905ffd084adp-57, +-0x1p0, +0x1.6dbbf286a8971p-6, +-0x1.ae4f1d5f3b9abp-3, +-0x1.aa8bbcef9b68ep-57, +-0x1p0, +0x1.785ef400da46cp-6, +-0x1.b4732ef3d6722p-3, +-0x1.bbe5d5d75cbd8p-57, +-0x1p0, +0x1.832887c88735dp-6, +-0x1.ba96334f15dadp-3, +0x1.75098c05dd18ap-57, +-0x1p0, +0x1.8e18a73634ee7p-6, +-0x1.c0b826a7e4f63p-3, +0x1.af1439e521935p-62, +-0x1p0, +0x1.992f4b8aa21f8p-6, +-0x1.c6d90535d74ddp-3, +0x1.bfb2be2264962p-59, +-0x1p0, +0x1.a46c6deecac5fp-6, +-0x1.ccf8cb312b286p-3, +-0x1.2382b0aecadf8p-58, +-0x1p0, +0x1.afd00773ec64fp-6, +-0x1.d31774d2cbdeep-3, +-0x1.2fdc8e5791a0bp-57, +-0x1p0, +0x1.bb5a11138a4c9p-6, +-0x1.d934fe5454311p-3, +-0x1.75b92277107adp-57, +-0x1p0, +0x1.c70a83af71ef5p-6, +-0x1.df5163f01099ap-3, +0x1.01f7d79906e86p-57, +-0x1p0, +0x1.d2e15811bf462p-6, +-0x1.e56ca1e101a1bp-3, +-0x1.46ac3f9fd0227p-57, +-0x1p0, +0x1.dede86ece142ep-6, +-0x1.eb86b462de348p-3, +0x1.bfcde46f90b62p-57, +-0x1p0, +0x1.eb0208db9e51bp-6, +-0x1.f19f97b215f1bp-3, +0x1.42deef11da2c4p-57, +-0x1p0, +0x1.f74bd66118e8dp-6, +-0x1.f7b7480bd3802p-3, +0x1.9a96d967ee12ep-57, +-0x1p0, +0x1.01ddf3f46a139p-5, +-0x1.fdcdc1adfedf9p-3, +0x1.2dba4580ed7bbp-57, +-0x1p0, +0x1.08291ae35c407p-5, +-0x1.01f1806b9fdd2p-2, +0x1.448135394b8bap-56, +-0x1p0, +0x1.0e875c1b8c3dap-5, +-0x1.04fb80e37fdaep-2, +0x1.412cdb72583ccp-63, +-0x1p0, +0x1.14f8b3af5abb9p-5, +-0x1.0804e05eb661ep-2, +-0x1.54e583d92d3d8p-56, +-0x1p0, +0x1.1b7d1da562443p-5, +-0x1.0b0d9cfdbdb9p-2, +-0x1.3b3a7b8d1200dp-58, +-0x1p0, +0x1.221495f879af5p-5, +-0x1.0e15b4e1749cep-2, +0x1.5b7fb156c550ap-56, +-0x1p0, +0x1.28bf1897b69ccp-5, +-0x1.111d262b1f677p-2, +-0x1.824c20ab7aa9ap-56, +-0x1p0, +0x1.2f7ca1666ff6fp-5, +-0x1.1423eefc69378p-2, +-0x1.22d3368ec9b62p-56, +-0x1p0, +0x1.364d2c3c407bep-5, +-0x1.172a0d7765177p-2, +-0x1.22575f33366bep-57, +-0x1p0, +0x1.3d30b4e5094ep-5, +-0x1.1a2f7fbe8f243p-2, +-0x1.6465ac86ba7b2p-56, +-0x1p0, +0x1.44273720f48bcp-5, +-0x1.1d3443f4cdb3ep-2, +0x1.720d41c13519ep-57, +-0x1p0, +0x1.4b30aea477eeep-5, +-0x1.2038583d727bep-2, +0x1.c69cd46300a3p-57, +-0x1p0, +0x1.524d171857726p-5, +-0x1.233bbabc3bb71p-2, +-0x1.99b04e23259efp-56, +-0x1p0, +0x1.597c6c19a8003p-5, +-0x1.263e6995554bap-2, +-0x1.1d350ffc5ff32p-56, +-0x1p0, +0x1.60bea939d225ap-5, +-0x1.294062ed59f06p-2, +0x1.5d28da2c4612dp-56, +-0x1p0, +0x1.6813c9fe94cfbp-5, +-0x1.2c41a4e95452p-2, +-0x1.9cf0354aad2dcp-56, +-0x1p0, +0x1.6f7bc9e2080d9p-5, +-0x1.2f422daec0387p-2, +0x1.7501ba473da6fp-56, +-0x1p0, +0x1.76f6a4529fdb5p-5, +-0x1.3241fb638baafp-2, +-0x1.ecee8f76f8c51p-60, +-0x1p0, +0x1.7e8454b32ef34p-5, +-0x1.35410c2e18152p-2, +0x1.3cb002f96e062p-56, +-0x1p0, +0x1.8624d65ae9a63p-5, +-0x1.383f5e353b6abp-2, +0x1.a812a4a5c3d44p-56, +-0x1p0, +0x1.8dd8249568bbbp-5, +-0x1.3b3cefa0414b7p-2, +-0x1.f36dc4a9c2294p-56, +-0x1p0, +0x1.959e3aa2ac58dp-5, +-0x1.3e39be96ec271p-2, +-0x1.814c6de9aaaf6p-56, +-0x1p0, +0x1.9d7713b71eee1p-5, +-0x1.4135c94176601p-2, +-0x1.0c97c4afa2518p-56, +-0x1p0, +0x1.a562aafb982cdp-5, +-0x1.44310dc8936fp-2, +-0x1.8b694e91d3125p-56, +-0x1p0, +0x1.ad60fb8d6003ap-5, +-0x1.472b8a5571054p-2, +0x1.01ea0fe4dff23p-56, +-0x1p0, +0x1.b572007e31a1bp-5, +-0x1.4a253d11b82f3p-2, +0x1.2afa4d6d42a55p-58, +-0x1p0, +0x1.bd95b4d43e819p-5, +-0x1.4d1e24278e76ap-2, +-0x1.2417218792858p-57, +-0x1p0, +0x1.c5cc138a317afp-5, +-0x1.50163dc197048p-2, +0x1.ec66cb05c7ea4p-56, +-0x1p0, +0x1.ce15178f31db3p-5, +-0x1.530d880af3c24p-2, +0x1.fab8e2103fbd6p-56, +-0x1p0, +0x1.d670bbc6e685ep-5, +-0x1.5604012f467b4p-2, +-0x1.a0e0b2a5b25p-56, +-0x1p0, +0x1.dedefb09791b4p-5, +-0x1.58f9a75ab1fddp-2, +0x1.efdc0d58cf62p-62, +-0x1p0, +0x1.e75fd0239926cp-5, +-0x1.5bee78b9db3b6p-2, +-0x1.e734a63158dfdp-58, +-0x1p0, +0x1.eff335d67f541p-5, +-0x1.5ee27379ea693p-2, +-0x1.634ff2fa75245p-56, +-0x1p0, +0x1.f89926d7f0ab8p-5, +-0x1.61d595c88c202p-2, +-0x1.f6b1e333415d7p-56, +-0x1p0, +0x1.00a8cee920eabp-4, +-0x1.64c7ddd3f27c6p-2, +-0x1.10d2b4a664121p-58, +-0x1p0, +0x1.050e4ab22d321p-4, +-0x1.67b949cad63cbp-2, +0x1.a23369348d7efp-56, +-0x1p0, +0x1.097d0410dc132p-4, +-0x1.6aa9d7dc77e17p-2, +0x1.38b470592c7b3p-56, +-0x1p0, +0x1.0df4f849393f5p-4, +-0x1.6d998638a0cb6p-2, +0x1.1ca14532860dfp-61, +-0x1p0, +0x1.127624999ee1dp-4, +-0x1.7088530fa459fp-2, +0x1.44b19e0864c5dp-56, +-0x1p0, +0x1.1700863ab7533p-4, +-0x1.73763c9261092p-2, +0x1.52324face3b1ap-57, +-0x1p0, +0x1.1b941a5f7ecffp-4, +-0x1.766340f2418f6p-2, +-0x1.2b2adc9041b2cp-56, +-0x1p0, +0x1.2030de354532cp-4, +-0x1.794f5e613dfaep-2, +-0x1.820a4b0d21fc5p-57, +-0x1p0, +0x1.24d6cee3afb2ap-4, +-0x1.7c3a9311dcce7p-2, +-0x1.9a3f21ef3e8d9p-62, +-0x1p0, +0x1.2985e98cbaa3ap-4, +-0x1.7f24dd37341e4p-2, +-0x1.2791a1b5eb796p-57, +-0x1p0, +0x1.2e3e2b4cbb3c3p-4, +-0x1.820e3b04eaac4p-2, +0x1.92379eb01c6b6p-59, +-0x1p0, +0x1.32ff913a615dp-4, +-0x1.84f6aaaf3903fp-2, +-0x1.6dcdc2bd47067p-57, +-0x1p0, +0x1.37ca1866b95cfp-4, +-0x1.87de2a6aea963p-2, +0x1.72cedd3d5a61p-57, +-0x1p0, +0x1.3c9dbddd2dd84p-4, +-0x1.8ac4b86d5ed44p-2, +-0x1.17fa7f944ad5bp-56, +-0x1p0, +0x1.417a7ea389835p-4, +-0x1.8daa52ec8a4bp-2, +0x1.72eb2db8c621ep-57, +-0x1p0, +0x1.466057b9f900ap-4, +-0x1.908ef81ef7bd1p-2, +-0x1.4c00267012357p-56, +-0x1p0, +0x1.4b4f461b0cbaap-4, +-0x1.9372a63bc93d7p-2, +-0x1.684319e5ad5b1p-57, +-0x1p0, +0x1.504746bbbac0bp-4, +-0x1.96555b7ab948fp-2, +-0x1.7afd51eff33adp-56, +-0x1p0, +0x1.5548568b60a7bp-4, +-0x1.993716141bdffp-2, +0x1.15e8cce261c55p-56, +-0x1p0, +0x1.5a527273c56e1p-4, +-0x1.9c17d440df9f2p-2, +-0x1.923c540a9eec4p-57, +-0x1p0, +0x1.5f6597591b633p-4, +-0x1.9ef7943a8ed8ap-2, +-0x1.6da81290bdbabp-57, +-0x1p0, +0x1.6481c21a02123p-4, +-0x1.a1d6543b50acp-2, +0x1.0246cfd8779fbp-57, +-0x1p0, +0x1.69a6ef8f8830ap-4, +-0x1.a4b4127dea1e5p-2, +0x1.bec6f01bc22f1p-56, +-0x1p0, +0x1.6ed51c8d2d8fcp-4, +-0x1.a790cd3dbf31bp-2, +0x1.7f786986d9023p-57, +-0x1p0, +0x1.740c45e0e512p-4, +-0x1.aa6c82b6d3fcap-2, +0x1.d5f106ee5ccf7p-56, +-0x1p0, +0x1.794c685316a3cp-4, +-0x1.ad473125cdc09p-2, +0x1.379ede57649dap-58, +-0x1p0, +0x1.7e9580a6a136ep-4, +-0x1.b020d6c7f4009p-2, +-0x1.414ae7e555208p-58, +-0x1p0, +0x1.83e78b98dcc2bp-4, +-0x1.b2f971db31972p-2, +-0x1.fa971a4a41f2p-56, +-0x1p0, +0x1.894285e19c468p-4, +-0x1.b5d1009e15ccp-2, +-0x1.5b362cb974183p-57, +-0x1p0, +0x1.8ea66c332fd01p-4, +-0x1.b8a7814fd5693p-2, +-0x1.9a9e6651cc119p-56, +-0x1p0, +0x1.94133b3a66851p-4, +-0x1.bb7cf2304bd01p-2, +-0x1.9e1a5bd9269d4p-57, +-0x1p0, +0x1.9988ef9e90b04p-4, +-0x1.be51517ffc0d9p-2, +-0x1.2b667131a5f16p-56, +-0x1p0, +0x1.9f07860181d1ep-4, +-0x1.c1249d8011ee7p-2, +0x1.813aabb515206p-56, +-0x1p0, +0x1.a48efaff92b3bp-4, +-0x1.c3f6d47263129p-2, +-0x1.9c7bd0fcdecddp-56, +-0x1p0, +0x1.aa1f4b2fa37fcp-4, +-0x1.c6c7f4997000bp-2, +0x1.bec2669c68e74p-56, +-0x1p0, +0x1.afb873231ddb9p-4, +-0x1.c997fc3865389p-2, +0x1.6295f8b0ca33bp-56, +-0x1p0, +0x1.b55a6f65f7058p-4, +-0x1.cc66e9931c45ep-2, +-0x1.6850e59c37f8fp-58, +-0x1p0, +0x1.bb053c7eb1f68p-4, +-0x1.cf34baee1cd21p-2, +0x1.118724d19d014p-56, +-0x1p0, +0x1.c0b8d6ee61867p-4, +-0x1.d2016e8e9db5bp-2, +0x1.c8bce9d93efb8p-57, +-0x1p0, +0x1.c6753b30aa949p-4, +-0x1.d4cd02ba8609dp-2, +0x1.37f33c63033d6p-57, +-0x1p0, +0x1.cc3a65bbc6327p-4, +-0x1.d79775b86e389p-2, +-0x1.550ec87bc0575p-56, +-0x1p0, +0x1.d208530083d3p-4, +-0x1.da60c5cfa10d9p-2, +0x1.0f38e2143c8d5p-57, +-0x1p0, +0x1.d7deff6a4b7c9p-4, +-0x1.dd28f1481cc58p-2, +0x1.e7576fa6c944ep-59, +-0x1p0, +0x1.ddbe675f1ffdfp-4, +-0x1.dfeff66a941dep-2, +0x1.a756c6e625f96p-56, +-0x1p0, +0x1.e3a6873fa1279p-4, +-0x1.e2b5d3806f63bp-2, +-0x1.e0d891d3c6841p-58, +-0x1p0, +0x1.e9975b670e077p-4, +-0x1.e57a86d3cd825p-2, +0x1.2c80dcd511e87p-57, +-0x1p0, +0x1.ef90e02b47283p-4, +-0x1.e83e0eaf85114p-2, +0x1.7bc380ef24ba7p-57, +-0x1p0, +0x1.f59311dcd0d44p-4, +-0x1.eb00695f2562p-2, +-0x1.53c9fd3083e22p-56, +-0x1p0, +0x1.fb9decc6d55b8p-4, +-0x1.edc1952ef78d6p-2, +0x1.dd0f7c33edee6p-56, +-0x1p0, +0x1.00d8b69793ae4p-3, +-0x1.f081906bff7fep-2, +0x1.4cab2d4ff6fccp-56, +-0x1p0, +0x1.03e6c7ab2208cp-3, +-0x1.f3405963fd067p-2, +-0x1.06846d44a238fp-56, +-0x1p0, +0x1.06f927bbaacfep-3, +-0x1.f5fdee656cda3p-2, +0x1.7bf9780816b05p-58, +-0x1p0, +0x1.0a0fd4e41ab5ap-3, +-0x1.f8ba4dbf89abap-2, +0x1.2ec1fc1b776b8p-60, +-0x1p0, +0x1.0d2acd3cb7364p-3, +-0x1.fb7575c24d2dep-2, +0x1.5bfdc883c8664p-57, +-0x1p0, +0x1.104a0edb1fc58p-3, +-0x1.fe2f64be7121p-2, +0x1.297ab1ca2d7dbp-56, +-0x1p0, +0x1.136d97d24efccp-3, +-0x1.00740c82b82e1p-1, +0x1.6d48563c60e87p-55, +-0x1p0, +0x1.169566329bcb7p-3, +-0x1.01cfc874c3eb7p-1, +0x1.34a35e7c2368cp-56, +-0x1p0, +0x1.19c17809baa87p-3, +-0x1.032ae55edbd96p-1, +0x1.bdb022b40107ap-55, +-0x1p0, +0x1.1cf1cb62bec5dp-3, +-0x1.0485626ae221ap-1, +-0x1.b937d9091ff7p-55, +-0x1p0, +0x1.20265e461b45ap-3, +-0x1.05df3ec31b8b7p-1, +0x1.e2dcad34d9c1dp-57, +-0x1p0, +0x1.235f2eb9a470ap-3, +-0x1.073879922ffeep-1, +0x1.a5a014347406cp-55, +-0x1p0, +0x1.269c3ac090ee4p-3, +-0x1.089112032b08cp-1, +-0x1.3248ddf9fe619p-57, +-0x1p0, +0x1.29dd805b7afecp-3, +-0x1.09e907417c5e1p-1, +0x1.fe573741a9bd4p-55, +-0x1p0, +0x1.2d22fd8861b6bp-3, +-0x1.0b405878f85ecp-1, +0x1.ad66c3bb80da5p-55, +-0x1p0, +0x1.306cb042aa3bap-3, +-0x1.0c9704d5d898fp-1, +0x1.8d3d7de6ee9b2p-55, +-0x1p0, +0x1.33ba968321032p-3, +-0x1.0ded0b84bc4b6p-1, +0x1.8540fa327c55cp-55, +-0x1p0, +0x1.370cae3ffb12fp-3, +-0x1.0f426bb2a8e7ep-1, +0x1.bb58fb774f8eep-55, +-0x1p0, +0x1.3a62f56cd742ep-3, +-0x1.1097248d0a957p-1, +0x1.7a58759ba80ddp-55, +-0x1p0, +0x1.3dbd69fabf802p-3, +-0x1.11eb3541b4b23p-1, +0x1.ef23b69abe4f1p-55, +-0x1p0, +0x1.411c09d82a128p-3, +-0x1.133e9cfee254fp-1, +0x1.a1377cfd5ce5p-56, +-0x1p0, +0x1.447ed2f0fae31p-3, +-0x1.14915af336cebp-1, +-0x1.f3660558a0213p-56, +-0x1p0, +0x1.47e5c32e84c45p-3, +-0x1.15e36e4dbe2bcp-1, +-0x1.3c545f7d79eaep-56, +-0x1p0, +0x1.4b50d8778abbdp-3, +-0x1.1734d63dedb49p-1, +0x1.7eef2ccc50575p-55, +-0x1p0, +0x1.4ec010b0414e1p-3, +-0x1.188591f3a46e5p-1, +0x1.bbefe5a524346p-56, +-0x1p0, +0x1.523369ba4fcaep-3, +-0x1.19d5a09f2b9b8p-1, +0x1.33656c68a1d4ap-57, +-0x1p0, +0x1.55aae174d19c8p-3, +-0x1.1b250171373bfp-1, +0x1.b210e95e1ca4cp-55, +-0x1p0, +0x1.592675bc57974p-3, +-0x1.1c73b39ae68c8p-1, +-0x1.b25dd267f66p-55, +-0x1p0, +0x1.5ca6246ae94b8p-3, +-0x1.1dc1b64dc4872p-1, +-0x1.f15e1c468be78p-57, +-0x1p0, +0x1.6029eb580658ep-3, +-0x1.1f0f08bbc861bp-1, +0x1.10d9dcafb74cbp-57, +-0x1p0, +0x1.63b1c858a7c2ep-3, +-0x1.205baa17560d6p-1, +-0x1.b7b144016c7a3p-56, +-0x1p0, +0x1.673db93f41479p-3, +-0x1.21a799933eb59p-1, +0x1.3a7b177c68fb2p-55, +-0x1p0, +0x1.6acdbbdbc2b73p-3, +-0x1.22f2d662c13e2p-1, +0x1.d5cc7580cb6d2p-55, +-0x1p0, +0x1.6e61cdfb994dfp-3, +-0x1.243d5fb98ac1fp-1, +-0x1.c533d0a284a8dp-56, +-0x1p0, +0x1.71f9ed69b10eap-3, +-0x1.258734cbb711p-1, +-0x1.3a3f0903ce09dp-57, +-0x1p0, +0x1.759617ee761f9p-3, +-0x1.26d054cdd12dfp-1, +0x1.5da743ef3770cp-55, +-0x1p0, +0x1.79364b4fd6288p-3, +-0x1.2818bef4d3cbap-1, +0x1.e3fffeb76568ap-56, +-0x1p0, +0x1.7cda855141b26p-3, +-0x1.2960727629ca8p-1, +-0x1.56d6c7af02d5cp-56, +-0x1p0, +0x1.8082c3b3ad887p-3, +-0x1.2aa76e87aeb58p-1, +-0x1.fd600833287a7p-59, +-0x1p0, +0x1.842f0435941afp-3, +-0x1.2bedb25faf3eap-1, +0x1.14981c796ee46p-58, +-0x1p0, +0x1.87df4492f6e38p-3, +-0x1.2d333d34e9bb8p-1, +0x1.0e2c2c5549e26p-55, +-0x1p0, +0x1.8b9382855fcaap-3, +-0x1.2e780e3e8ea17p-1, +0x1.b19fafe36587ap-55, +-0x1p0, +0x1.8f4bbbc3e28f6p-3, +-0x1.2fbc24b441015p-1, +-0x1.dba4875410874p-57, +-0x1p0, +0x1.9307ee031e2fdp-3, +-0x1.30ff7fce17035p-1, +0x1.efcc626f74a6fp-57, +-0x1p0, +0x1.96c816f53e539p-3, +-0x1.32421ec49a61fp-1, +-0x1.65e25cc951bfep-55, +-0x1p0, +0x1.9a8c3449fcb77p-3, +-0x1.338400d0c8e57p-1, +0x1.abf2a5e95e6e5p-55, +-0x1p0, +0x1.9e5443aea29b2p-3, +-0x1.34c5252c14de1p-1, +-0x1.583f49632ab2bp-55, +-0x1p0, +0x1.a22042ce0a2f9p-3, +-0x1.36058b10659f3p-1, +0x1.1fcb3a35857e7p-55, +-0x1p0, +0x1.a5f02f50a007cp-3, +-0x1.374531b817f8dp-1, +-0x1.444d2b0a747fep-55, +-0x1p0, +0x1.a9c406dc648a5p-3, +-0x1.3884185dfeb22p-1, +0x1.a038026abe6b2p-56, +-0x1p0, +0x1.ad9bc714ed64fp-3, +-0x1.39c23e3d63029p-1, +0x1.3b05b276085c1p-58, +-0x1p0, +0x1.b1776d9b67013p-3, +-0x1.3affa292050b9p-1, +-0x1.e3e25e3954964p-56, +-0x1p0, +0x1.b556f80e95facp-3, +-0x1.3c3c44981c518p-1, +0x1.b5e9a9644151bp-55, +-0x1p0, +0x1.b93a640ad8978p-3, +-0x1.3d78238c58344p-1, +0x1.0219f5f0f79cep-55, +-0x1p0, +0x1.bd21af2a28408p-3, +-0x1.3eb33eabe068p-1, +-0x1.86a2357d1a0d3p-58, +-0x1p0, +0x1.c10cd7041afccp-3, +-0x1.3fed9534556d4p-1, +-0x1.36916608c5061p-55, +-0x1p0, +0x1.c4fbd92de4eddp-3, +-0x1.41272663d108cp-1, +-0x1.1bbe7636fadf5p-55, +-0x1p0, +0x1.c8eeb33a59cdp-3, +-0x1.425ff178e6bb1p-1, +-0x1.7b38d675140cap-55, +-0x1p0, +0x1.cce562b9ee6aep-3, +-0x1.4397f5b2a438p-1, +0x1.7274c9e48c226p-55, +-0x1p0, +0x1.d0dfe53aba2fdp-3, +-0x1.44cf325091dd6p-1, +-0x1.8076a2cfdc6b3p-57, +-0x1p0, +0x1.d4de3848789e2p-3, +-0x1.4605a692b32a2p-1, +-0x1.21ca219b97107p-55, +-0x1p0, +0x1.d8e0596c8ad56p-3, +-0x1.473b51b987347p-1, +-0x1.ca1953514e41bp-57, +-0x1p0, +0x1.dce6462df917dp-3, +-0x1.48703306091ffp-1, +0x1.70813b86159fdp-57, +-0x1p0, +0x1.e0effc1174505p-3, +-0x1.49a449b9b0939p-1, +0x1.27ee16d719b94p-55, +-0x1p0, +0x1.e4fd7899579acp-3, +-0x1.4ad79516722f1p-1, +0x1.1273b163000f7p-55, +-0x1p0, +0x1.e90eb945a9ccfp-3, +-0x1.4c0a145ec0004p-1, +-0x1.2630cfafceaa1p-58, +-0x1p0, +0x1.ed23bb941f019p-3, +-0x1.4d3bc6d589f7fp-1, +-0x1.6e4d9d6b72011p-55, +-0x1p0, +0x1.f13c7d001a249p-3, +-0x1.4e6cabbe3e5e9p-1, +-0x1.3c293edceb327p-57, +-0x1p0, +0x1.f558fb02ae805p-3, +-0x1.4f9cc25cca486p-1, +-0x1.48b5951cfc2b5p-55, +-0x1p0, +0x1.f9793312a14d1p-3, +-0x1.50cc09f59a09bp-1, +-0x1.693463a2c2e6fp-56, +-0x1p0, +0x1.fd9d22a46b416p-3, +-0x1.51fa81cd99aa6p-1, +0x1.499f59d8560e9p-63, +-0x1p0, +0x1.00e263951d11fp-2, +-0x1.5328292a35596p-1, +0x1.a12eb89da0257p-56, +-0x1p0, +0x1.02f80f09f92f4p-2, +-0x1.5454ff5159dfcp-1, +0x1.4e247588bf256p-55, +-0x1p0, +0x1.050f92679849cp-2, +-0x1.5581038975137p-1, +-0x1.4570d9efe26dfp-55, +-0x1p0, +0x1.0728ec63a599ap-2, +-0x1.56ac35197649fp-1, +0x1.f7874188cb279p-55, +-0x1p0, +0x1.09441bb2aa0a2p-2, +-0x1.57d69348cecap-1, +0x1.75720992bfbb2p-55, +-0x1p0, +0x1.0b611f080d05bp-2, +-0x1.59001d5f723dfp-1, +-0x1.a9f86ba0dde98p-56, +-0x1p0, +0x1.0d7ff51615437p-2, +-0x1.5a28d2a5d725p-1, +-0x1.57a25f8b1343p-55, +-0x1p0, +0x1.0fa09c8de994bp-2, +-0x1.5b50b264f7448p-1, +-0x1.519d30d4cfebp-56, +-0x1p0, +0x1.11c3141f91b3ep-2, +-0x1.5c77bbe65018cp-1, +-0x1.069ea9c0bc32ap-55, +-0x1p0, +0x1.13e75a79f7139p-2, +-0x1.5d9dee73e345cp-1, +0x1.de1165ecdf7a3p-57, +-0x1p0, +0x1.160d6e4ae5ae6p-2, +-0x1.5ec3495837074p-1, +-0x1.dea89a9b8f727p-56, +-0x1p0, +0x1.18354e3f0cd7dp-2, +-0x1.5fe7cbde56a1p-1, +0x1.fcb9cc30cc01ep-55, +-0x1p0, +0x1.1a5ef902000d3p-2, +-0x1.610b7551d2cdfp-1, +0x1.251b352ff2a37p-56, +-0x1p0, +0x1.1c8a6d3e37c82p-2, +-0x1.622e44fec22ffp-1, +-0x1.f98d8be132d57p-56, +-0x1p0, +0x1.1eb7a99d1250cp-2, +-0x1.63503a31c1be9p-1, +-0x1.1248f09e6587cp-57, +-0x1p0, +0x1.20e6acc6d4916p-2, +-0x1.64715437f535bp-1, +0x1.7c399c15a17dp-55, +-0x1p0, +0x1.23177562aaea3p-2, +-0x1.6591925f0783dp-1, +-0x1.c3d64fbf5de23p-55, +-0x1p0, +0x1.254a0216aa067p-2, +-0x1.66b0f3f52b386p-1, +-0x1.1e2eb31a8848bp-55, +-0x1p0, +0x1.277e5187cfb16p-2, +-0x1.67cf78491af1p-1, +-0x1.750ab23477b61p-59, +-0x1p0, +0x1.29b4625a03ac9p-2, +-0x1.68ed1eaa19c71p-1, +-0x1.fd4a85350f69p-56, +-0x1p0, +0, +-0x1.6a09e667f3bcdp-1, +0x1.bdd3413b26456p-55, +0, +-0x1.a3b47aa8671c5p-3, +-0x1.6b25ced2fe29cp-1, +0x1.5ac64116beda5p-55, +-0x1p-1, +-0x1.9f3de1246bc4p-3, +-0x1.6c40d73c18275p-1, +-0x1.25d4f802be257p-57, +-0x1p-1, +-0x1.9ac3cfd4ace19p-3, +-0x1.6d5afef4aafcdp-1, +0x1.868a696b8835ep-55, +-0x1p-1, +-0x1.9646497c1e0f6p-3, +-0x1.6e74454eaa8afp-1, +0x1.dbc03c84e226ep-55, +-0x1p-1, +-0x1.91c550dfd4d6bp-3, +-0x1.6f8ca99c95b75p-1, +-0x1.f22e7a35723f4p-56, +-0x1p-1, +-0x1.8d40e8c706fa4p-3, +-0x1.70a42b3176d7ap-1, +0x1.d9e3fbe2e15ap-56, +-0x1p-1, +-0x1.88b913fb08bfdp-3, +-0x1.71bac960e41bfp-1, +0x1.b858d90b0f7d8p-56, +-0x1p-1, +-0x1.842dd5474b37bp-3, +-0x1.72d0837efff96p-1, +-0x1.0d4ef0f1d915cp-55, +-0x1p-1, +-0x1.7f9f2f795a83ep-3, +-0x1.73e558e079942p-1, +0x1.2663126697f5ep-55, +-0x1p-1, +-0x1.7b0d2560dc1d1p-3, +-0x1.74f948da8d28dp-1, +-0x1.19900a3b9a3a2p-63, +-0x1p-1, +-0x1.7677b9cf8d17p-3, +-0x1.760c52c304764p-1, +0x1.11d76f8e50f1fp-55, +-0x1p-1, +-0x1.71deef9940631p-3, +-0x1.771e75f037261p-1, +-0x1.5cfce8d84068fp-56, +-0x1p-1, +-0x1.6d42c993dd121p-3, +-0x1.782fb1b90b35bp-1, +0x1.3e46c1dfd001cp-55, +-0x1p-1, +-0x1.68a34a975c941p-3, +-0x1.79400574f55e5p-1, +0x1.0adadbdb4c65ap-55, +-0x1p-1, +-0x1.6400757dc8f7dp-3, +-0x1.7a4f707bf97d2p-1, +-0x1.3c9751b491eafp-55, +-0x1p-1, +-0x1.5f5a4d233b27fp-3, +-0x1.7b5df226aafafp-1, +0x1.0f537acdf0ad7p-56, +-0x1p-1, +-0x1.5ab0d465d927ap-3, +-0x1.7c6b89ce2d333p-1, +0x1.cfd628084982cp-56, +-0x1p-1, +-0x1.56040e25d44ddp-3, +-0x1.7d7836cc33db2p-1, +-0x1.162715ef03f85p-56, +-0x1p-1, +-0x1.5153fd45677efp-3, +-0x1.7e83f87b03686p-1, +-0x1.b61a8ccabad6p-57, +-0x1p-1, +-0x1.4ca0a4a8d5657p-3, +-0x1.7f8ece3571771p-1, +0x1.9c8d8ce93c917p-55, +-0x1p-1, +-0x1.47ea073666a98p-3, +-0x1.8098b756e52fap-1, +-0x1.9136e834b4707p-55, +-0x1p-1, +-0x1.433027d66826dp-3, +-0x1.81a1b33b57accp-1, +0x1.5dea12d66bb66p-55, +-0x1p-1, +-0x1.3e73097329219p-3, +-0x1.82a9c13f545ffp-1, +0x1.65e87a7a8cde9p-56, +-0x1p-1, +-0x1.39b2aef8f97a4p-3, +-0x1.83b0e0bff976ep-1, +0x1.6f420f8ea3475p-56, +-0x1p-1, +-0x1.34ef1b5627dfdp-3, +-0x1.84b7111af83fap-1, +0x1.63a47df0b21bap-55, +-0x1p-1, +-0x1.3028517b0001p-3, +-0x1.85bc51ae958ccp-1, +-0x1.45ba6478086ccp-55, +-0x1p-1, +-0x1.2b5e5459c8bc3p-3, +-0x1.86c0a1d9aa195p-1, +-0x1.84564f09c3726p-59, +-0x1p-1, +-0x1.269126e6c24e3p-3, +-0x1.87c400fba2ebfp-1, +0x1.2dabc0c3f64cdp-55, +-0x1p-1, +-0x1.21c0cc18247fcp-3, +-0x1.88c66e7481ba1p-1, +0x1.5c6228970cf35p-56, +-0x1p-1, +-0x1.1ced46e61cd1cp-3, +-0x1.89c7e9a4dd4aap-1, +-0x1.db6ea04a8678fp-55, +-0x1p-1, +-0x1.18169a4acca89p-3, +-0x1.8ac871ede1d88p-1, +0x1.9afaa5b7cfc55p-55, +-0x1p-1, +-0x1.133cc94247758p-3, +-0x1.8bc806b151741p-1, +0x1.2c5e12ed1336dp-55, +-0x1p-1, +-0x1.0e5fd6ca90dffp-3, +-0x1.8cc6a75184655p-1, +0x1.e18b3657e2285p-55, +-0x1p-1, +-0x1.097fc5e39aec5p-3, +-0x1.8dc45331698ccp-1, +-0x1.1d9fcd83634d7p-57, +-0x1p-1, +-0x1.049c998f44231p-3, +-0x1.8ec109b486c49p-1, +0x1.cb2a3eb6af617p-56, +-0x1p-1, +-0x1.ff6ca9a2ab6a2p-4, +-0x1.8fbcca3ef940dp-1, +0x1.6dfa99c86f2f1p-57, +-0x1p-1, +-0x1.f599f55f034p-4, +-0x1.90b7943575efep-1, +-0x1.4ecb0c5273706p-57, +-0x1p-1, +-0x1.ebc11c62c1a1ep-4, +-0x1.91b166fd49da2p-1, +0x1.3be953a7fe996p-57, +-0x1p-1, +-0x1.e1e224c0e28bdp-4, +-0x1.92aa41fc5a815p-1, +0x1.68f89e2d23db7p-57, +-0x1p-1, +-0x1.d7fd1490285cap-4, +-0x1.93a22499263fbp-1, +-0x1.3d419a920df0bp-55, +-0x1p-1, +-0x1.ce11f1eb18148p-4, +-0x1.94990e3ac4a6cp-1, +-0x1.a95328edeb3e6p-56, +-0x1p-1, +-0x1.c420c2eff590ep-4, +-0x1.958efe48e6dd7p-1, +0x1.561335da0f4e7p-55, +-0x1p-1, +-0x1.ba298dc0bfc6bp-4, +-0x1.9683f42bd7fe1p-1, +0x1.11bad933c835ep-57, +-0x1p-1, +-0x1.b02c58832cf96p-4, +-0x1.9777ef4c7d742p-1, +0x1.15479a240665ep-55, +-0x1p-1, +-0x1.a6292960a6f0bp-4, +-0x1.986aef1457594p-1, +0x1.af03e318f38fcp-55, +-0x1p-1, +-0x1.9c200686472b5p-4, +-0x1.995cf2ed80d22p-1, +-0x1.7783e907fbd7bp-56, +-0x1p-1, +-0x1.9210f624d30fbp-4, +-0x1.9a4dfa42b06b2p-1, +0x1.829b6b8b1c947p-56, +-0x1p-1, +-0x1.87fbfe70b81a7p-4, +-0x1.9b3e047f38741p-1, +0x1.30ee286712474p-55, +-0x1p-1, +-0x1.7de125a2080a9p-4, +-0x1.9c2d110f075c2p-1, +-0x1.d9c9f1c8c30dp-55, +-0x1p-1, +-0x1.73c071f4750b5p-4, +-0x1.9d1b1f5ea80d5p-1, +-0x1.c5fadd5ffb36fp-55, +-0x1p-1, +-0x1.6999e9a74ddbep-4, +-0x1.9e082edb42472p-1, +-0x1.5809a4e121e22p-57, +-0x1p-1, +-0x1.5f6d92fd79f5p-4, +-0x1.9ef43ef29af94p-1, +-0x1.b1dfcb60445c2p-56, +-0x1p-1, +-0x1.553b743d75acp-4, +-0x1.9fdf4f13149dep-1, +-0x1.1e6d79006ec09p-55, +-0x1p-1, +-0x1.4b0393b14e541p-4, +-0x1.a0c95eabaf937p-1, +0x1.e0ca3acbd049ap-55, +-0x1p-1, +-0x1.40c5f7a69e5cep-4, +-0x1.a1b26d2c0a75ep-1, +-0x1.30ef431d627a6p-57, +-0x1p-1, +-0x1.3682a66e896f5p-4, +-0x1.a29a7a0462782p-1, +0x1.128bb015df175p-56, +-0x1p-1, +-0x1.2c39a65db8881p-4, +-0x1.a38184a593bc6p-1, +0x1.bc92c5bd2d288p-55, +-0x1p-1, +-0x1.21eafdcc560fap-4, +-0x1.a4678c8119ac8p-1, +-0x1.1b4c0dd3f212ap-55, +-0x1p-1, +-0x1.1796b31609f0cp-4, +-0x1.a54c91090f523p-1, +-0x1.184300fd1c1cep-56, +-0x1p-1, +-0x1.0d3ccc99f5ac6p-4, +-0x1.a63091b02fae2p-1, +0x1.e911152248d1p-56, +-0x1p-1, +-0x1.02dd50bab06b2p-4, +-0x1.a7138de9d60f5p-1, +0x1.f1ab82a9c5f2dp-55, +-0x1p-1, +-0x1.f0f08bbc861afp-5, +-0x1.a7f58529fe69dp-1, +0x1.97a441584a179p-55, +-0x1p-1, +-0x1.dc1b64dc48722p-5, +-0x1.a8d676e545ad2p-1, +0x1.b11dcce2e74bdp-59, +-0x1p-1, +-0x1.c73b39ae68c87p-5, +-0x1.a9b66290ea1a3p-1, +-0x1.9f630e8b6dac8p-60, +-0x1p-1, +-0x1.b250171373be9p-5, +-0x1.aa9547a2cb98ep-1, +-0x1.87d00ae97abaap-60, +-0x1p-1, +-0x1.9d5a09f2b9b7fp-5, +-0x1.ab7325916c0d4p-1, +-0x1.a8b8c85baaa9bp-55, +-0x1p-1, +-0x1.88591f3a46e4dp-5, +-0x1.ac4ffbd3efac8p-1, +0x1.818504103fa16p-56, +-0x1p-1, +-0x1.734d63dedb48ap-5, +-0x1.ad2bc9e21d511p-1, +0x1.47fbe07bea548p-55, +-0x1p-1, +-0x1.5e36e4dbe2bc2p-5, +-0x1.ae068f345ecefp-1, +0x1.33934c4029a4cp-56, +-0x1p-1, +-0x1.4915af336ceb4p-5, +-0x1.aee04b43c1474p-1, +0x1.3a79a438bf8ccp-55, +-0x1p-1, +-0x1.33e9cfee254edp-5, +-0x1.afb8fd89f57b6p-1, +-0x1.1ced12d2899b8p-60, +-0x1p-1, +-0x1.1eb3541b4b228p-5, +-0x1.b090a581502p-1, +0x1.926da300ffccep-55, +-0x1p-1, +-0x1.097248d0a956ap-5, +-0x1.b16742a4ca2f5p-1, +0x1.ba70972b80438p-55, +-0x1p-1, +-0x1.e84d76551cfb2p-6, +-0x1.b23cd470013b4p-1, +-0x1.5a1bb35ad6d2ep-56, +-0x1p-1, +-0x1.bda17097896b4p-6, +-0x1.b3115a5f37bf3p-1, +-0x1.dde2726e34fe1p-55, +-0x1p-1, +-0x1.92e09abb131d4p-6, +-0x1.b3e4d3ef55712p-1, +0x1.eb6b8bf11a493p-55, +-0x1p-1, +-0x1.680b0f1f0bd73p-6, +-0x1.b4b7409de7925p-1, +-0x1.f4e257bde73d8p-56, +-0x1p-1, +-0x1.3d20e82f8bc1p-6, +-0x1.b5889fe921405p-1, +0x1.df49b307c8602p-57, +-0x1p-1, +-0x1.1222406561182p-6, +-0x1.b658f14fdbc47p-1, +-0x1.52b5308f397dep-57, +-0x1p-1, +-0x1.ce1e648bffb66p-7, +-0x1.b728345196e3ep-1, +0x1.bc69f324e6d61p-55, +-0x1p-1, +-0x1.77cfb0c6e2db8p-7, +-0x1.b7f6686e792e9p-1, +-0x1.87665bfea06aap-55, +-0x1p-1, +-0x1.21589ab88869cp-7, +-0x1.b8c38d27504e9p-1, +0x1.1529abff40e45p-55, +-0x1p-1, +-0x1.9572af6decac8p-8, +-0x1.b98fa1fd9155ep-1, +-0x1.5559034fe85a4p-55, +-0x1p-1, +-0x1.cfc874c3eb6d9p-9, +-0x1.ba5aa673590d2p-1, +-0x1.7ea4e370753b6p-55, +-0x1p-1, +-0x1.d0320ae0b8293p-11, +-0x1.bb249a0b6c40dp-1, +0x1.d6318ee919f7ap-58, +-0x1p-1, +0x1.d09b418edf04ap-10, +-0x1.bbed7c49380eap-1, +-0x1.beacbd88500b4p-59, +-0x1p-1, +0x1.22a28f6cb488bp-8, +-0x1.bcb54cb0d2327p-1, +-0x1.410923c55523ep-62, +-0x1p-1, +0x1.d16c901d95181p-8, +-0x1.bd7c0ac6f952ap-1, +0x1.825a732ac700ap-55, +-0x1p-1, +0x1.4042335264ba3p-7, +-0x1.be41b611154c1p-1, +0x1.fdcdad3a6877ep-55, +-0x1p-1, +0x1.97f4d3805f318p-7, +-0x1.bf064e15377ddp-1, +-0x1.2156026a1e028p-57, +-0x1p-1, +0x1.efcdf2801004ap-7, +-0x1.bfc9d25a1b147p-1, +0x1.51bf4ee01357p-61, +-0x1p-1, +0x1.23e6ad10872a7p-6, +-0x1.c08c426725549p-1, +-0x1.b157fd80e2946p-58, +-0x1p-1, +0x1.4ff96a0da9dfbp-6, +-0x1.c14d9dc465e57p-1, +-0x1.ce36b64c7f3ccp-55, +-0x1p-1, +0x1.7c1f1507aeec3p-6, +-0x1.c20de3fa971bp-1, +0x1.b4ca2bab1322cp-55, +-0x1p-1, +0x1.a85792c327db2p-6, +-0x1.c2cd14931e3f1p-1, +-0x1.2ce2f9d4600f5p-56, +-0x1p-1, +0x1.d4a2c7f909c4ep-6, +-0x1.c38b2f180bdb1p-1, +0x1.6e0b1757c8d07p-56, +-0x1p-1, +0x1.00804cab5f113p-5, +-0x1.c44833141c004p-1, +-0x1.23e0521df01a2p-56, +-0x1p-1, +0x1.16b875bf19d4p-5, +-0x1.c5042012b6907p-1, +0x1.5c058dd8eaba5p-57, +-0x1p-1, +0x1.2cf9d182f7939p-5, +-0x1.c5bef59fef85ap-1, +0x1.f0a406c8b7468p-58, +-0x1p-1, +0x1.4344523c8e3b5p-5, +-0x1.c678b3488739bp-1, +-0x1.d86cac7c5ff5bp-57, +-0x1p-1, +0x1.5997ea2bcfb19p-5, +-0x1.c7315899eaad7p-1, +0x1.9be5dcd047da7p-57, +-0x1p-1, +0x1.6ff48b8b1252ap-5, +-0x1.c7e8e52233cf3p-1, +-0x1.b2ad324aa35c1p-57, +-0x1p-1, +0x1.865a288f196fap-5, +-0x1.c89f587029c13p-1, +-0x1.588358ed6e78fp-58, +-0x1p-1, +0x1.9cc8b3671dd0fp-5, +-0x1.c954b213411f5p-1, +0x1.2fb761e946603p-58, +-0x1p-1, +0x1.b3401e3cd63bbp-5, +-0x1.ca08f19b9c449p-1, +0x1.431e0a5a737fdp-56, +-0x1p-1, +0x1.c9c05b347ffabp-5, +-0x1.cabc169a0b9p-1, +-0x1.c42d3e10851d1p-55, +-0x1p-1, +0x1.e0495c6ce76b5p-5, +-0x1.cb6e20a00da99p-1, +0x1.4fb24b5194c1bp-55, +-0x1p-1, +0x1.f6db13ff708cbp-5, +-0x1.cc1f0f3fcfc5cp-1, +-0x1.e57613b68f6abp-56, +-0x1p-1, +0x1.06baba000fc9bp-4, +-0x1.cccee20c2deap-1, +0x1.d3116ae0e69e4p-55, +-0x1p-1, +0x1.120c373ed0bfbp-4, +-0x1.cd7d9898b32f6p-1, +0x1.f2fa062496738p-57, +-0x1p-1, +0x1.1d61fac0aa5b2p-4, +-0x1.ce2b32799a06p-1, +0x1.631d457e46317p-56, +-0x1p-1, +0x1.28bbfd87a8cffp-4, +-0x1.ced7af43cc773p-1, +0x1.e7b6bb5ab58aep-58, +-0x1p-1, +0x1.341a389339a36p-4, +-0x1.cf830e8ce467bp-1, +0x1.7b9202780d49dp-55, +-0x1p-1, +0x1.3f7ca4e02ffdcp-4, +-0x1.d02d4feb2bd92p-1, +-0x1.195ff41bc55fep-55, +-0x1p-1, +0x1.4ae33b68c8fdcp-4, +-0x1.d0d672f59d2b9p-1, +0x1.c83009f0c39dep-55, +-0x1p-1, +0x1.564df524b00dap-4, +-0x1.d17e7743e35dcp-1, +0x1.101da3540130ap-58, +-0x1p-1, +0x1.61bccb0903395p-4, +-0x1.d2255c6e5a4e1p-1, +0x1.d129a71ecafc9p-55, +-0x1p-1, +0x1.6d2fb6085786ep-4, +-0x1.d2cb220e0ef9fp-1, +0x1.f07656d4e6652p-56, +-0x1p-1, +0x1.78a6af12bd501p-4, +-0x1.d36fc7bcbfbdcp-1, +0x1.ba196d95a177dp-55, +-0x1p-1, +0x1.8421af15c49d7p-4, +-0x1.d4134d14dc93ap-1, +0x1.4ef5295d25af2p-55, +-0x1p-1, +0x1.8fa0aefc81837p-4, +-0x1.d4b5b1b187524p-1, +0x1.f56be6b42b76dp-57, +-0x1p-1, +0x1.9b23a7af90805p-4, +-0x1.d556f52e93eb1p-1, +0x1.80ed9233a963p-55, +-0x1p-1, +0x1.a6aa92151adc3p-4, +-0x1.d5f7172888a7fp-1, +0x1.68663e2225755p-55, +-0x1p-1, +0x1.b2356710db0a3p-4, +-0x1.d696173c9e68bp-1, +0x1.e8c61c6393d55p-56, +-0x1p-1, +0x1.bdc41f84210bbp-4, +-0x1.d733f508c0dffp-1, +0x1.007928e770cd5p-55, +-0x1p-1, +0x1.c956b44dd6d41p-4, +-0x1.d7d0b02b8ecf9p-1, +-0x1.800f4ce65cd6ep-55, +-0x1p-1, +0x1.d4ed1e4a84aefp-4, +-0x1.d86c48445a44fp-1, +-0x1.e8813c023d71fp-55, +-0x1p-1, +0x1.e087565455a75p-4, +-0x1.d906bcf328d46p-1, +-0x1.457e610231ac2p-56, +-0x1p-1, +0x1.ec2555431bf03p-4, +-0x1.d9a00dd8b3d46p-1, +-0x1.bea0e4bac8e16p-58, +-0x1p-1, +0x1.f7c713ec554fp-4, +-0x1.da383a9668988p-1, +0x1.5811000b39d84p-55, +-0x1p-1, +0x1.01b6459197c38p-3, +-0x1.dacf42ce68ab9p-1, +0x1.fe8d76efdf896p-56, +-0x1p-1, +0x1.078ad9dc46632p-3, +-0x1.db6526238a09bp-1, +0x1.adee7eae6946p-56, +-0x1p-1, +0x1.0d61433d840a4p-3, +-0x1.dbf9e4395759ap-1, +-0x1.d8ff7350f75fdp-55, +-0x1p-1, +0x1.13397e1b7ce13p-3, +-0x1.dc8d7cb41026p-1, +-0x1.6b7872773830dp-56, +-0x1p-1, +0x1.191386db3dedcp-3, +-0x1.dd1fef38a915ap-1, +0x1.782f169e17f3bp-55, +-0x1p-1, +0x1.1eef59e0b74c3p-3, +-0x1.ddb13b6ccc23cp-1, +-0x1.83c37c6107db3p-55, +-0x1p-1, +0x1.24ccf38ebe694p-3, +-0x1.de4160f6d8d81p-1, +-0x1.9bf11cc5f8776p-55, +-0x1p-1, +0x1.2aac5047103d3p-3, +-0x1.ded05f7de47dap-1, +0x1.2cc4c1f8ba966p-55, +-0x1p-1, +-0x1.9ee5272b58f2ap-4, +-0x1.df5e36a9ba59cp-1, +0x1.e01f8bceb43d3p-57, +-0x1p-2, +-0x1.931f774fc9f18p-4, +-0x1.dfeae622dbe2bp-1, +0x1.514ea88425567p-55, +-0x1p-2, +-0x1.875657223080ap-4, +-0x1.e0766d9280f54p-1, +-0x1.f44c969cf62e3p-55, +-0x1p-2, +-0x1.7b89cde7a9a4dp-4, +-0x1.e100cca2980acp-1, +0x1.02d182acdf825p-57, +-0x1p-2, +-0x1.6fb9e2e76ced8p-4, +-0x1.e18a02fdc66d9p-1, +-0x1.07e272abd88cfp-55, +-0x1p-2, +-0x1.63e69d6ac7f74p-4, +-0x1.e212104f686e5p-1, +0x1.014c76c126527p-55, +-0x1p-2, +-0x1.581004bd19ed2p-4, +-0x1.e298f4439197ap-1, +-0x1.e84e601038eb2p-57, +-0x1p-2, +-0x1.4c36202bcf08ep-4, +-0x1.e31eae870ce25p-1, +0x1.bc7094538d678p-56, +-0x1p-2, +-0x1.4058f7065c11ep-4, +-0x1.e3a33ec75ce85p-1, +-0x1.45089cd46bbb8p-57, +-0x1p-2, +-0x1.3478909e39da9p-4, +-0x1.e426a4b2bc17ep-1, +-0x1.a873889744882p-55, +-0x1p-2, +-0x1.2894f446e0bccp-4, +-0x1.e4a8dff81ce5ep-1, +-0x1.43578776c0f46p-55, +-0x1p-2, +-0x1.1cae2955c414fp-4, +-0x1.e529f04729ffcp-1, +-0x1.9075d6e6dfc8bp-55, +-0x1p-2, +-0x1.10c437224dbc2p-4, +-0x1.e5a9d550467d3p-1, +-0x1.7d431be53f92fp-56, +-0x1p-2, +-0x1.04d72505d9805p-4, +-0x1.e6288ec48e112p-1, +0x1.16b56f2847754p-57, +-0x1p-2, +-0x1.f1cdf4b76138bp-5, +-0x1.e6a61c55d53a7p-1, +-0x1.660d981acdcf7p-56, +-0x1p-2, +-0x1.d9e77d020a5bcp-5, +-0x1.e7227db6a9744p-1, +-0x1.2128794da5a5p-55, +-0x1p-2, +-0x1.c1faf1a9db555p-5, +-0x1.e79db29a5165ap-1, +0x1.75e710aca58p-56, +-0x1p-2, +-0x1.aa086170c0a8ep-5, +-0x1.e817bab4cd10dp-1, +0x1.d0afe686b5e0ap-56, +-0x1p-2, +-0x1.920fdb1c5d578p-5, +-0x1.e89095bad6025p-1, +0x1.5a4cc0fcbccap-55, +-0x1p-2, +-0x1.7a116d7601c35p-5, +-0x1.e9084361df7f2p-1, +-0x1.cdfc7ce9dc3e9p-55, +-0x1p-2, +-0x1.620d274aa2903p-5, +-0x1.e97ec36016b3p-1, +-0x1.5bc48562557d3p-55, +-0x1p-2, +-0x1.4a03176acf82dp-5, +-0x1.e9f4156c62ddap-1, +-0x1.760b1e2e3f81ep-55, +-0x1p-2, +-0x1.31f34caaaa5d2p-5, +-0x1.ea68393e658p-1, +0x1.467259bb7b556p-56, +-0x1p-2, +-0x1.19ddd5e1ddb8bp-5, +-0x1.eadb2e8e7a88ep-1, +0x1.92ec52ea226a3p-55, +-0x1p-2, +-0x1.01c2c1eb93deep-5, +-0x1.eb4cf515b8811p-1, +-0x1.95da1ba97ec5ep-57, +-0x1p-2, +-0x1.d3443f4cdb3ddp-6, +-0x1.ebbd8c8df0b74p-1, +-0x1.c6c8c615e7277p-56, +-0x1p-2, +-0x1.a2f7fbe8f2436p-6, +-0x1.ec2cf4b1af6b2p-1, +-0x1.34ee3f2caa62dp-59, +-0x1p-2, +-0x1.72a0d77651772p-6, +-0x1.ec9b2d3c3bf84p-1, +-0x1.19119d358de05p-56, +-0x1p-2, +-0x1.423eefc693785p-6, +-0x1.ed0835e999009p-1, +-0x1.499d188aa32fap-57, +-0x1p-2, +-0x1.11d262b1f6776p-6, +-0x1.ed740e7684963p-1, +-0x1.e82c791f59cc2p-56, +-0x1p-2, +-0x1.c2b69c2e939b5p-7, +-0x1.eddeb6a078651p-1, +0x1.3b579af740a74p-55, +-0x1p-2, +-0x1.61b39fb7b7202p-7, +-0x1.ee482e25a9dbcp-1, +0x1.b6066ef81af2ap-56, +-0x1p-2, +-0x1.009c0bd6cc3cbp-7, +-0x1.eeb074c50a544p-1, +-0x1.d925f656c43b4p-55, +-0x1p-2, +-0x1.3ee038dff6b8p-8, +-0x1.ef178a3e473c2p-1, +-0x1.6310a67fe774fp-55, +-0x1p-2, +-0x1.f1806b9fdd1afp-10, +-0x1.ef7d6e51ca3cp-1, +0x1.a3c67c3d3f604p-55, +-0x1p-2, +0x1.191f2900903a6p-10, +-0x1.efe220c0b95ecp-1, +-0x1.c853b7bf7e0cdp-55, +-0x1p-2, +0x1.0916fe858ffcdp-8, +-0x1.f045a14cf738cp-1, +0x1.a52c44f45216cp-55, +-0x1p-2, +0x1.cc0d09bd41caap-8, +-0x1.f0a7efb9230d7p-1, +-0x1.52c7adc6b4989p-56, +-0x1p-2, +0x1.4794b9d21cb87p-7, +-0x1.f1090bc898f5fp-1, +0x1.baa64ab102a93p-55, +-0x1p-2, +0x1.a935e1efe5e4bp-7, +-0x1.f168f53f7205dp-1, +0x1.26a6c1f015601p-57, +-0x1p-2, +0x1.0574e07f7b332p-6, +-0x1.f1c7abe284708p-1, +-0x1.504b80c8a63fcp-55, +-0x1p-2, +0x1.36580d5d5e775p-6, +-0x1.f2252f7763adap-1, +0x1.20cb81c8d94abp-55, +-0x1p-2, +0x1.67445969a108ep-6, +-0x1.f2817fc4609cep-1, +0x1.dd1f8eaf65689p-55, +-0x1p-2, +0x1.9839a676a6bcfp-6, +-0x1.f2dc9c9089a9dp-1, +-0x1.5407460bdfc07p-59, +-0x1p-2, +0x1.c937d65145919p-6, +-0x1.f33685a3aaefp-1, +-0x1.eb78685d850f8p-56, +-0x1p-2, +0x1.fa3ecac0d84e8p-6, +-0x1.f38f3ac64e589p-1, +0x1.d7bafb51f72e6p-56, +-0x1p-2, +0x1.15a732c3a894dp-5, +-0x1.f3e6bbc1bbc65p-1, +-0x1.5774bb7e8a21ep-57, +-0x1p-2, +0x1.2e334430a6376p-5, +-0x1.f43d085ff92ddp-1, +0x1.8fde71e361c05p-55, +-0x1p-2, +0x1.46c38a8311952p-5, +-0x1.f492206bcabb4p-1, +-0x1.d1e921bbe3bd3p-55, +-0x1p-2, +0x1.5f57f693feebep-5, +-0x1.f4e603b0b2f2dp-1, +0x1.8ee01e695ac05p-56, +-0x1p-2, +0x1.77f07939f3897p-5, +-0x1.f538b1faf2d07p-1, +0x1.5f7cd5099519cp-59, +-0x1p-2, +0x1.908d0348ef266p-5, +-0x1.f58a2b1789e84p-1, +-0x1.1f4a188aa368p-56, +-0x1p-2, +0x1.a92d859275418p-5, +-0x1.f5da6ed43685dp-1, +0x1.536fc33bf9dd8p-55, +-0x1p-2, +0x1.c1d1f0e5967d5p-5, +-0x1.f6297cff75cbp-1, +-0x1.562172a361fd3p-56, +-0x1p-2, +0x1.da7a360ef9fefp-5, +-0x1.f677556883ceep-1, +-0x1.ef696a8d070f4p-57, +-0x1p-2, +0x1.f32645d8e6ce9p-5, +-0x1.f6c3f7df5bbb7p-1, +-0x1.8561ce9d5ef5bp-56, +-0x1p-2, +0x1.05eb0885a69c9p-4, +-0x1.f70f6434b7eb7p-1, +-0x1.1775df66f0ec4p-56, +-0x1p-2, +0x1.1244c435e819dp-4, +-0x1.f7599a3a12077p-1, +-0x1.84f31d743195cp-55, +-0x1p-2, +0x1.1ea04e5ee7601p-4, +-0x1.f7a299c1a322ap-1, +-0x1.6e7190c94899ep-56, +-0x1p-2, +0x1.2afd9f6136a9cp-4, +-0x1.f7ea629e63d6ep-1, +-0x1.ba92d57ebfeddp-55, +-0x1p-2, +-0x1.9146a0c760c35p-5, +-0x1.f830f4a40c60cp-1, +-0x1.8528676925128p-57, +-0x1p-3, +-0x1.78851122cff19p-5, +-0x1.f8764fa714ba9p-1, +-0x1.ab256778ffcb6p-56, +-0x1p-3, +-0x1.5fc0219532f79p-5, +-0x1.f8ba737cb4b78p-1, +0x1.da71f96d5a49cp-55, +-0x1p-3, +-0x1.46f7e165f17c8p-5, +-0x1.f8fd5ffae41dbp-1, +0x1.8cfd77fd970d2p-56, +-0x1p-3, +-0x1.2e2c5fde7ea22p-5, +-0x1.f93f14f85ac08p-1, +0x1.cfd153e9a9c1ap-55, +-0x1p-3, +-0x1.155dac4a4f967p-5, +-0x1.f97f924c9099bp-1, +0x1.e2ae0eea5963bp-55, +-0x1p-3, +-0x1.f917abeda4499p-6, +-0x1.f9bed7cfbde29p-1, +0x1.b35b1f9bcf70bp-56, +-0x1p-3, +-0x1.c76dd866c689ep-6, +-0x1.f9fce55adb2c8p-1, +-0x1.f2a06fab9f9d1p-56, +-0x1p-3, +-0x1.95bdfca28b53ap-6, +-0x1.fa39bac7a1791p-1, +0x1.94f388f1b4e1ep-57, +-0x1p-3, +-0x1.64083747309d1p-6, +-0x1.fa7557f08a517p-1, +0x1.7a0a8ca13571fp-55, +-0x1p-3, +-0x1.324ca6fe9a04bp-6, +-0x1.faafbcb0cfddcp-1, +0x1.e349cb4d3e866p-55, +-0x1p-3, +-0x1.008b6a763de76p-6, +-0x1.fae8e8e46cfbbp-1, +0x1.3a9e414732d97p-56, +-0x1p-3, +-0x1.9d8940be24e74p-7, +-0x1.fb20dc681d54dp-1, +0x1.ff148ec7c5fafp-55, +-0x1p-3, +-0x1.39f0cedaf576bp-7, +-0x1.fb5797195d741p-1, +-0x1.1bfac7397cc08p-56, +-0x1p-3, +-0x1.ac9b7964cf0bap-8, +-0x1.fb8d18d66adb7p-1, +0x1.d0b66224cce2ep-56, +-0x1p-3, +-0x1.ca811eea0c749p-9, +-0x1.fbc1617e44186p-1, +0x1.58ec496dc4ecbp-59, +-0x1p-3, +-0x1.dd15adf70b65ap-12, +-0x1.fbf470f0a8d88p-1, +0x1.6bb200d1d70b7p-55, +-0x1p-3, +0x1.536352ad19e39p-9, +-0x1.fc26470e19fd3p-1, +-0x1.1ec8668ecaceep-55, +-0x1p-3, +0x1.7148021b55c15p-8, +-0x1.fc56e3b7d9af6p-1, +0x1.03ff7a673d3bdp-56, +-0x1p-3, +0x1.1c789a28b01b7p-7, +-0x1.fc8646cfeb721p-1, +-0x1.3143dc43a9b9dp-55, +-0x1p-3, +0x1.80566267c11f6p-7, +-0x1.fcb4703914354p-1, +-0x1.126aa7d51b25cp-55, +-0x1p-3, +0x1.e43d1c309e958p-7, +-0x1.fce15fd6da67bp-1, +0x1.5dd6f830d4c09p-56, +-0x1p-3, +0x1.241644f1c26cep-6, +-0x1.fd0d158d86087p-1, +-0x1.9705a7b864883p-55, +-0x1p-3, +0x1.561236eda8ff2p-6, +-0x1.fd37914220b84p-1, +-0x1.52e9d7b772791p-55, +-0x1p-3, +0x1.88124536d5e8fp-6, +-0x1.fd60d2da75c9ep-1, +-0x1.36dedb314f0ebp-58, +-0x1p-3, +0x1.ba1650f592f5p-6, +-0x1.fd88da3d12526p-1, +0x1.87df6378811c7p-55, +-0x1p-3, +0x1.ec1e3b4fb3d7ep-6, +-0x1.fdafa7514538cp-1, +-0x1.d97c45ca4d398p-59, +-0x1p-3, +0x1.0f14f2b4549bdp-5, +-0x1.fdd539ff1f456p-1, +0x1.ab13cbbec1781p-56, +-0x1p-3, +0x1.281c9830c9dafp-5, +-0x1.fdf9922f73307p-1, +-0x1.a5e0abd3a9b65p-56, +-0x1p-3, +-0x1.7db402a6a9063p-6, +-0x1.fe1cafcbd5b09p-1, +-0x1.a23e3202a884ep-57, +-0x1p-4, +-0x1.4b9dd29353428p-6, +-0x1.fe3e92be9d886p-1, +-0x1.afeb2e264d46bp-57, +-0x1p-4, +-0x1.19845e49c8257p-6, +-0x1.fe5f3af2e394p-1, +-0x1.b213f18c9cf17p-55, +-0x1p-4, +-0x1.cecf8962d14c8p-7, +-0x1.fe7ea85482d6p-1, +-0x1.34b085c1828f7p-56, +-0x1p-4, +-0x1.6a9049670cfaep-7, +-0x1.fe9cdad01883ap-1, +-0x1.521ecd0c67e35p-57, +-0x1p-4, +-0x1.064b3a76a2264p-7, +-0x1.feb9d2530410fp-1, +-0x1.9d429eeda9bb9p-58, +-0x1p-4, +-0x1.440134d709b28p-8, +-0x1.fed58ecb673c4p-1, +0x1.e6e462a7ae686p-56, +-0x1p-4, +-0x1.ed853918c18ecp-10, +-0x1.fef0102826191p-1, +-0x1.3c3ea4f30addap-56, +-0x1p-4, +0x1.35230c0fbe402p-10, +-0x1.ff095658e71adp-1, +-0x1.01a8ce18a4b9ep-55, +-0x1p-4, +0x1.15fc833fb89b8p-8, +-0x1.ff21614e131edp-1, +0x1.de692a167353p-55, +-0x1p-4, +0x1.deb9769f940eap-8, +-0x1.ff3830f8d575cp-1, +0x1.95e1e79d335f7p-56, +-0x1p-4, +0x1.53bf90a81f3a5p-7, +-0x1.ff4dc54b1bed3p-1, +0x1.c1169ccd1e92ep-55, +-0x1p-4, +0x1.b82683bc89fbp-7, +-0x1.ff621e3796d7ep-1, +0x1.c57bc2e24aa15p-57, +-0x1p-4, +0x1.0e48ab4f172f4p-6, +-0x1.ff753bb1b9164p-1, +0x1.7c330129f56efp-56, +-0x1p-4, +-0x1.7f0034a43350ep-7, +-0x1.ff871dadb81dfp-1, +-0x1.8b1c676208aa4p-56, +-0x1p-5, +-0x1.1a8e5bfe185e4p-7, +-0x1.ff97c4208c014p-1, +-0x1.52ab2b947e843p-57, +-0x1p-5, +-0x1.6c32baca2ae69p-8, +-0x1.ffa72effef75dp-1, +0x1.8b4cdcdb25956p-55, +-0x1p-5, +-0x1.4685db42c17ebp-9, +-0x1.ffb55e425fdaep-1, +-0x1.6da7ec781c225p-55, +-0x1p-5, +0x1.2d919c5c61fep-11, +-0x1.ffc251df1d3f8p-1, +-0x1.7a7d209f32d43p-56, +-0x1p-5, +0x1.dd58598d6271cp-9, +-0x1.ffce09ce2a679p-1, +0x1.7bd62ab5ee228p-55, +-0x1p-5, +0x1.b7aa821726608p-8, +-0x1.ffd886084cd0dp-1, +0x1.1354d4556e4cbp-55, +-0x1p-5, +-0x1.7f53487eac897p-8, +-0x1.ffe1c6870cb77p-1, +-0x1.89aa14768323ep-55, +-0x1p-6, +-0x1.6c9b5df1877eap-9, +-0x1.ffe9cb44b51a1p-1, +-0x1.5b43366df667p-56, +-0x1p-6, +0x1.2bad2a8cd06bp-12, +-0x1.fff0943c53bd1p-1, +0x1.47399f361d158p-55, +-0x1p-6, +0x1.b78b80c84e1eep-9, +-0x1.fff62169b92dbp-1, +-0x1.5dda3c81fbd0dp-55, +-0x1p-6, +-0x1.6cb587284b817p-10, +-0x1.fffa72c978c4fp-1, +0x1.22cb000328f91p-55, +-0x1p-7, +0x1.b783c0663fe3cp-10, +-0x1.fffd8858e8a92p-1, +-0x1.359c71883bcf7p-55, +-0x1p-7, +0x1.b781d04cd6d17p-11, +-0x1.ffff621621d02p-1, +0x1.6acfcebc82813p-56, +-0x1p-8, +0, +-0x1p0, +0, +0, +-0x1.b781d04cd6d17p-11, +-0x1.ffff621621d02p-1, +0x1.6acfcebc82813p-56, +0x1p-8, +-0x1.b783c0663fe3cp-10, +-0x1.fffd8858e8a92p-1, +-0x1.359c71883bcf7p-55, +0x1p-7, +0x1.6cb587284b817p-10, +-0x1.fffa72c978c4fp-1, +0x1.22cb000328f91p-55, +0x1p-7, +-0x1.b78b80c84e1eep-9, +-0x1.fff62169b92dbp-1, +-0x1.5dda3c81fbd0dp-55, +0x1p-6, +-0x1.2bad2a8cd06bp-12, +-0x1.fff0943c53bd1p-1, +0x1.47399f361d158p-55, +0x1p-6, +0x1.6c9b5df1877eap-9, +-0x1.ffe9cb44b51a1p-1, +-0x1.5b43366df667p-56, +0x1p-6, +0x1.7f53487eac897p-8, +-0x1.ffe1c6870cb77p-1, +-0x1.89aa14768323ep-55, +0x1p-6, +-0x1.b7aa821726608p-8, +-0x1.ffd886084cd0dp-1, +0x1.1354d4556e4cbp-55, +0x1p-5, +-0x1.dd58598d6271cp-9, +-0x1.ffce09ce2a679p-1, +0x1.7bd62ab5ee228p-55, +0x1p-5, +-0x1.2d919c5c61fep-11, +-0x1.ffc251df1d3f8p-1, +-0x1.7a7d209f32d43p-56, +0x1p-5, +0x1.4685db42c17ebp-9, +-0x1.ffb55e425fdaep-1, +-0x1.6da7ec781c225p-55, +0x1p-5, +0x1.6c32baca2ae69p-8, +-0x1.ffa72effef75dp-1, +0x1.8b4cdcdb25956p-55, +0x1p-5, +0x1.1a8e5bfe185e4p-7, +-0x1.ff97c4208c014p-1, +-0x1.52ab2b947e843p-57, +0x1p-5, +0x1.7f0034a43350ep-7, +-0x1.ff871dadb81dfp-1, +-0x1.8b1c676208aa4p-56, +0x1p-5, +-0x1.0e48ab4f172f4p-6, +-0x1.ff753bb1b9164p-1, +0x1.7c330129f56efp-56, +0x1p-4, +-0x1.b82683bc89fbp-7, +-0x1.ff621e3796d7ep-1, +0x1.c57bc2e24aa15p-57, +0x1p-4, +-0x1.53bf90a81f3a5p-7, +-0x1.ff4dc54b1bed3p-1, +0x1.c1169ccd1e92ep-55, +0x1p-4, +-0x1.deb9769f940eap-8, +-0x1.ff3830f8d575cp-1, +0x1.95e1e79d335f7p-56, +0x1p-4, +-0x1.15fc833fb89b8p-8, +-0x1.ff21614e131edp-1, +0x1.de692a167353p-55, +0x1p-4, +-0x1.35230c0fbe402p-10, +-0x1.ff095658e71adp-1, +-0x1.01a8ce18a4b9ep-55, +0x1p-4, +0x1.ed853918c18ecp-10, +-0x1.fef0102826191p-1, +-0x1.3c3ea4f30addap-56, +0x1p-4, +0x1.440134d709b28p-8, +-0x1.fed58ecb673c4p-1, +0x1.e6e462a7ae686p-56, +0x1p-4, +0x1.064b3a76a2264p-7, +-0x1.feb9d2530410fp-1, +-0x1.9d429eeda9bb9p-58, +0x1p-4, +0x1.6a9049670cfaep-7, +-0x1.fe9cdad01883ap-1, +-0x1.521ecd0c67e35p-57, +0x1p-4, +0x1.cecf8962d14c8p-7, +-0x1.fe7ea85482d6p-1, +-0x1.34b085c1828f7p-56, +0x1p-4, +0x1.19845e49c8257p-6, +-0x1.fe5f3af2e394p-1, +-0x1.b213f18c9cf17p-55, +0x1p-4, +0x1.4b9dd29353428p-6, +-0x1.fe3e92be9d886p-1, +-0x1.afeb2e264d46bp-57, +0x1p-4, +0x1.7db402a6a9063p-6, +-0x1.fe1cafcbd5b09p-1, +-0x1.a23e3202a884ep-57, +0x1p-4, +-0x1.281c9830c9dafp-5, +-0x1.fdf9922f73307p-1, +-0x1.a5e0abd3a9b65p-56, +0x1p-3, +-0x1.0f14f2b4549bdp-5, +-0x1.fdd539ff1f456p-1, +0x1.ab13cbbec1781p-56, +0x1p-3, +-0x1.ec1e3b4fb3d7ep-6, +-0x1.fdafa7514538cp-1, +-0x1.d97c45ca4d398p-59, +0x1p-3, +-0x1.ba1650f592f5p-6, +-0x1.fd88da3d12526p-1, +0x1.87df6378811c7p-55, +0x1p-3, +-0x1.88124536d5e8fp-6, +-0x1.fd60d2da75c9ep-1, +-0x1.36dedb314f0ebp-58, +0x1p-3, +-0x1.561236eda8ff2p-6, +-0x1.fd37914220b84p-1, +-0x1.52e9d7b772791p-55, +0x1p-3, +-0x1.241644f1c26cep-6, +-0x1.fd0d158d86087p-1, +-0x1.9705a7b864883p-55, +0x1p-3, +-0x1.e43d1c309e958p-7, +-0x1.fce15fd6da67bp-1, +0x1.5dd6f830d4c09p-56, +0x1p-3, +-0x1.80566267c11f6p-7, +-0x1.fcb4703914354p-1, +-0x1.126aa7d51b25cp-55, +0x1p-3, +-0x1.1c789a28b01b7p-7, +-0x1.fc8646cfeb721p-1, +-0x1.3143dc43a9b9dp-55, +0x1p-3, +-0x1.7148021b55c15p-8, +-0x1.fc56e3b7d9af6p-1, +0x1.03ff7a673d3bdp-56, +0x1p-3, +-0x1.536352ad19e39p-9, +-0x1.fc26470e19fd3p-1, +-0x1.1ec8668ecaceep-55, +0x1p-3, +0x1.dd15adf70b65ap-12, +-0x1.fbf470f0a8d88p-1, +0x1.6bb200d1d70b7p-55, +0x1p-3, +0x1.ca811eea0c749p-9, +-0x1.fbc1617e44186p-1, +0x1.58ec496dc4ecbp-59, +0x1p-3, +0x1.ac9b7964cf0bap-8, +-0x1.fb8d18d66adb7p-1, +0x1.d0b66224cce2ep-56, +0x1p-3, +0x1.39f0cedaf576bp-7, +-0x1.fb5797195d741p-1, +-0x1.1bfac7397cc08p-56, +0x1p-3, +0x1.9d8940be24e74p-7, +-0x1.fb20dc681d54dp-1, +0x1.ff148ec7c5fafp-55, +0x1p-3, +0x1.008b6a763de76p-6, +-0x1.fae8e8e46cfbbp-1, +0x1.3a9e414732d97p-56, +0x1p-3, +0x1.324ca6fe9a04bp-6, +-0x1.faafbcb0cfddcp-1, +0x1.e349cb4d3e866p-55, +0x1p-3, +0x1.64083747309d1p-6, +-0x1.fa7557f08a517p-1, +0x1.7a0a8ca13571fp-55, +0x1p-3, +0x1.95bdfca28b53ap-6, +-0x1.fa39bac7a1791p-1, +0x1.94f388f1b4e1ep-57, +0x1p-3, +0x1.c76dd866c689ep-6, +-0x1.f9fce55adb2c8p-1, +-0x1.f2a06fab9f9d1p-56, +0x1p-3, +0x1.f917abeda4499p-6, +-0x1.f9bed7cfbde29p-1, +0x1.b35b1f9bcf70bp-56, +0x1p-3, +0x1.155dac4a4f967p-5, +-0x1.f97f924c9099bp-1, +0x1.e2ae0eea5963bp-55, +0x1p-3, +0x1.2e2c5fde7ea22p-5, +-0x1.f93f14f85ac08p-1, +0x1.cfd153e9a9c1ap-55, +0x1p-3, +0x1.46f7e165f17c8p-5, +-0x1.f8fd5ffae41dbp-1, +0x1.8cfd77fd970d2p-56, +0x1p-3, +0x1.5fc0219532f79p-5, +-0x1.f8ba737cb4b78p-1, +0x1.da71f96d5a49cp-55, +0x1p-3, +0x1.78851122cff19p-5, +-0x1.f8764fa714ba9p-1, +-0x1.ab256778ffcb6p-56, +0x1p-3, +0x1.9146a0c760c35p-5, +-0x1.f830f4a40c60cp-1, +-0x1.8528676925128p-57, +0x1p-3, +-0x1.2afd9f6136a9cp-4, +-0x1.f7ea629e63d6ep-1, +-0x1.ba92d57ebfeddp-55, +0x1p-2, +-0x1.1ea04e5ee7601p-4, +-0x1.f7a299c1a322ap-1, +-0x1.6e7190c94899ep-56, +0x1p-2, +-0x1.1244c435e819dp-4, +-0x1.f7599a3a12077p-1, +-0x1.84f31d743195cp-55, +0x1p-2, +-0x1.05eb0885a69c9p-4, +-0x1.f70f6434b7eb7p-1, +-0x1.1775df66f0ec4p-56, +0x1p-2, +-0x1.f32645d8e6ce9p-5, +-0x1.f6c3f7df5bbb7p-1, +-0x1.8561ce9d5ef5bp-56, +0x1p-2, +-0x1.da7a360ef9fefp-5, +-0x1.f677556883ceep-1, +-0x1.ef696a8d070f4p-57, +0x1p-2, +-0x1.c1d1f0e5967d5p-5, +-0x1.f6297cff75cbp-1, +-0x1.562172a361fd3p-56, +0x1p-2, +-0x1.a92d859275418p-5, +-0x1.f5da6ed43685dp-1, +0x1.536fc33bf9dd8p-55, +0x1p-2, +-0x1.908d0348ef266p-5, +-0x1.f58a2b1789e84p-1, +-0x1.1f4a188aa368p-56, +0x1p-2, +-0x1.77f07939f3897p-5, +-0x1.f538b1faf2d07p-1, +0x1.5f7cd5099519cp-59, +0x1p-2, +-0x1.5f57f693feebep-5, +-0x1.f4e603b0b2f2dp-1, +0x1.8ee01e695ac05p-56, +0x1p-2, +-0x1.46c38a8311952p-5, +-0x1.f492206bcabb4p-1, +-0x1.d1e921bbe3bd3p-55, +0x1p-2, +-0x1.2e334430a6376p-5, +-0x1.f43d085ff92ddp-1, +0x1.8fde71e361c05p-55, +0x1p-2, +-0x1.15a732c3a894dp-5, +-0x1.f3e6bbc1bbc65p-1, +-0x1.5774bb7e8a21ep-57, +0x1p-2, +-0x1.fa3ecac0d84e8p-6, +-0x1.f38f3ac64e589p-1, +0x1.d7bafb51f72e6p-56, +0x1p-2, +-0x1.c937d65145919p-6, +-0x1.f33685a3aaefp-1, +-0x1.eb78685d850f8p-56, +0x1p-2, +-0x1.9839a676a6bcfp-6, +-0x1.f2dc9c9089a9dp-1, +-0x1.5407460bdfc07p-59, +0x1p-2, +-0x1.67445969a108ep-6, +-0x1.f2817fc4609cep-1, +0x1.dd1f8eaf65689p-55, +0x1p-2, +-0x1.36580d5d5e775p-6, +-0x1.f2252f7763adap-1, +0x1.20cb81c8d94abp-55, +0x1p-2, +-0x1.0574e07f7b332p-6, +-0x1.f1c7abe284708p-1, +-0x1.504b80c8a63fcp-55, +0x1p-2, +-0x1.a935e1efe5e4bp-7, +-0x1.f168f53f7205dp-1, +0x1.26a6c1f015601p-57, +0x1p-2, +-0x1.4794b9d21cb87p-7, +-0x1.f1090bc898f5fp-1, +0x1.baa64ab102a93p-55, +0x1p-2, +-0x1.cc0d09bd41caap-8, +-0x1.f0a7efb9230d7p-1, +-0x1.52c7adc6b4989p-56, +0x1p-2, +-0x1.0916fe858ffcdp-8, +-0x1.f045a14cf738cp-1, +0x1.a52c44f45216cp-55, +0x1p-2, +-0x1.191f2900903a6p-10, +-0x1.efe220c0b95ecp-1, +-0x1.c853b7bf7e0cdp-55, +0x1p-2, +0x1.f1806b9fdd1afp-10, +-0x1.ef7d6e51ca3cp-1, +0x1.a3c67c3d3f604p-55, +0x1p-2, +0x1.3ee038dff6b8p-8, +-0x1.ef178a3e473c2p-1, +-0x1.6310a67fe774fp-55, +0x1p-2, +0x1.009c0bd6cc3cbp-7, +-0x1.eeb074c50a544p-1, +-0x1.d925f656c43b4p-55, +0x1p-2, +0x1.61b39fb7b7202p-7, +-0x1.ee482e25a9dbcp-1, +0x1.b6066ef81af2ap-56, +0x1p-2, +0x1.c2b69c2e939b5p-7, +-0x1.eddeb6a078651p-1, +0x1.3b579af740a74p-55, +0x1p-2, +0x1.11d262b1f6776p-6, +-0x1.ed740e7684963p-1, +-0x1.e82c791f59cc2p-56, +0x1p-2, +0x1.423eefc693785p-6, +-0x1.ed0835e999009p-1, +-0x1.499d188aa32fap-57, +0x1p-2, +0x1.72a0d77651772p-6, +-0x1.ec9b2d3c3bf84p-1, +-0x1.19119d358de05p-56, +0x1p-2, +0x1.a2f7fbe8f2436p-6, +-0x1.ec2cf4b1af6b2p-1, +-0x1.34ee3f2caa62dp-59, +0x1p-2, +0x1.d3443f4cdb3ddp-6, +-0x1.ebbd8c8df0b74p-1, +-0x1.c6c8c615e7277p-56, +0x1p-2, +0x1.01c2c1eb93deep-5, +-0x1.eb4cf515b8811p-1, +-0x1.95da1ba97ec5ep-57, +0x1p-2, +0x1.19ddd5e1ddb8bp-5, +-0x1.eadb2e8e7a88ep-1, +0x1.92ec52ea226a3p-55, +0x1p-2, +0x1.31f34caaaa5d2p-5, +-0x1.ea68393e658p-1, +0x1.467259bb7b556p-56, +0x1p-2, +0x1.4a03176acf82dp-5, +-0x1.e9f4156c62ddap-1, +-0x1.760b1e2e3f81ep-55, +0x1p-2, +0x1.620d274aa2903p-5, +-0x1.e97ec36016b3p-1, +-0x1.5bc48562557d3p-55, +0x1p-2, +0x1.7a116d7601c35p-5, +-0x1.e9084361df7f2p-1, +-0x1.cdfc7ce9dc3e9p-55, +0x1p-2, +0x1.920fdb1c5d578p-5, +-0x1.e89095bad6025p-1, +0x1.5a4cc0fcbccap-55, +0x1p-2, +0x1.aa086170c0a8ep-5, +-0x1.e817bab4cd10dp-1, +0x1.d0afe686b5e0ap-56, +0x1p-2, +0x1.c1faf1a9db555p-5, +-0x1.e79db29a5165ap-1, +0x1.75e710aca58p-56, +0x1p-2, +0x1.d9e77d020a5bcp-5, +-0x1.e7227db6a9744p-1, +-0x1.2128794da5a5p-55, +0x1p-2, +0x1.f1cdf4b76138bp-5, +-0x1.e6a61c55d53a7p-1, +-0x1.660d981acdcf7p-56, +0x1p-2, +0x1.04d72505d9805p-4, +-0x1.e6288ec48e112p-1, +0x1.16b56f2847754p-57, +0x1p-2, +0x1.10c437224dbc2p-4, +-0x1.e5a9d550467d3p-1, +-0x1.7d431be53f92fp-56, +0x1p-2, +0x1.1cae2955c414fp-4, +-0x1.e529f04729ffcp-1, +-0x1.9075d6e6dfc8bp-55, +0x1p-2, +0x1.2894f446e0bccp-4, +-0x1.e4a8dff81ce5ep-1, +-0x1.43578776c0f46p-55, +0x1p-2, +0x1.3478909e39da9p-4, +-0x1.e426a4b2bc17ep-1, +-0x1.a873889744882p-55, +0x1p-2, +0x1.4058f7065c11ep-4, +-0x1.e3a33ec75ce85p-1, +-0x1.45089cd46bbb8p-57, +0x1p-2, +0x1.4c36202bcf08ep-4, +-0x1.e31eae870ce25p-1, +0x1.bc7094538d678p-56, +0x1p-2, +0x1.581004bd19ed2p-4, +-0x1.e298f4439197ap-1, +-0x1.e84e601038eb2p-57, +0x1p-2, +0x1.63e69d6ac7f74p-4, +-0x1.e212104f686e5p-1, +0x1.014c76c126527p-55, +0x1p-2, +0x1.6fb9e2e76ced8p-4, +-0x1.e18a02fdc66d9p-1, +-0x1.07e272abd88cfp-55, +0x1p-2, +0x1.7b89cde7a9a4dp-4, +-0x1.e100cca2980acp-1, +0x1.02d182acdf825p-57, +0x1p-2, +0x1.875657223080ap-4, +-0x1.e0766d9280f54p-1, +-0x1.f44c969cf62e3p-55, +0x1p-2, +0x1.931f774fc9f18p-4, +-0x1.dfeae622dbe2bp-1, +0x1.514ea88425567p-55, +0x1p-2, +0x1.9ee5272b58f2ap-4, +-0x1.df5e36a9ba59cp-1, +0x1.e01f8bceb43d3p-57, +0x1p-2, +-0x1.2aac5047103d3p-3, +-0x1.ded05f7de47dap-1, +0x1.2cc4c1f8ba966p-55, +0x1p-1, +-0x1.24ccf38ebe694p-3, +-0x1.de4160f6d8d81p-1, +-0x1.9bf11cc5f8776p-55, +0x1p-1, +-0x1.1eef59e0b74c3p-3, +-0x1.ddb13b6ccc23cp-1, +-0x1.83c37c6107db3p-55, +0x1p-1, +-0x1.191386db3dedcp-3, +-0x1.dd1fef38a915ap-1, +0x1.782f169e17f3bp-55, +0x1p-1, +-0x1.13397e1b7ce13p-3, +-0x1.dc8d7cb41026p-1, +-0x1.6b7872773830dp-56, +0x1p-1, +-0x1.0d61433d840a4p-3, +-0x1.dbf9e4395759ap-1, +-0x1.d8ff7350f75fdp-55, +0x1p-1, +-0x1.078ad9dc46632p-3, +-0x1.db6526238a09bp-1, +0x1.adee7eae6946p-56, +0x1p-1, +-0x1.01b6459197c38p-3, +-0x1.dacf42ce68ab9p-1, +0x1.fe8d76efdf896p-56, +0x1p-1, +-0x1.f7c713ec554fp-4, +-0x1.da383a9668988p-1, +0x1.5811000b39d84p-55, +0x1p-1, +-0x1.ec2555431bf03p-4, +-0x1.d9a00dd8b3d46p-1, +-0x1.bea0e4bac8e16p-58, +0x1p-1, +-0x1.e087565455a75p-4, +-0x1.d906bcf328d46p-1, +-0x1.457e610231ac2p-56, +0x1p-1, +-0x1.d4ed1e4a84aefp-4, +-0x1.d86c48445a44fp-1, +-0x1.e8813c023d71fp-55, +0x1p-1, +-0x1.c956b44dd6d41p-4, +-0x1.d7d0b02b8ecf9p-1, +-0x1.800f4ce65cd6ep-55, +0x1p-1, +-0x1.bdc41f84210bbp-4, +-0x1.d733f508c0dffp-1, +0x1.007928e770cd5p-55, +0x1p-1, +-0x1.b2356710db0a3p-4, +-0x1.d696173c9e68bp-1, +0x1.e8c61c6393d55p-56, +0x1p-1, +-0x1.a6aa92151adc3p-4, +-0x1.d5f7172888a7fp-1, +0x1.68663e2225755p-55, +0x1p-1, +-0x1.9b23a7af90805p-4, +-0x1.d556f52e93eb1p-1, +0x1.80ed9233a963p-55, +0x1p-1, +-0x1.8fa0aefc81837p-4, +-0x1.d4b5b1b187524p-1, +0x1.f56be6b42b76dp-57, +0x1p-1, +-0x1.8421af15c49d7p-4, +-0x1.d4134d14dc93ap-1, +0x1.4ef5295d25af2p-55, +0x1p-1, +-0x1.78a6af12bd501p-4, +-0x1.d36fc7bcbfbdcp-1, +0x1.ba196d95a177dp-55, +0x1p-1, +-0x1.6d2fb6085786ep-4, +-0x1.d2cb220e0ef9fp-1, +0x1.f07656d4e6652p-56, +0x1p-1, +-0x1.61bccb0903395p-4, +-0x1.d2255c6e5a4e1p-1, +0x1.d129a71ecafc9p-55, +0x1p-1, +-0x1.564df524b00dap-4, +-0x1.d17e7743e35dcp-1, +0x1.101da3540130ap-58, +0x1p-1, +-0x1.4ae33b68c8fdcp-4, +-0x1.d0d672f59d2b9p-1, +0x1.c83009f0c39dep-55, +0x1p-1, +-0x1.3f7ca4e02ffdcp-4, +-0x1.d02d4feb2bd92p-1, +-0x1.195ff41bc55fep-55, +0x1p-1, +-0x1.341a389339a36p-4, +-0x1.cf830e8ce467bp-1, +0x1.7b9202780d49dp-55, +0x1p-1, +-0x1.28bbfd87a8cffp-4, +-0x1.ced7af43cc773p-1, +0x1.e7b6bb5ab58aep-58, +0x1p-1, +-0x1.1d61fac0aa5b2p-4, +-0x1.ce2b32799a06p-1, +0x1.631d457e46317p-56, +0x1p-1, +-0x1.120c373ed0bfbp-4, +-0x1.cd7d9898b32f6p-1, +0x1.f2fa062496738p-57, +0x1p-1, +-0x1.06baba000fc9bp-4, +-0x1.cccee20c2deap-1, +0x1.d3116ae0e69e4p-55, +0x1p-1, +-0x1.f6db13ff708cbp-5, +-0x1.cc1f0f3fcfc5cp-1, +-0x1.e57613b68f6abp-56, +0x1p-1, +-0x1.e0495c6ce76b5p-5, +-0x1.cb6e20a00da99p-1, +0x1.4fb24b5194c1bp-55, +0x1p-1, +-0x1.c9c05b347ffabp-5, +-0x1.cabc169a0b9p-1, +-0x1.c42d3e10851d1p-55, +0x1p-1, +-0x1.b3401e3cd63bbp-5, +-0x1.ca08f19b9c449p-1, +0x1.431e0a5a737fdp-56, +0x1p-1, +-0x1.9cc8b3671dd0fp-5, +-0x1.c954b213411f5p-1, +0x1.2fb761e946603p-58, +0x1p-1, +-0x1.865a288f196fap-5, +-0x1.c89f587029c13p-1, +-0x1.588358ed6e78fp-58, +0x1p-1, +-0x1.6ff48b8b1252ap-5, +-0x1.c7e8e52233cf3p-1, +-0x1.b2ad324aa35c1p-57, +0x1p-1, +-0x1.5997ea2bcfb19p-5, +-0x1.c7315899eaad7p-1, +0x1.9be5dcd047da7p-57, +0x1p-1, +-0x1.4344523c8e3b5p-5, +-0x1.c678b3488739bp-1, +-0x1.d86cac7c5ff5bp-57, +0x1p-1, +-0x1.2cf9d182f7939p-5, +-0x1.c5bef59fef85ap-1, +0x1.f0a406c8b7468p-58, +0x1p-1, +-0x1.16b875bf19d4p-5, +-0x1.c5042012b6907p-1, +0x1.5c058dd8eaba5p-57, +0x1p-1, +-0x1.00804cab5f113p-5, +-0x1.c44833141c004p-1, +-0x1.23e0521df01a2p-56, +0x1p-1, +-0x1.d4a2c7f909c4ep-6, +-0x1.c38b2f180bdb1p-1, +0x1.6e0b1757c8d07p-56, +0x1p-1, +-0x1.a85792c327db2p-6, +-0x1.c2cd14931e3f1p-1, +-0x1.2ce2f9d4600f5p-56, +0x1p-1, +-0x1.7c1f1507aeec3p-6, +-0x1.c20de3fa971bp-1, +0x1.b4ca2bab1322cp-55, +0x1p-1, +-0x1.4ff96a0da9dfbp-6, +-0x1.c14d9dc465e57p-1, +-0x1.ce36b64c7f3ccp-55, +0x1p-1, +-0x1.23e6ad10872a7p-6, +-0x1.c08c426725549p-1, +-0x1.b157fd80e2946p-58, +0x1p-1, +-0x1.efcdf2801004ap-7, +-0x1.bfc9d25a1b147p-1, +0x1.51bf4ee01357p-61, +0x1p-1, +-0x1.97f4d3805f318p-7, +-0x1.bf064e15377ddp-1, +-0x1.2156026a1e028p-57, +0x1p-1, +-0x1.4042335264ba3p-7, +-0x1.be41b611154c1p-1, +0x1.fdcdad3a6877ep-55, +0x1p-1, +-0x1.d16c901d95181p-8, +-0x1.bd7c0ac6f952ap-1, +0x1.825a732ac700ap-55, +0x1p-1, +-0x1.22a28f6cb488bp-8, +-0x1.bcb54cb0d2327p-1, +-0x1.410923c55523ep-62, +0x1p-1, +-0x1.d09b418edf04ap-10, +-0x1.bbed7c49380eap-1, +-0x1.beacbd88500b4p-59, +0x1p-1, +0x1.d0320ae0b8293p-11, +-0x1.bb249a0b6c40dp-1, +0x1.d6318ee919f7ap-58, +0x1p-1, +0x1.cfc874c3eb6d9p-9, +-0x1.ba5aa673590d2p-1, +-0x1.7ea4e370753b6p-55, +0x1p-1, +0x1.9572af6decac8p-8, +-0x1.b98fa1fd9155ep-1, +-0x1.5559034fe85a4p-55, +0x1p-1, +0x1.21589ab88869cp-7, +-0x1.b8c38d27504e9p-1, +0x1.1529abff40e45p-55, +0x1p-1, +0x1.77cfb0c6e2db8p-7, +-0x1.b7f6686e792e9p-1, +-0x1.87665bfea06aap-55, +0x1p-1, +0x1.ce1e648bffb66p-7, +-0x1.b728345196e3ep-1, +0x1.bc69f324e6d61p-55, +0x1p-1, +0x1.1222406561182p-6, +-0x1.b658f14fdbc47p-1, +-0x1.52b5308f397dep-57, +0x1p-1, +0x1.3d20e82f8bc1p-6, +-0x1.b5889fe921405p-1, +0x1.df49b307c8602p-57, +0x1p-1, +0x1.680b0f1f0bd73p-6, +-0x1.b4b7409de7925p-1, +-0x1.f4e257bde73d8p-56, +0x1p-1, +0x1.92e09abb131d4p-6, +-0x1.b3e4d3ef55712p-1, +0x1.eb6b8bf11a493p-55, +0x1p-1, +0x1.bda17097896b4p-6, +-0x1.b3115a5f37bf3p-1, +-0x1.dde2726e34fe1p-55, +0x1p-1, +0x1.e84d76551cfb2p-6, +-0x1.b23cd470013b4p-1, +-0x1.5a1bb35ad6d2ep-56, +0x1p-1, +0x1.097248d0a956ap-5, +-0x1.b16742a4ca2f5p-1, +0x1.ba70972b80438p-55, +0x1p-1, +0x1.1eb3541b4b228p-5, +-0x1.b090a581502p-1, +0x1.926da300ffccep-55, +0x1p-1, +0x1.33e9cfee254edp-5, +-0x1.afb8fd89f57b6p-1, +-0x1.1ced12d2899b8p-60, +0x1p-1, +0x1.4915af336ceb4p-5, +-0x1.aee04b43c1474p-1, +0x1.3a79a438bf8ccp-55, +0x1p-1, +0x1.5e36e4dbe2bc2p-5, +-0x1.ae068f345ecefp-1, +0x1.33934c4029a4cp-56, +0x1p-1, +0x1.734d63dedb48ap-5, +-0x1.ad2bc9e21d511p-1, +0x1.47fbe07bea548p-55, +0x1p-1, +0x1.88591f3a46e4dp-5, +-0x1.ac4ffbd3efac8p-1, +0x1.818504103fa16p-56, +0x1p-1, +0x1.9d5a09f2b9b7fp-5, +-0x1.ab7325916c0d4p-1, +-0x1.a8b8c85baaa9bp-55, +0x1p-1, +0x1.b250171373be9p-5, +-0x1.aa9547a2cb98ep-1, +-0x1.87d00ae97abaap-60, +0x1p-1, +0x1.c73b39ae68c87p-5, +-0x1.a9b66290ea1a3p-1, +-0x1.9f630e8b6dac8p-60, +0x1p-1, +0x1.dc1b64dc48722p-5, +-0x1.a8d676e545ad2p-1, +0x1.b11dcce2e74bdp-59, +0x1p-1, +0x1.f0f08bbc861afp-5, +-0x1.a7f58529fe69dp-1, +0x1.97a441584a179p-55, +0x1p-1, +0x1.02dd50bab06b2p-4, +-0x1.a7138de9d60f5p-1, +0x1.f1ab82a9c5f2dp-55, +0x1p-1, +0x1.0d3ccc99f5ac6p-4, +-0x1.a63091b02fae2p-1, +0x1.e911152248d1p-56, +0x1p-1, +0x1.1796b31609f0cp-4, +-0x1.a54c91090f523p-1, +-0x1.184300fd1c1cep-56, +0x1p-1, +0x1.21eafdcc560fap-4, +-0x1.a4678c8119ac8p-1, +-0x1.1b4c0dd3f212ap-55, +0x1p-1, +0x1.2c39a65db8881p-4, +-0x1.a38184a593bc6p-1, +0x1.bc92c5bd2d288p-55, +0x1p-1, +0x1.3682a66e896f5p-4, +-0x1.a29a7a0462782p-1, +0x1.128bb015df175p-56, +0x1p-1, +0x1.40c5f7a69e5cep-4, +-0x1.a1b26d2c0a75ep-1, +-0x1.30ef431d627a6p-57, +0x1p-1, +0x1.4b0393b14e541p-4, +-0x1.a0c95eabaf937p-1, +0x1.e0ca3acbd049ap-55, +0x1p-1, +0x1.553b743d75acp-4, +-0x1.9fdf4f13149dep-1, +-0x1.1e6d79006ec09p-55, +0x1p-1, +0x1.5f6d92fd79f5p-4, +-0x1.9ef43ef29af94p-1, +-0x1.b1dfcb60445c2p-56, +0x1p-1, +0x1.6999e9a74ddbep-4, +-0x1.9e082edb42472p-1, +-0x1.5809a4e121e22p-57, +0x1p-1, +0x1.73c071f4750b5p-4, +-0x1.9d1b1f5ea80d5p-1, +-0x1.c5fadd5ffb36fp-55, +0x1p-1, +0x1.7de125a2080a9p-4, +-0x1.9c2d110f075c2p-1, +-0x1.d9c9f1c8c30dp-55, +0x1p-1, +0x1.87fbfe70b81a7p-4, +-0x1.9b3e047f38741p-1, +0x1.30ee286712474p-55, +0x1p-1, +0x1.9210f624d30fbp-4, +-0x1.9a4dfa42b06b2p-1, +0x1.829b6b8b1c947p-56, +0x1p-1, +0x1.9c200686472b5p-4, +-0x1.995cf2ed80d22p-1, +-0x1.7783e907fbd7bp-56, +0x1p-1, +0x1.a6292960a6f0bp-4, +-0x1.986aef1457594p-1, +0x1.af03e318f38fcp-55, +0x1p-1, +0x1.b02c58832cf96p-4, +-0x1.9777ef4c7d742p-1, +0x1.15479a240665ep-55, +0x1p-1, +0x1.ba298dc0bfc6bp-4, +-0x1.9683f42bd7fe1p-1, +0x1.11bad933c835ep-57, +0x1p-1, +0x1.c420c2eff590ep-4, +-0x1.958efe48e6dd7p-1, +0x1.561335da0f4e7p-55, +0x1p-1, +0x1.ce11f1eb18148p-4, +-0x1.94990e3ac4a6cp-1, +-0x1.a95328edeb3e6p-56, +0x1p-1, +0x1.d7fd1490285cap-4, +-0x1.93a22499263fbp-1, +-0x1.3d419a920df0bp-55, +0x1p-1, +0x1.e1e224c0e28bdp-4, +-0x1.92aa41fc5a815p-1, +0x1.68f89e2d23db7p-57, +0x1p-1, +0x1.ebc11c62c1a1ep-4, +-0x1.91b166fd49da2p-1, +0x1.3be953a7fe996p-57, +0x1p-1, +0x1.f599f55f034p-4, +-0x1.90b7943575efep-1, +-0x1.4ecb0c5273706p-57, +0x1p-1, +0x1.ff6ca9a2ab6a2p-4, +-0x1.8fbcca3ef940dp-1, +0x1.6dfa99c86f2f1p-57, +0x1p-1, +0x1.049c998f44231p-3, +-0x1.8ec109b486c49p-1, +0x1.cb2a3eb6af617p-56, +0x1p-1, +0x1.097fc5e39aec5p-3, +-0x1.8dc45331698ccp-1, +-0x1.1d9fcd83634d7p-57, +0x1p-1, +0x1.0e5fd6ca90dffp-3, +-0x1.8cc6a75184655p-1, +0x1.e18b3657e2285p-55, +0x1p-1, +0x1.133cc94247758p-3, +-0x1.8bc806b151741p-1, +0x1.2c5e12ed1336dp-55, +0x1p-1, +0x1.18169a4acca89p-3, +-0x1.8ac871ede1d88p-1, +0x1.9afaa5b7cfc55p-55, +0x1p-1, +0x1.1ced46e61cd1cp-3, +-0x1.89c7e9a4dd4aap-1, +-0x1.db6ea04a8678fp-55, +0x1p-1, +0x1.21c0cc18247fcp-3, +-0x1.88c66e7481ba1p-1, +0x1.5c6228970cf35p-56, +0x1p-1, +0x1.269126e6c24e3p-3, +-0x1.87c400fba2ebfp-1, +0x1.2dabc0c3f64cdp-55, +0x1p-1, +0x1.2b5e5459c8bc3p-3, +-0x1.86c0a1d9aa195p-1, +-0x1.84564f09c3726p-59, +0x1p-1, +0x1.3028517b0001p-3, +-0x1.85bc51ae958ccp-1, +-0x1.45ba6478086ccp-55, +0x1p-1, +0x1.34ef1b5627dfdp-3, +-0x1.84b7111af83fap-1, +0x1.63a47df0b21bap-55, +0x1p-1, +0x1.39b2aef8f97a4p-3, +-0x1.83b0e0bff976ep-1, +0x1.6f420f8ea3475p-56, +0x1p-1, +0x1.3e73097329219p-3, +-0x1.82a9c13f545ffp-1, +0x1.65e87a7a8cde9p-56, +0x1p-1, +0x1.433027d66826dp-3, +-0x1.81a1b33b57accp-1, +0x1.5dea12d66bb66p-55, +0x1p-1, +0x1.47ea073666a98p-3, +-0x1.8098b756e52fap-1, +-0x1.9136e834b4707p-55, +0x1p-1, +0x1.4ca0a4a8d5657p-3, +-0x1.7f8ece3571771p-1, +0x1.9c8d8ce93c917p-55, +0x1p-1, +0x1.5153fd45677efp-3, +-0x1.7e83f87b03686p-1, +-0x1.b61a8ccabad6p-57, +0x1p-1, +0x1.56040e25d44ddp-3, +-0x1.7d7836cc33db2p-1, +-0x1.162715ef03f85p-56, +0x1p-1, +0x1.5ab0d465d927ap-3, +-0x1.7c6b89ce2d333p-1, +0x1.cfd628084982cp-56, +0x1p-1, +0x1.5f5a4d233b27fp-3, +-0x1.7b5df226aafafp-1, +0x1.0f537acdf0ad7p-56, +0x1p-1, +0x1.6400757dc8f7dp-3, +-0x1.7a4f707bf97d2p-1, +-0x1.3c9751b491eafp-55, +0x1p-1, +0x1.68a34a975c941p-3, +-0x1.79400574f55e5p-1, +0x1.0adadbdb4c65ap-55, +0x1p-1, +0x1.6d42c993dd121p-3, +-0x1.782fb1b90b35bp-1, +0x1.3e46c1dfd001cp-55, +0x1p-1, +0x1.71deef9940631p-3, +-0x1.771e75f037261p-1, +-0x1.5cfce8d84068fp-56, +0x1p-1, +0x1.7677b9cf8d17p-3, +-0x1.760c52c304764p-1, +0x1.11d76f8e50f1fp-55, +0x1p-1, +0x1.7b0d2560dc1d1p-3, +-0x1.74f948da8d28dp-1, +-0x1.19900a3b9a3a2p-63, +0x1p-1, +0x1.7f9f2f795a83ep-3, +-0x1.73e558e079942p-1, +0x1.2663126697f5ep-55, +0x1p-1, +0x1.842dd5474b37bp-3, +-0x1.72d0837efff96p-1, +-0x1.0d4ef0f1d915cp-55, +0x1p-1, +0x1.88b913fb08bfdp-3, +-0x1.71bac960e41bfp-1, +0x1.b858d90b0f7d8p-56, +0x1p-1, +0x1.8d40e8c706fa4p-3, +-0x1.70a42b3176d7ap-1, +0x1.d9e3fbe2e15ap-56, +0x1p-1, +0x1.91c550dfd4d6bp-3, +-0x1.6f8ca99c95b75p-1, +-0x1.f22e7a35723f4p-56, +0x1p-1, +0x1.9646497c1e0f6p-3, +-0x1.6e74454eaa8afp-1, +0x1.dbc03c84e226ep-55, +0x1p-1, +0x1.9ac3cfd4ace19p-3, +-0x1.6d5afef4aafcdp-1, +0x1.868a696b8835ep-55, +0x1p-1, +0x1.9f3de1246bc4p-3, +-0x1.6c40d73c18275p-1, +-0x1.25d4f802be257p-57, +0x1p-1, +0x1.a3b47aa8671c5p-3, +-0x1.6b25ced2fe29cp-1, +0x1.5ac64116beda5p-55, +0x1p-1, +0, +-0x1.6a09e667f3bcdp-1, +0x1.bdd3413b26456p-55, +0, +-0x1.29b4625a03ac9p-2, +-0x1.68ed1eaa19c71p-1, +-0x1.fd4a85350f69p-56, +0x1p0, +-0x1.277e5187cfb16p-2, +-0x1.67cf78491af1p-1, +-0x1.750ab23477b61p-59, +0x1p0, +-0x1.254a0216aa067p-2, +-0x1.66b0f3f52b386p-1, +-0x1.1e2eb31a8848bp-55, +0x1p0, +-0x1.23177562aaea3p-2, +-0x1.6591925f0783dp-1, +-0x1.c3d64fbf5de23p-55, +0x1p0, +-0x1.20e6acc6d4916p-2, +-0x1.64715437f535bp-1, +0x1.7c399c15a17dp-55, +0x1p0, +-0x1.1eb7a99d1250cp-2, +-0x1.63503a31c1be9p-1, +-0x1.1248f09e6587cp-57, +0x1p0, +-0x1.1c8a6d3e37c82p-2, +-0x1.622e44fec22ffp-1, +-0x1.f98d8be132d57p-56, +0x1p0, +-0x1.1a5ef902000d3p-2, +-0x1.610b7551d2cdfp-1, +0x1.251b352ff2a37p-56, +0x1p0, +-0x1.18354e3f0cd7dp-2, +-0x1.5fe7cbde56a1p-1, +0x1.fcb9cc30cc01ep-55, +0x1p0, +-0x1.160d6e4ae5ae6p-2, +-0x1.5ec3495837074p-1, +-0x1.dea89a9b8f727p-56, +0x1p0, +-0x1.13e75a79f7139p-2, +-0x1.5d9dee73e345cp-1, +0x1.de1165ecdf7a3p-57, +0x1p0, +-0x1.11c3141f91b3ep-2, +-0x1.5c77bbe65018cp-1, +-0x1.069ea9c0bc32ap-55, +0x1p0, +-0x1.0fa09c8de994bp-2, +-0x1.5b50b264f7448p-1, +-0x1.519d30d4cfebp-56, +0x1p0, +-0x1.0d7ff51615437p-2, +-0x1.5a28d2a5d725p-1, +-0x1.57a25f8b1343p-55, +0x1p0, +-0x1.0b611f080d05bp-2, +-0x1.59001d5f723dfp-1, +-0x1.a9f86ba0dde98p-56, +0x1p0, +-0x1.09441bb2aa0a2p-2, +-0x1.57d69348cecap-1, +0x1.75720992bfbb2p-55, +0x1p0, +-0x1.0728ec63a599ap-2, +-0x1.56ac35197649fp-1, +0x1.f7874188cb279p-55, +0x1p0, +-0x1.050f92679849cp-2, +-0x1.5581038975137p-1, +-0x1.4570d9efe26dfp-55, +0x1p0, +-0x1.02f80f09f92f4p-2, +-0x1.5454ff5159dfcp-1, +0x1.4e247588bf256p-55, +0x1p0, +-0x1.00e263951d11fp-2, +-0x1.5328292a35596p-1, +0x1.a12eb89da0257p-56, +0x1p0, +-0x1.fd9d22a46b416p-3, +-0x1.51fa81cd99aa6p-1, +0x1.499f59d8560e9p-63, +0x1p0, +-0x1.f9793312a14d1p-3, +-0x1.50cc09f59a09bp-1, +-0x1.693463a2c2e6fp-56, +0x1p0, +-0x1.f558fb02ae805p-3, +-0x1.4f9cc25cca486p-1, +-0x1.48b5951cfc2b5p-55, +0x1p0, +-0x1.f13c7d001a249p-3, +-0x1.4e6cabbe3e5e9p-1, +-0x1.3c293edceb327p-57, +0x1p0, +-0x1.ed23bb941f019p-3, +-0x1.4d3bc6d589f7fp-1, +-0x1.6e4d9d6b72011p-55, +0x1p0, +-0x1.e90eb945a9ccfp-3, +-0x1.4c0a145ec0004p-1, +-0x1.2630cfafceaa1p-58, +0x1p0, +-0x1.e4fd7899579acp-3, +-0x1.4ad79516722f1p-1, +0x1.1273b163000f7p-55, +0x1p0, +-0x1.e0effc1174505p-3, +-0x1.49a449b9b0939p-1, +0x1.27ee16d719b94p-55, +0x1p0, +-0x1.dce6462df917dp-3, +-0x1.48703306091ffp-1, +0x1.70813b86159fdp-57, +0x1p0, +-0x1.d8e0596c8ad56p-3, +-0x1.473b51b987347p-1, +-0x1.ca1953514e41bp-57, +0x1p0, +-0x1.d4de3848789e2p-3, +-0x1.4605a692b32a2p-1, +-0x1.21ca219b97107p-55, +0x1p0, +-0x1.d0dfe53aba2fdp-3, +-0x1.44cf325091dd6p-1, +-0x1.8076a2cfdc6b3p-57, +0x1p0, +-0x1.cce562b9ee6aep-3, +-0x1.4397f5b2a438p-1, +0x1.7274c9e48c226p-55, +0x1p0, +-0x1.c8eeb33a59cdp-3, +-0x1.425ff178e6bb1p-1, +-0x1.7b38d675140cap-55, +0x1p0, +-0x1.c4fbd92de4eddp-3, +-0x1.41272663d108cp-1, +-0x1.1bbe7636fadf5p-55, +0x1p0, +-0x1.c10cd7041afccp-3, +-0x1.3fed9534556d4p-1, +-0x1.36916608c5061p-55, +0x1p0, +-0x1.bd21af2a28408p-3, +-0x1.3eb33eabe068p-1, +-0x1.86a2357d1a0d3p-58, +0x1p0, +-0x1.b93a640ad8978p-3, +-0x1.3d78238c58344p-1, +0x1.0219f5f0f79cep-55, +0x1p0, +-0x1.b556f80e95facp-3, +-0x1.3c3c44981c518p-1, +0x1.b5e9a9644151bp-55, +0x1p0, +-0x1.b1776d9b67013p-3, +-0x1.3affa292050b9p-1, +-0x1.e3e25e3954964p-56, +0x1p0, +-0x1.ad9bc714ed64fp-3, +-0x1.39c23e3d63029p-1, +0x1.3b05b276085c1p-58, +0x1p0, +-0x1.a9c406dc648a5p-3, +-0x1.3884185dfeb22p-1, +0x1.a038026abe6b2p-56, +0x1p0, +-0x1.a5f02f50a007cp-3, +-0x1.374531b817f8dp-1, +-0x1.444d2b0a747fep-55, +0x1p0, +-0x1.a22042ce0a2f9p-3, +-0x1.36058b10659f3p-1, +0x1.1fcb3a35857e7p-55, +0x1p0, +-0x1.9e5443aea29b2p-3, +-0x1.34c5252c14de1p-1, +-0x1.583f49632ab2bp-55, +0x1p0, +-0x1.9a8c3449fcb77p-3, +-0x1.338400d0c8e57p-1, +0x1.abf2a5e95e6e5p-55, +0x1p0, +-0x1.96c816f53e539p-3, +-0x1.32421ec49a61fp-1, +-0x1.65e25cc951bfep-55, +0x1p0, +-0x1.9307ee031e2fdp-3, +-0x1.30ff7fce17035p-1, +0x1.efcc626f74a6fp-57, +0x1p0, +-0x1.8f4bbbc3e28f6p-3, +-0x1.2fbc24b441015p-1, +-0x1.dba4875410874p-57, +0x1p0, +-0x1.8b9382855fcaap-3, +-0x1.2e780e3e8ea17p-1, +0x1.b19fafe36587ap-55, +0x1p0, +-0x1.87df4492f6e38p-3, +-0x1.2d333d34e9bb8p-1, +0x1.0e2c2c5549e26p-55, +0x1p0, +-0x1.842f0435941afp-3, +-0x1.2bedb25faf3eap-1, +0x1.14981c796ee46p-58, +0x1p0, +-0x1.8082c3b3ad887p-3, +-0x1.2aa76e87aeb58p-1, +-0x1.fd600833287a7p-59, +0x1p0, +-0x1.7cda855141b26p-3, +-0x1.2960727629ca8p-1, +-0x1.56d6c7af02d5cp-56, +0x1p0, +-0x1.79364b4fd6288p-3, +-0x1.2818bef4d3cbap-1, +0x1.e3fffeb76568ap-56, +0x1p0, +-0x1.759617ee761f9p-3, +-0x1.26d054cdd12dfp-1, +0x1.5da743ef3770cp-55, +0x1p0, +-0x1.71f9ed69b10eap-3, +-0x1.258734cbb711p-1, +-0x1.3a3f0903ce09dp-57, +0x1p0, +-0x1.6e61cdfb994dfp-3, +-0x1.243d5fb98ac1fp-1, +-0x1.c533d0a284a8dp-56, +0x1p0, +-0x1.6acdbbdbc2b73p-3, +-0x1.22f2d662c13e2p-1, +0x1.d5cc7580cb6d2p-55, +0x1p0, +-0x1.673db93f41479p-3, +-0x1.21a799933eb59p-1, +0x1.3a7b177c68fb2p-55, +0x1p0, +-0x1.63b1c858a7c2ep-3, +-0x1.205baa17560d6p-1, +-0x1.b7b144016c7a3p-56, +0x1p0, +-0x1.6029eb580658ep-3, +-0x1.1f0f08bbc861bp-1, +0x1.10d9dcafb74cbp-57, +0x1p0, +-0x1.5ca6246ae94b8p-3, +-0x1.1dc1b64dc4872p-1, +-0x1.f15e1c468be78p-57, +0x1p0, +-0x1.592675bc57974p-3, +-0x1.1c73b39ae68c8p-1, +-0x1.b25dd267f66p-55, +0x1p0, +-0x1.55aae174d19c8p-3, +-0x1.1b250171373bfp-1, +0x1.b210e95e1ca4cp-55, +0x1p0, +-0x1.523369ba4fcaep-3, +-0x1.19d5a09f2b9b8p-1, +0x1.33656c68a1d4ap-57, +0x1p0, +-0x1.4ec010b0414e1p-3, +-0x1.188591f3a46e5p-1, +0x1.bbefe5a524346p-56, +0x1p0, +-0x1.4b50d8778abbdp-3, +-0x1.1734d63dedb49p-1, +0x1.7eef2ccc50575p-55, +0x1p0, +-0x1.47e5c32e84c45p-3, +-0x1.15e36e4dbe2bcp-1, +-0x1.3c545f7d79eaep-56, +0x1p0, +-0x1.447ed2f0fae31p-3, +-0x1.14915af336cebp-1, +-0x1.f3660558a0213p-56, +0x1p0, +-0x1.411c09d82a128p-3, +-0x1.133e9cfee254fp-1, +0x1.a1377cfd5ce5p-56, +0x1p0, +-0x1.3dbd69fabf802p-3, +-0x1.11eb3541b4b23p-1, +0x1.ef23b69abe4f1p-55, +0x1p0, +-0x1.3a62f56cd742ep-3, +-0x1.1097248d0a957p-1, +0x1.7a58759ba80ddp-55, +0x1p0, +-0x1.370cae3ffb12fp-3, +-0x1.0f426bb2a8e7ep-1, +0x1.bb58fb774f8eep-55, +0x1p0, +-0x1.33ba968321032p-3, +-0x1.0ded0b84bc4b6p-1, +0x1.8540fa327c55cp-55, +0x1p0, +-0x1.306cb042aa3bap-3, +-0x1.0c9704d5d898fp-1, +0x1.8d3d7de6ee9b2p-55, +0x1p0, +-0x1.2d22fd8861b6bp-3, +-0x1.0b405878f85ecp-1, +0x1.ad66c3bb80da5p-55, +0x1p0, +-0x1.29dd805b7afecp-3, +-0x1.09e907417c5e1p-1, +0x1.fe573741a9bd4p-55, +0x1p0, +-0x1.269c3ac090ee4p-3, +-0x1.089112032b08cp-1, +-0x1.3248ddf9fe619p-57, +0x1p0, +-0x1.235f2eb9a470ap-3, +-0x1.073879922ffeep-1, +0x1.a5a014347406cp-55, +0x1p0, +-0x1.20265e461b45ap-3, +-0x1.05df3ec31b8b7p-1, +0x1.e2dcad34d9c1dp-57, +0x1p0, +-0x1.1cf1cb62bec5dp-3, +-0x1.0485626ae221ap-1, +-0x1.b937d9091ff7p-55, +0x1p0, +-0x1.19c17809baa87p-3, +-0x1.032ae55edbd96p-1, +0x1.bdb022b40107ap-55, +0x1p0, +-0x1.169566329bcb7p-3, +-0x1.01cfc874c3eb7p-1, +0x1.34a35e7c2368cp-56, +0x1p0, +-0x1.136d97d24efccp-3, +-0x1.00740c82b82e1p-1, +0x1.6d48563c60e87p-55, +0x1p0, +-0x1.104a0edb1fc58p-3, +-0x1.fe2f64be7121p-2, +0x1.297ab1ca2d7dbp-56, +0x1p0, +-0x1.0d2acd3cb7364p-3, +-0x1.fb7575c24d2dep-2, +0x1.5bfdc883c8664p-57, +0x1p0, +-0x1.0a0fd4e41ab5ap-3, +-0x1.f8ba4dbf89abap-2, +0x1.2ec1fc1b776b8p-60, +0x1p0, +-0x1.06f927bbaacfep-3, +-0x1.f5fdee656cda3p-2, +0x1.7bf9780816b05p-58, +0x1p0, +-0x1.03e6c7ab2208cp-3, +-0x1.f3405963fd067p-2, +-0x1.06846d44a238fp-56, +0x1p0, +-0x1.00d8b69793ae4p-3, +-0x1.f081906bff7fep-2, +0x1.4cab2d4ff6fccp-56, +0x1p0, +-0x1.fb9decc6d55b8p-4, +-0x1.edc1952ef78d6p-2, +0x1.dd0f7c33edee6p-56, +0x1p0, +-0x1.f59311dcd0d44p-4, +-0x1.eb00695f2562p-2, +-0x1.53c9fd3083e22p-56, +0x1p0, +-0x1.ef90e02b47283p-4, +-0x1.e83e0eaf85114p-2, +0x1.7bc380ef24ba7p-57, +0x1p0, +-0x1.e9975b670e077p-4, +-0x1.e57a86d3cd825p-2, +0x1.2c80dcd511e87p-57, +0x1p0, +-0x1.e3a6873fa1279p-4, +-0x1.e2b5d3806f63bp-2, +-0x1.e0d891d3c6841p-58, +0x1p0, +-0x1.ddbe675f1ffdfp-4, +-0x1.dfeff66a941dep-2, +0x1.a756c6e625f96p-56, +0x1p0, +-0x1.d7deff6a4b7c9p-4, +-0x1.dd28f1481cc58p-2, +0x1.e7576fa6c944ep-59, +0x1p0, +-0x1.d208530083d3p-4, +-0x1.da60c5cfa10d9p-2, +0x1.0f38e2143c8d5p-57, +0x1p0, +-0x1.cc3a65bbc6327p-4, +-0x1.d79775b86e389p-2, +-0x1.550ec87bc0575p-56, +0x1p0, +-0x1.c6753b30aa949p-4, +-0x1.d4cd02ba8609dp-2, +0x1.37f33c63033d6p-57, +0x1p0, +-0x1.c0b8d6ee61867p-4, +-0x1.d2016e8e9db5bp-2, +0x1.c8bce9d93efb8p-57, +0x1p0, +-0x1.bb053c7eb1f68p-4, +-0x1.cf34baee1cd21p-2, +0x1.118724d19d014p-56, +0x1p0, +-0x1.b55a6f65f7058p-4, +-0x1.cc66e9931c45ep-2, +-0x1.6850e59c37f8fp-58, +0x1p0, +-0x1.afb873231ddb9p-4, +-0x1.c997fc3865389p-2, +0x1.6295f8b0ca33bp-56, +0x1p0, +-0x1.aa1f4b2fa37fcp-4, +-0x1.c6c7f4997000bp-2, +0x1.bec2669c68e74p-56, +0x1p0, +-0x1.a48efaff92b3bp-4, +-0x1.c3f6d47263129p-2, +-0x1.9c7bd0fcdecddp-56, +0x1p0, +-0x1.9f07860181d1ep-4, +-0x1.c1249d8011ee7p-2, +0x1.813aabb515206p-56, +0x1p0, +-0x1.9988ef9e90b04p-4, +-0x1.be51517ffc0d9p-2, +-0x1.2b667131a5f16p-56, +0x1p0, +-0x1.94133b3a66851p-4, +-0x1.bb7cf2304bd01p-2, +-0x1.9e1a5bd9269d4p-57, +0x1p0, +-0x1.8ea66c332fd01p-4, +-0x1.b8a7814fd5693p-2, +-0x1.9a9e6651cc119p-56, +0x1p0, +-0x1.894285e19c468p-4, +-0x1.b5d1009e15ccp-2, +-0x1.5b362cb974183p-57, +0x1p0, +-0x1.83e78b98dcc2bp-4, +-0x1.b2f971db31972p-2, +-0x1.fa971a4a41f2p-56, +0x1p0, +-0x1.7e9580a6a136ep-4, +-0x1.b020d6c7f4009p-2, +-0x1.414ae7e555208p-58, +0x1p0, +-0x1.794c685316a3cp-4, +-0x1.ad473125cdc09p-2, +0x1.379ede57649dap-58, +0x1p0, +-0x1.740c45e0e512p-4, +-0x1.aa6c82b6d3fcap-2, +0x1.d5f106ee5ccf7p-56, +0x1p0, +-0x1.6ed51c8d2d8fcp-4, +-0x1.a790cd3dbf31bp-2, +0x1.7f786986d9023p-57, +0x1p0, +-0x1.69a6ef8f8830ap-4, +-0x1.a4b4127dea1e5p-2, +0x1.bec6f01bc22f1p-56, +0x1p0, +-0x1.6481c21a02123p-4, +-0x1.a1d6543b50acp-2, +0x1.0246cfd8779fbp-57, +0x1p0, +-0x1.5f6597591b633p-4, +-0x1.9ef7943a8ed8ap-2, +-0x1.6da81290bdbabp-57, +0x1p0, +-0x1.5a527273c56e1p-4, +-0x1.9c17d440df9f2p-2, +-0x1.923c540a9eec4p-57, +0x1p0, +-0x1.5548568b60a7bp-4, +-0x1.993716141bdffp-2, +0x1.15e8cce261c55p-56, +0x1p0, +-0x1.504746bbbac0bp-4, +-0x1.96555b7ab948fp-2, +-0x1.7afd51eff33adp-56, +0x1p0, +-0x1.4b4f461b0cbaap-4, +-0x1.9372a63bc93d7p-2, +-0x1.684319e5ad5b1p-57, +0x1p0, +-0x1.466057b9f900ap-4, +-0x1.908ef81ef7bd1p-2, +-0x1.4c00267012357p-56, +0x1p0, +-0x1.417a7ea389835p-4, +-0x1.8daa52ec8a4bp-2, +0x1.72eb2db8c621ep-57, +0x1p0, +-0x1.3c9dbddd2dd84p-4, +-0x1.8ac4b86d5ed44p-2, +-0x1.17fa7f944ad5bp-56, +0x1p0, +-0x1.37ca1866b95cfp-4, +-0x1.87de2a6aea963p-2, +0x1.72cedd3d5a61p-57, +0x1p0, +-0x1.32ff913a615dp-4, +-0x1.84f6aaaf3903fp-2, +-0x1.6dcdc2bd47067p-57, +0x1p0, +-0x1.2e3e2b4cbb3c3p-4, +-0x1.820e3b04eaac4p-2, +0x1.92379eb01c6b6p-59, +0x1p0, +-0x1.2985e98cbaa3ap-4, +-0x1.7f24dd37341e4p-2, +-0x1.2791a1b5eb796p-57, +0x1p0, +-0x1.24d6cee3afb2ap-4, +-0x1.7c3a9311dcce7p-2, +-0x1.9a3f21ef3e8d9p-62, +0x1p0, +-0x1.2030de354532cp-4, +-0x1.794f5e613dfaep-2, +-0x1.820a4b0d21fc5p-57, +0x1p0, +-0x1.1b941a5f7ecffp-4, +-0x1.766340f2418f6p-2, +-0x1.2b2adc9041b2cp-56, +0x1p0, +-0x1.1700863ab7533p-4, +-0x1.73763c9261092p-2, +0x1.52324face3b1ap-57, +0x1p0, +-0x1.127624999ee1dp-4, +-0x1.7088530fa459fp-2, +0x1.44b19e0864c5dp-56, +0x1p0, +-0x1.0df4f849393f5p-4, +-0x1.6d998638a0cb6p-2, +0x1.1ca14532860dfp-61, +0x1p0, +-0x1.097d0410dc132p-4, +-0x1.6aa9d7dc77e17p-2, +0x1.38b470592c7b3p-56, +0x1p0, +-0x1.050e4ab22d321p-4, +-0x1.67b949cad63cbp-2, +0x1.a23369348d7efp-56, +0x1p0, +-0x1.00a8cee920eabp-4, +-0x1.64c7ddd3f27c6p-2, +-0x1.10d2b4a664121p-58, +0x1p0, +-0x1.f89926d7f0ab8p-5, +-0x1.61d595c88c202p-2, +-0x1.f6b1e333415d7p-56, +0x1p0, +-0x1.eff335d67f541p-5, +-0x1.5ee27379ea693p-2, +-0x1.634ff2fa75245p-56, +0x1p0, +-0x1.e75fd0239926cp-5, +-0x1.5bee78b9db3b6p-2, +-0x1.e734a63158dfdp-58, +0x1p0, +-0x1.dedefb09791b4p-5, +-0x1.58f9a75ab1fddp-2, +0x1.efdc0d58cf62p-62, +0x1p0, +-0x1.d670bbc6e685ep-5, +-0x1.5604012f467b4p-2, +-0x1.a0e0b2a5b25p-56, +0x1p0, +-0x1.ce15178f31db3p-5, +-0x1.530d880af3c24p-2, +0x1.fab8e2103fbd6p-56, +0x1p0, +-0x1.c5cc138a317afp-5, +-0x1.50163dc197048p-2, +0x1.ec66cb05c7ea4p-56, +0x1p0, +-0x1.bd95b4d43e819p-5, +-0x1.4d1e24278e76ap-2, +-0x1.2417218792858p-57, +0x1p0, +-0x1.b572007e31a1bp-5, +-0x1.4a253d11b82f3p-2, +0x1.2afa4d6d42a55p-58, +0x1p0, +-0x1.ad60fb8d6003ap-5, +-0x1.472b8a5571054p-2, +0x1.01ea0fe4dff23p-56, +0x1p0, +-0x1.a562aafb982cdp-5, +-0x1.44310dc8936fp-2, +-0x1.8b694e91d3125p-56, +0x1p0, +-0x1.9d7713b71eee1p-5, +-0x1.4135c94176601p-2, +-0x1.0c97c4afa2518p-56, +0x1p0, +-0x1.959e3aa2ac58dp-5, +-0x1.3e39be96ec271p-2, +-0x1.814c6de9aaaf6p-56, +0x1p0, +-0x1.8dd8249568bbbp-5, +-0x1.3b3cefa0414b7p-2, +-0x1.f36dc4a9c2294p-56, +0x1p0, +-0x1.8624d65ae9a63p-5, +-0x1.383f5e353b6abp-2, +0x1.a812a4a5c3d44p-56, +0x1p0, +-0x1.7e8454b32ef34p-5, +-0x1.35410c2e18152p-2, +0x1.3cb002f96e062p-56, +0x1p0, +-0x1.76f6a4529fdb5p-5, +-0x1.3241fb638baafp-2, +-0x1.ecee8f76f8c51p-60, +0x1p0, +-0x1.6f7bc9e2080d9p-5, +-0x1.2f422daec0387p-2, +0x1.7501ba473da6fp-56, +0x1p0, +-0x1.6813c9fe94cfbp-5, +-0x1.2c41a4e95452p-2, +-0x1.9cf0354aad2dcp-56, +0x1p0, +-0x1.60bea939d225ap-5, +-0x1.294062ed59f06p-2, +0x1.5d28da2c4612dp-56, +0x1p0, +-0x1.597c6c19a8003p-5, +-0x1.263e6995554bap-2, +-0x1.1d350ffc5ff32p-56, +0x1p0, +-0x1.524d171857726p-5, +-0x1.233bbabc3bb71p-2, +-0x1.99b04e23259efp-56, +0x1p0, +-0x1.4b30aea477eeep-5, +-0x1.2038583d727bep-2, +0x1.c69cd46300a3p-57, +0x1p0, +-0x1.44273720f48bcp-5, +-0x1.1d3443f4cdb3ep-2, +0x1.720d41c13519ep-57, +0x1p0, +-0x1.3d30b4e5094ep-5, +-0x1.1a2f7fbe8f243p-2, +-0x1.6465ac86ba7b2p-56, +0x1p0, +-0x1.364d2c3c407bep-5, +-0x1.172a0d7765177p-2, +-0x1.22575f33366bep-57, +0x1p0, +-0x1.2f7ca1666ff6fp-5, +-0x1.1423eefc69378p-2, +-0x1.22d3368ec9b62p-56, +0x1p0, +-0x1.28bf1897b69ccp-5, +-0x1.111d262b1f677p-2, +-0x1.824c20ab7aa9ap-56, +0x1p0, +-0x1.221495f879af5p-5, +-0x1.0e15b4e1749cep-2, +0x1.5b7fb156c550ap-56, +0x1p0, +-0x1.1b7d1da562443p-5, +-0x1.0b0d9cfdbdb9p-2, +-0x1.3b3a7b8d1200dp-58, +0x1p0, +-0x1.14f8b3af5abb9p-5, +-0x1.0804e05eb661ep-2, +-0x1.54e583d92d3d8p-56, +0x1p0, +-0x1.0e875c1b8c3dap-5, +-0x1.04fb80e37fdaep-2, +0x1.412cdb72583ccp-63, +0x1p0, +-0x1.08291ae35c407p-5, +-0x1.01f1806b9fdd2p-2, +0x1.448135394b8bap-56, +0x1p0, +-0x1.01ddf3f46a139p-5, +-0x1.fdcdc1adfedf9p-3, +0x1.2dba4580ed7bbp-57, +0x1p0, +-0x1.f74bd66118e8dp-6, +-0x1.f7b7480bd3802p-3, +0x1.9a96d967ee12ep-57, +0x1p0, +-0x1.eb0208db9e51bp-6, +-0x1.f19f97b215f1bp-3, +0x1.42deef11da2c4p-57, +0x1p0, +-0x1.dede86ece142ep-6, +-0x1.eb86b462de348p-3, +0x1.bfcde46f90b62p-57, +0x1p0, +-0x1.d2e15811bf462p-6, +-0x1.e56ca1e101a1bp-3, +-0x1.46ac3f9fd0227p-57, +0x1p0, +-0x1.c70a83af71ef5p-6, +-0x1.df5163f01099ap-3, +0x1.01f7d79906e86p-57, +0x1p0, +-0x1.bb5a11138a4c9p-6, +-0x1.d934fe5454311p-3, +-0x1.75b92277107adp-57, +0x1p0, +-0x1.afd00773ec64fp-6, +-0x1.d31774d2cbdeep-3, +-0x1.2fdc8e5791a0bp-57, +0x1p0, +-0x1.a46c6deecac5fp-6, +-0x1.ccf8cb312b286p-3, +-0x1.2382b0aecadf8p-58, +0x1p0, +-0x1.992f4b8aa21f8p-6, +-0x1.c6d90535d74ddp-3, +0x1.bfb2be2264962p-59, +0x1p0, +-0x1.8e18a73634ee7p-6, +-0x1.c0b826a7e4f63p-3, +0x1.af1439e521935p-62, +0x1p0, +-0x1.832887c88735dp-6, +-0x1.ba96334f15dadp-3, +0x1.75098c05dd18ap-57, +0x1p0, +-0x1.785ef400da46cp-6, +-0x1.b4732ef3d6722p-3, +-0x1.bbe5d5d75cbd8p-57, +0x1p0, +-0x1.6dbbf286a8971p-6, +-0x1.ae4f1d5f3b9abp-3, +-0x1.aa8bbcef9b68ep-57, +0x1p0, +-0x1.633f89e9a1a66p-6, +-0x1.a82a025b00451p-3, +0x1.87905ffd084adp-57, +0x1p0, +-0x1.58e9c0a1a5f21p-6, +-0x1.a203e1b1831dap-3, +-0x1.c1aadb580a1ecp-58, +0x1p0, +-0x1.4eba9d0ec2f7cp-6, +-0x1.9bdcbf2dc4366p-3, +-0x1.9632d189956fep-57, +0x1p0, +-0x1.44b225792f46bp-6, +-0x1.95b49e9b62afap-3, +0x1.100b3d1dbfeaap-59, +0x1p0, +-0x1.3ad06011469fbp-6, +-0x1.8f8b83c69a60bp-3, +0x1.26d19b9ff8d82p-57, +0x1p0, +-0x1.311552ef8623cp-6, +-0x1.8961727c41804p-3, +-0x1.3fdab4e42640ap-58, +0x1p0, +-0x1.278104148891ap-6, +-0x1.83366e89c64c6p-3, +0x1.192952df10db8p-57, +0x1p0, +-0x1.1e1379690291cp-6, +-0x1.7d0a7bbd2cb1cp-3, +0x1.cf900f27c58efp-57, +0x1p0, +-0x1.14ccb8bdbf114p-6, +-0x1.76dd9de50bf31p-3, +-0x1.1d5eeec501b2fp-57, +0x1p0, +-0x1.0bacc7cb9babap-6, +-0x1.70afd8d08c4ffp-3, +-0x1.260c3f1369484p-57, +0x1p0, +-0x1.02b3ac3385232p-6, +-0x1.6a81304f64ab2p-3, +-0x1.f0cd73fb5d8d4p-58, +0x1p0, +-0x1.f3c2d6fce7cfap-7, +-0x1.6451a831d830dp-3, +-0x1.ad16031a34d5p-58, +0x1p0, +-0x1.e26c163ad15b3p-7, +-0x1.5e214448b3fc6p-3, +-0x1.531ff779ddac6p-57, +0x1p0, +-0x1.d16320d2d221ep-7, +-0x1.57f008654cbdep-3, +-0x1.908c95c4c9118p-58, +0x1p0, +-0x1.c0a80146f894cp-7, +-0x1.51bdf8597c5f2p-3, +0x1.9f9976af04aa5p-61, +0x1p0, +-0x1.b03ac1e94fe1dp-7, +-0x1.4b8b17f79fa88p-3, +-0x1.b534fe588f0dp-57, +0x1p0, +-0x1.a01b6cdbd995ep-7, +-0x1.45576b1293e5ap-3, +0x1.285a24119f7b1p-58, +0x1p0, +-0x1.904a0c10875cep-7, +-0x1.3f22f57db4893p-3, +-0x1.bfe7ff2274956p-59, +0x1p0, +-0x1.80c6a94934dfp-7, +-0x1.38edbb0cd8d14p-3, +0x1.198c21fbf7718p-57, +0x1p0, +-0x1.71914e17a1bc6p-7, +-0x1.32b7bf94516a7p-3, +-0x1.2a24e2431ef29p-57, +0x1p0, +-0x1.62aa03dd6ba58p-7, +-0x1.2c8106e8e613ap-3, +-0x1.13000a89a11ep-58, +0x1p0, +-0x1.5410d3cc0891ep-7, +-0x1.264994dfd3409p-3, +-0x1.a744ce26f39cp-57, +0x1p0, +-0x1.45c5c6e4c114ap-7, +-0x1.20116d4ec7bcfp-3, +0x1.242c8e1053452p-57, +0x1p0, +-0x1.37c8e5f8aacep-7, +-0x1.19d8940be24e7p-3, +-0x1.e8dcdca90cc74p-58, +0x1p0, +-0x1.2a1a39a8a2fb7p-7, +-0x1.139f0cedaf577p-3, +0x1.523434d1b3cfap-57, +0x1p0, +-0x1.1cb9ca654924fp-7, +-0x1.0d64dbcb26786p-3, +0x1.713a562132055p-58, +0x1p0, +-0x1.0fa7a06ef9e81p-7, +-0x1.072a047ba831dp-3, +-0x1.19db1f70118cap-58, +0x1p0, +-0x1.02e3c3d5c9e17p-7, +-0x1.00ee8ad6fb85bp-3, +-0x1.673eac8308f11p-58, +0x1p0, +-0x1.ecdc78f30165cp-8, +-0x1.f564e56a9730ep-4, +-0x1.a2704729ae56dp-59, +0x1p0, +-0x1.d48e24132851p-8, +-0x1.e8eb7fde4aa3fp-4, +0x1.23758f2d5bb8bp-58, +0x1p0, +-0x1.bcdc980a46f5ap-8, +-0x1.dc70ecbae9fc9p-4, +-0x1.2fda2d73295eep-60, +0x1p0, +-0x1.a5c7e375e55dep-8, +-0x1.cff533b307dc1p-4, +-0x1.8feeb8f9c3334p-59, +0x1p0, +-0x1.8f501492cc296p-8, +-0x1.c3785c79ec2d5p-4, +0x1.4f39df133fb21p-61, +0x1p0, +-0x1.7975393cfbc4dp-8, +-0x1.b6fa6ec38f64cp-4, +-0x1.db5d943691f09p-58, +0x1p0, +-0x1.64375eefa3dd6p-8, +-0x1.aa7b724495c03p-4, +-0x1.e5399ba0967b8p-58, +0x1p0, +-0x1.4f9692c51b0fbp-8, +-0x1.9dfb6eb24a85cp-4, +-0x1.e96b47b8c44e6p-59, +0x1p0, +-0x1.3b92e176d6d31p-8, +-0x1.917a6bc29b42cp-4, +0x1.e2718d26ed688p-60, +0x1p0, +-0x1.282c575d639fcp-8, +-0x1.84f8712c130a1p-4, +0x1.e626ebafe374ep-58, +0x1p0, +-0x1.156300705d51bp-8, +-0x1.787586a5d5b21p-4, +-0x1.5f7589f083399p-58, +0x1p0, +-0x1.0336e84667c66p-8, +-0x1.6bf1b3e79b129p-4, +0x1.14b6da08765p-58, +0x1p0, +-0x1.e350342a4f6e6p-9, +-0x1.5f6d00a9aa419p-4, +0x1.f4022d03f6c9ap-59, +0x1p0, +-0x1.c16d4162779e5p-9, +-0x1.52e774a4d4d0ap-4, +-0x1.b2edf18c730cbp-60, +0x1p0, +-0x1.a0c50d1c6bf93p-9, +-0x1.4661179272096p-4, +0x1.4b109f2406c4cp-58, +0x1p0, +-0x1.8157ab7d29fd9p-9, +-0x1.39d9f12c5a299p-4, +-0x1.1287ff27ae554p-62, +0x1p0, +-0x1.63252fe77c5ebp-9, +-0x1.2d52092ce19f6p-4, +0x1.9a088a8bf6b2cp-59, +0x1p0, +-0x1.462dacfbef0f3p-9, +-0x1.20c9674ed444dp-4, +0x1.f9d48faba7974p-58, +0x1p0, +-0x1.2a713498c3c3dp-9, +-0x1.1440134d709b3p-4, +0x1.fec446daea6adp-58, +0x1p0, +-0x1.0fefd7d9e6ed8p-9, +-0x1.07b614e463064p-4, +0x1.384f8c3ee7605p-58, +0x1p0, +-0x1.ed534e31ca57fp-10, +-0x1.f656e79f820ep-5, +0x1.2e1ebe392bffep-61, +0x1p0, +-0x1.bd3d63d9c26efp-10, +-0x1.dd406f9808ec9p-5, +-0x1.1313a4b4068bdp-62, +0x1p0, +-0x1.8f9e0e5514865p-10, +-0x1.c428d12c0d7e3p-5, +0x1.89bc74b58c513p-60, +0x1p0, +-0x1.647569c825ae1p-10, +-0x1.ab101bd5f8317p-5, +0x1.65c6175c6dc68p-59, +0x1p0, +-0x1.3bc390d250439p-10, +-0x1.91f65f10dd814p-5, +0x1.912bd0d569a9p-61, +0x1p0, +-0x1.15889c8dd385fp-10, +-0x1.78dbaa5874686p-5, +0x1.4a0ef4035c29cp-60, +0x1p0, +-0x1.e389491f8833ap-11, +-0x1.5fc00d290cd43p-5, +-0x1.a2669a693a8e1p-59, +0x1p0, +-0x1.a0ef7dcffafabp-11, +-0x1.46a396ff86179p-5, +-0x1.136ac00fa2da9p-61, +0x1p0, +-0x1.6344004228d8bp-11, +-0x1.2d865759455cdp-5, +-0x1.686f65ba93acp-61, +0x1p0, +-0x1.2a86f68094692p-11, +-0x1.14685db42c17fp-5, +0x1.2890d277cb974p-59, +0x1p0, +-0x1.ed71071603e86p-12, +-0x1.f693731d1cf01p-6, +0x1.3fe9bc66286c7p-66, +0x1p0, +-0x1.8fb18eacc3af8p-12, +-0x1.c454f4ce53b1dp-6, +0x1.d63d7fef0e36cp-60, +0x1p0, +-0x1.3bcfbd9979a27p-12, +-0x1.92155f7a3667ep-6, +0x1.b1d63091a013p-64, +0x1p0, +-0x1.e3978f34889d9p-13, +-0x1.5fd4d21fab226p-6, +0x1.0c0a91c37851cp-61, +0x1p0, +-0x1.634bb4ae5ed49p-13, +-0x1.2d936bbe30efdp-6, +-0x1.b5f91ee371d64p-61, +0x1p0, +-0x1.ed7875885ea3ap-14, +-0x1.f6a296ab997cbp-7, +0x1.f2943d8fe7033p-61, +0x1p0, +-0x1.3bd2c8da49511p-14, +-0x1.921d1fcdec784p-7, +-0x1.9878ebe836d9dp-61, +0x1p0, +-0x1.634da1cec522dp-15, +-0x1.2d96b0e509703p-7, +0x1.1e9131ff52dc9p-63, +0x1p0, +-0x1.3bd38bab6d94cp-16, +-0x1.921f0fe670071p-8, +-0x1.ab967fe6b7a9bp-64, +0x1p0, +-0x1.3bd3bc5fc5ab4p-18, +-0x1.921f8becca4bap-9, +-0x1.2ba407bcab5b2p-63, +0x1p0 +}; +template <> HWY_ALIGN constexpr double kCosApproxTable[] = { +0, +0x1p0, +0, +0, +0x1.b781d04cd6d17p-11, +0x1.ffff621621d02p-1, +-0x1.6acfcebc82813p-56, +-0x1p-8, +0x1.b783c0663fe3cp-10, +0x1.fffd8858e8a92p-1, +0x1.359c71883bcf7p-55, +-0x1p-7, +-0x1.6cb587284b817p-10, +0x1.fffa72c978c4fp-1, +-0x1.22cb000328f91p-55, +-0x1p-7, +0x1.b78b80c84e1eep-9, +0x1.fff62169b92dbp-1, +0x1.5dda3c81fbd0dp-55, +-0x1p-6, +0x1.2bad2a8cd06bp-12, +0x1.fff0943c53bd1p-1, +-0x1.47399f361d158p-55, +-0x1p-6, +-0x1.6c9b5df1877eap-9, +0x1.ffe9cb44b51a1p-1, +0x1.5b43366df667p-56, +-0x1p-6, +-0x1.7f53487eac897p-8, +0x1.ffe1c6870cb77p-1, +0x1.89aa14768323ep-55, +-0x1p-6, +0x1.b7aa821726608p-8, +0x1.ffd886084cd0dp-1, +-0x1.1354d4556e4cbp-55, +-0x1p-5, +0x1.dd58598d6271cp-9, +0x1.ffce09ce2a679p-1, +-0x1.7bd62ab5ee228p-55, +-0x1p-5, +0x1.2d919c5c61fep-11, +0x1.ffc251df1d3f8p-1, +0x1.7a7d209f32d43p-56, +-0x1p-5, +-0x1.4685db42c17ebp-9, +0x1.ffb55e425fdaep-1, +0x1.6da7ec781c225p-55, +-0x1p-5, +-0x1.6c32baca2ae69p-8, +0x1.ffa72effef75dp-1, +-0x1.8b4cdcdb25956p-55, +-0x1p-5, +-0x1.1a8e5bfe185e4p-7, +0x1.ff97c4208c014p-1, +0x1.52ab2b947e843p-57, +-0x1p-5, +-0x1.7f0034a43350ep-7, +0x1.ff871dadb81dfp-1, +0x1.8b1c676208aa4p-56, +-0x1p-5, +0x1.0e48ab4f172f4p-6, +0x1.ff753bb1b9164p-1, +-0x1.7c330129f56efp-56, +-0x1p-4, +0x1.b82683bc89fbp-7, +0x1.ff621e3796d7ep-1, +-0x1.c57bc2e24aa15p-57, +-0x1p-4, +0x1.53bf90a81f3a5p-7, +0x1.ff4dc54b1bed3p-1, +-0x1.c1169ccd1e92ep-55, +-0x1p-4, +0x1.deb9769f940eap-8, +0x1.ff3830f8d575cp-1, +-0x1.95e1e79d335f7p-56, +-0x1p-4, +0x1.15fc833fb89b8p-8, +0x1.ff21614e131edp-1, +-0x1.de692a167353p-55, +-0x1p-4, +0x1.35230c0fbe402p-10, +0x1.ff095658e71adp-1, +0x1.01a8ce18a4b9ep-55, +-0x1p-4, +-0x1.ed853918c18ecp-10, +0x1.fef0102826191p-1, +0x1.3c3ea4f30addap-56, +-0x1p-4, +-0x1.440134d709b28p-8, +0x1.fed58ecb673c4p-1, +-0x1.e6e462a7ae686p-56, +-0x1p-4, +-0x1.064b3a76a2264p-7, +0x1.feb9d2530410fp-1, +0x1.9d429eeda9bb9p-58, +-0x1p-4, +-0x1.6a9049670cfaep-7, +0x1.fe9cdad01883ap-1, +0x1.521ecd0c67e35p-57, +-0x1p-4, +-0x1.cecf8962d14c8p-7, +0x1.fe7ea85482d6p-1, +0x1.34b085c1828f7p-56, +-0x1p-4, +-0x1.19845e49c8257p-6, +0x1.fe5f3af2e394p-1, +0x1.b213f18c9cf17p-55, +-0x1p-4, +-0x1.4b9dd29353428p-6, +0x1.fe3e92be9d886p-1, +0x1.afeb2e264d46bp-57, +-0x1p-4, +-0x1.7db402a6a9063p-6, +0x1.fe1cafcbd5b09p-1, +0x1.a23e3202a884ep-57, +-0x1p-4, +0x1.281c9830c9dafp-5, +0x1.fdf9922f73307p-1, +0x1.a5e0abd3a9b65p-56, +-0x1p-3, +0x1.0f14f2b4549bdp-5, +0x1.fdd539ff1f456p-1, +-0x1.ab13cbbec1781p-56, +-0x1p-3, +0x1.ec1e3b4fb3d7ep-6, +0x1.fdafa7514538cp-1, +0x1.d97c45ca4d398p-59, +-0x1p-3, +0x1.ba1650f592f5p-6, +0x1.fd88da3d12526p-1, +-0x1.87df6378811c7p-55, +-0x1p-3, +0x1.88124536d5e8fp-6, +0x1.fd60d2da75c9ep-1, +0x1.36dedb314f0ebp-58, +-0x1p-3, +0x1.561236eda8ff2p-6, +0x1.fd37914220b84p-1, +0x1.52e9d7b772791p-55, +-0x1p-3, +0x1.241644f1c26cep-6, +0x1.fd0d158d86087p-1, +0x1.9705a7b864883p-55, +-0x1p-3, +0x1.e43d1c309e958p-7, +0x1.fce15fd6da67bp-1, +-0x1.5dd6f830d4c09p-56, +-0x1p-3, +0x1.80566267c11f6p-7, +0x1.fcb4703914354p-1, +0x1.126aa7d51b25cp-55, +-0x1p-3, +0x1.1c789a28b01b7p-7, +0x1.fc8646cfeb721p-1, +0x1.3143dc43a9b9dp-55, +-0x1p-3, +0x1.7148021b55c15p-8, +0x1.fc56e3b7d9af6p-1, +-0x1.03ff7a673d3bdp-56, +-0x1p-3, +0x1.536352ad19e39p-9, +0x1.fc26470e19fd3p-1, +0x1.1ec8668ecaceep-55, +-0x1p-3, +-0x1.dd15adf70b65ap-12, +0x1.fbf470f0a8d88p-1, +-0x1.6bb200d1d70b7p-55, +-0x1p-3, +-0x1.ca811eea0c749p-9, +0x1.fbc1617e44186p-1, +-0x1.58ec496dc4ecbp-59, +-0x1p-3, +-0x1.ac9b7964cf0bap-8, +0x1.fb8d18d66adb7p-1, +-0x1.d0b66224cce2ep-56, +-0x1p-3, +-0x1.39f0cedaf576bp-7, +0x1.fb5797195d741p-1, +0x1.1bfac7397cc08p-56, +-0x1p-3, +-0x1.9d8940be24e74p-7, +0x1.fb20dc681d54dp-1, +-0x1.ff148ec7c5fafp-55, +-0x1p-3, +-0x1.008b6a763de76p-6, +0x1.fae8e8e46cfbbp-1, +-0x1.3a9e414732d97p-56, +-0x1p-3, +-0x1.324ca6fe9a04bp-6, +0x1.faafbcb0cfddcp-1, +-0x1.e349cb4d3e866p-55, +-0x1p-3, +-0x1.64083747309d1p-6, +0x1.fa7557f08a517p-1, +-0x1.7a0a8ca13571fp-55, +-0x1p-3, +-0x1.95bdfca28b53ap-6, +0x1.fa39bac7a1791p-1, +-0x1.94f388f1b4e1ep-57, +-0x1p-3, +-0x1.c76dd866c689ep-6, +0x1.f9fce55adb2c8p-1, +0x1.f2a06fab9f9d1p-56, +-0x1p-3, +-0x1.f917abeda4499p-6, +0x1.f9bed7cfbde29p-1, +-0x1.b35b1f9bcf70bp-56, +-0x1p-3, +-0x1.155dac4a4f967p-5, +0x1.f97f924c9099bp-1, +-0x1.e2ae0eea5963bp-55, +-0x1p-3, +-0x1.2e2c5fde7ea22p-5, +0x1.f93f14f85ac08p-1, +-0x1.cfd153e9a9c1ap-55, +-0x1p-3, +-0x1.46f7e165f17c8p-5, +0x1.f8fd5ffae41dbp-1, +-0x1.8cfd77fd970d2p-56, +-0x1p-3, +-0x1.5fc0219532f79p-5, +0x1.f8ba737cb4b78p-1, +-0x1.da71f96d5a49cp-55, +-0x1p-3, +-0x1.78851122cff19p-5, +0x1.f8764fa714ba9p-1, +0x1.ab256778ffcb6p-56, +-0x1p-3, +-0x1.9146a0c760c35p-5, +0x1.f830f4a40c60cp-1, +0x1.8528676925128p-57, +-0x1p-3, +0x1.2afd9f6136a9cp-4, +0x1.f7ea629e63d6ep-1, +0x1.ba92d57ebfeddp-55, +-0x1p-2, +0x1.1ea04e5ee7601p-4, +0x1.f7a299c1a322ap-1, +0x1.6e7190c94899ep-56, +-0x1p-2, +0x1.1244c435e819dp-4, +0x1.f7599a3a12077p-1, +0x1.84f31d743195cp-55, +-0x1p-2, +0x1.05eb0885a69c9p-4, +0x1.f70f6434b7eb7p-1, +0x1.1775df66f0ec4p-56, +-0x1p-2, +0x1.f32645d8e6ce9p-5, +0x1.f6c3f7df5bbb7p-1, +0x1.8561ce9d5ef5bp-56, +-0x1p-2, +0x1.da7a360ef9fefp-5, +0x1.f677556883ceep-1, +0x1.ef696a8d070f4p-57, +-0x1p-2, +0x1.c1d1f0e5967d5p-5, +0x1.f6297cff75cbp-1, +0x1.562172a361fd3p-56, +-0x1p-2, +0x1.a92d859275418p-5, +0x1.f5da6ed43685dp-1, +-0x1.536fc33bf9dd8p-55, +-0x1p-2, +0x1.908d0348ef266p-5, +0x1.f58a2b1789e84p-1, +0x1.1f4a188aa368p-56, +-0x1p-2, +0x1.77f07939f3897p-5, +0x1.f538b1faf2d07p-1, +-0x1.5f7cd5099519cp-59, +-0x1p-2, +0x1.5f57f693feebep-5, +0x1.f4e603b0b2f2dp-1, +-0x1.8ee01e695ac05p-56, +-0x1p-2, +0x1.46c38a8311952p-5, +0x1.f492206bcabb4p-1, +0x1.d1e921bbe3bd3p-55, +-0x1p-2, +0x1.2e334430a6376p-5, +0x1.f43d085ff92ddp-1, +-0x1.8fde71e361c05p-55, +-0x1p-2, +0x1.15a732c3a894dp-5, +0x1.f3e6bbc1bbc65p-1, +0x1.5774bb7e8a21ep-57, +-0x1p-2, +0x1.fa3ecac0d84e8p-6, +0x1.f38f3ac64e589p-1, +-0x1.d7bafb51f72e6p-56, +-0x1p-2, +0x1.c937d65145919p-6, +0x1.f33685a3aaefp-1, +0x1.eb78685d850f8p-56, +-0x1p-2, +0x1.9839a676a6bcfp-6, +0x1.f2dc9c9089a9dp-1, +0x1.5407460bdfc07p-59, +-0x1p-2, +0x1.67445969a108ep-6, +0x1.f2817fc4609cep-1, +-0x1.dd1f8eaf65689p-55, +-0x1p-2, +0x1.36580d5d5e775p-6, +0x1.f2252f7763adap-1, +-0x1.20cb81c8d94abp-55, +-0x1p-2, +0x1.0574e07f7b332p-6, +0x1.f1c7abe284708p-1, +0x1.504b80c8a63fcp-55, +-0x1p-2, +0x1.a935e1efe5e4bp-7, +0x1.f168f53f7205dp-1, +-0x1.26a6c1f015601p-57, +-0x1p-2, +0x1.4794b9d21cb87p-7, +0x1.f1090bc898f5fp-1, +-0x1.baa64ab102a93p-55, +-0x1p-2, +0x1.cc0d09bd41caap-8, +0x1.f0a7efb9230d7p-1, +0x1.52c7adc6b4989p-56, +-0x1p-2, +0x1.0916fe858ffcdp-8, +0x1.f045a14cf738cp-1, +-0x1.a52c44f45216cp-55, +-0x1p-2, +0x1.191f2900903a6p-10, +0x1.efe220c0b95ecp-1, +0x1.c853b7bf7e0cdp-55, +-0x1p-2, +-0x1.f1806b9fdd1afp-10, +0x1.ef7d6e51ca3cp-1, +-0x1.a3c67c3d3f604p-55, +-0x1p-2, +-0x1.3ee038dff6b8p-8, +0x1.ef178a3e473c2p-1, +0x1.6310a67fe774fp-55, +-0x1p-2, +-0x1.009c0bd6cc3cbp-7, +0x1.eeb074c50a544p-1, +0x1.d925f656c43b4p-55, +-0x1p-2, +-0x1.61b39fb7b7202p-7, +0x1.ee482e25a9dbcp-1, +-0x1.b6066ef81af2ap-56, +-0x1p-2, +-0x1.c2b69c2e939b5p-7, +0x1.eddeb6a078651p-1, +-0x1.3b579af740a74p-55, +-0x1p-2, +-0x1.11d262b1f6776p-6, +0x1.ed740e7684963p-1, +0x1.e82c791f59cc2p-56, +-0x1p-2, +-0x1.423eefc693785p-6, +0x1.ed0835e999009p-1, +0x1.499d188aa32fap-57, +-0x1p-2, +-0x1.72a0d77651772p-6, +0x1.ec9b2d3c3bf84p-1, +0x1.19119d358de05p-56, +-0x1p-2, +-0x1.a2f7fbe8f2436p-6, +0x1.ec2cf4b1af6b2p-1, +0x1.34ee3f2caa62dp-59, +-0x1p-2, +-0x1.d3443f4cdb3ddp-6, +0x1.ebbd8c8df0b74p-1, +0x1.c6c8c615e7277p-56, +-0x1p-2, +-0x1.01c2c1eb93deep-5, +0x1.eb4cf515b8811p-1, +0x1.95da1ba97ec5ep-57, +-0x1p-2, +-0x1.19ddd5e1ddb8bp-5, +0x1.eadb2e8e7a88ep-1, +-0x1.92ec52ea226a3p-55, +-0x1p-2, +-0x1.31f34caaaa5d2p-5, +0x1.ea68393e658p-1, +-0x1.467259bb7b556p-56, +-0x1p-2, +-0x1.4a03176acf82dp-5, +0x1.e9f4156c62ddap-1, +0x1.760b1e2e3f81ep-55, +-0x1p-2, +-0x1.620d274aa2903p-5, +0x1.e97ec36016b3p-1, +0x1.5bc48562557d3p-55, +-0x1p-2, +-0x1.7a116d7601c35p-5, +0x1.e9084361df7f2p-1, +0x1.cdfc7ce9dc3e9p-55, +-0x1p-2, +-0x1.920fdb1c5d578p-5, +0x1.e89095bad6025p-1, +-0x1.5a4cc0fcbccap-55, +-0x1p-2, +-0x1.aa086170c0a8ep-5, +0x1.e817bab4cd10dp-1, +-0x1.d0afe686b5e0ap-56, +-0x1p-2, +-0x1.c1faf1a9db555p-5, +0x1.e79db29a5165ap-1, +-0x1.75e710aca58p-56, +-0x1p-2, +-0x1.d9e77d020a5bcp-5, +0x1.e7227db6a9744p-1, +0x1.2128794da5a5p-55, +-0x1p-2, +-0x1.f1cdf4b76138bp-5, +0x1.e6a61c55d53a7p-1, +0x1.660d981acdcf7p-56, +-0x1p-2, +-0x1.04d72505d9805p-4, +0x1.e6288ec48e112p-1, +-0x1.16b56f2847754p-57, +-0x1p-2, +-0x1.10c437224dbc2p-4, +0x1.e5a9d550467d3p-1, +0x1.7d431be53f92fp-56, +-0x1p-2, +-0x1.1cae2955c414fp-4, +0x1.e529f04729ffcp-1, +0x1.9075d6e6dfc8bp-55, +-0x1p-2, +-0x1.2894f446e0bccp-4, +0x1.e4a8dff81ce5ep-1, +0x1.43578776c0f46p-55, +-0x1p-2, +-0x1.3478909e39da9p-4, +0x1.e426a4b2bc17ep-1, +0x1.a873889744882p-55, +-0x1p-2, +-0x1.4058f7065c11ep-4, +0x1.e3a33ec75ce85p-1, +0x1.45089cd46bbb8p-57, +-0x1p-2, +-0x1.4c36202bcf08ep-4, +0x1.e31eae870ce25p-1, +-0x1.bc7094538d678p-56, +-0x1p-2, +-0x1.581004bd19ed2p-4, +0x1.e298f4439197ap-1, +0x1.e84e601038eb2p-57, +-0x1p-2, +-0x1.63e69d6ac7f74p-4, +0x1.e212104f686e5p-1, +-0x1.014c76c126527p-55, +-0x1p-2, +-0x1.6fb9e2e76ced8p-4, +0x1.e18a02fdc66d9p-1, +0x1.07e272abd88cfp-55, +-0x1p-2, +-0x1.7b89cde7a9a4dp-4, +0x1.e100cca2980acp-1, +-0x1.02d182acdf825p-57, +-0x1p-2, +-0x1.875657223080ap-4, +0x1.e0766d9280f54p-1, +0x1.f44c969cf62e3p-55, +-0x1p-2, +-0x1.931f774fc9f18p-4, +0x1.dfeae622dbe2bp-1, +-0x1.514ea88425567p-55, +-0x1p-2, +-0x1.9ee5272b58f2ap-4, +0x1.df5e36a9ba59cp-1, +-0x1.e01f8bceb43d3p-57, +-0x1p-2, +0x1.2aac5047103d3p-3, +0x1.ded05f7de47dap-1, +-0x1.2cc4c1f8ba966p-55, +-0x1p-1, +0x1.24ccf38ebe694p-3, +0x1.de4160f6d8d81p-1, +0x1.9bf11cc5f8776p-55, +-0x1p-1, +0x1.1eef59e0b74c3p-3, +0x1.ddb13b6ccc23cp-1, +0x1.83c37c6107db3p-55, +-0x1p-1, +0x1.191386db3dedcp-3, +0x1.dd1fef38a915ap-1, +-0x1.782f169e17f3bp-55, +-0x1p-1, +0x1.13397e1b7ce13p-3, +0x1.dc8d7cb41026p-1, +0x1.6b7872773830dp-56, +-0x1p-1, +0x1.0d61433d840a4p-3, +0x1.dbf9e4395759ap-1, +0x1.d8ff7350f75fdp-55, +-0x1p-1, +0x1.078ad9dc46632p-3, +0x1.db6526238a09bp-1, +-0x1.adee7eae6946p-56, +-0x1p-1, +0x1.01b6459197c38p-3, +0x1.dacf42ce68ab9p-1, +-0x1.fe8d76efdf896p-56, +-0x1p-1, +0x1.f7c713ec554fp-4, +0x1.da383a9668988p-1, +-0x1.5811000b39d84p-55, +-0x1p-1, +0x1.ec2555431bf03p-4, +0x1.d9a00dd8b3d46p-1, +0x1.bea0e4bac8e16p-58, +-0x1p-1, +0x1.e087565455a75p-4, +0x1.d906bcf328d46p-1, +0x1.457e610231ac2p-56, +-0x1p-1, +0x1.d4ed1e4a84aefp-4, +0x1.d86c48445a44fp-1, +0x1.e8813c023d71fp-55, +-0x1p-1, +0x1.c956b44dd6d41p-4, +0x1.d7d0b02b8ecf9p-1, +0x1.800f4ce65cd6ep-55, +-0x1p-1, +0x1.bdc41f84210bbp-4, +0x1.d733f508c0dffp-1, +-0x1.007928e770cd5p-55, +-0x1p-1, +0x1.b2356710db0a3p-4, +0x1.d696173c9e68bp-1, +-0x1.e8c61c6393d55p-56, +-0x1p-1, +0x1.a6aa92151adc3p-4, +0x1.d5f7172888a7fp-1, +-0x1.68663e2225755p-55, +-0x1p-1, +0x1.9b23a7af90805p-4, +0x1.d556f52e93eb1p-1, +-0x1.80ed9233a963p-55, +-0x1p-1, +0x1.8fa0aefc81837p-4, +0x1.d4b5b1b187524p-1, +-0x1.f56be6b42b76dp-57, +-0x1p-1, +0x1.8421af15c49d7p-4, +0x1.d4134d14dc93ap-1, +-0x1.4ef5295d25af2p-55, +-0x1p-1, +0x1.78a6af12bd501p-4, +0x1.d36fc7bcbfbdcp-1, +-0x1.ba196d95a177dp-55, +-0x1p-1, +0x1.6d2fb6085786ep-4, +0x1.d2cb220e0ef9fp-1, +-0x1.f07656d4e6652p-56, +-0x1p-1, +0x1.61bccb0903395p-4, +0x1.d2255c6e5a4e1p-1, +-0x1.d129a71ecafc9p-55, +-0x1p-1, +0x1.564df524b00dap-4, +0x1.d17e7743e35dcp-1, +-0x1.101da3540130ap-58, +-0x1p-1, +0x1.4ae33b68c8fdcp-4, +0x1.d0d672f59d2b9p-1, +-0x1.c83009f0c39dep-55, +-0x1p-1, +0x1.3f7ca4e02ffdcp-4, +0x1.d02d4feb2bd92p-1, +0x1.195ff41bc55fep-55, +-0x1p-1, +0x1.341a389339a36p-4, +0x1.cf830e8ce467bp-1, +-0x1.7b9202780d49dp-55, +-0x1p-1, +0x1.28bbfd87a8cffp-4, +0x1.ced7af43cc773p-1, +-0x1.e7b6bb5ab58aep-58, +-0x1p-1, +0x1.1d61fac0aa5b2p-4, +0x1.ce2b32799a06p-1, +-0x1.631d457e46317p-56, +-0x1p-1, +0x1.120c373ed0bfbp-4, +0x1.cd7d9898b32f6p-1, +-0x1.f2fa062496738p-57, +-0x1p-1, +0x1.06baba000fc9bp-4, +0x1.cccee20c2deap-1, +-0x1.d3116ae0e69e4p-55, +-0x1p-1, +0x1.f6db13ff708cbp-5, +0x1.cc1f0f3fcfc5cp-1, +0x1.e57613b68f6abp-56, +-0x1p-1, +0x1.e0495c6ce76b5p-5, +0x1.cb6e20a00da99p-1, +-0x1.4fb24b5194c1bp-55, +-0x1p-1, +0x1.c9c05b347ffabp-5, +0x1.cabc169a0b9p-1, +0x1.c42d3e10851d1p-55, +-0x1p-1, +0x1.b3401e3cd63bbp-5, +0x1.ca08f19b9c449p-1, +-0x1.431e0a5a737fdp-56, +-0x1p-1, +0x1.9cc8b3671dd0fp-5, +0x1.c954b213411f5p-1, +-0x1.2fb761e946603p-58, +-0x1p-1, +0x1.865a288f196fap-5, +0x1.c89f587029c13p-1, +0x1.588358ed6e78fp-58, +-0x1p-1, +0x1.6ff48b8b1252ap-5, +0x1.c7e8e52233cf3p-1, +0x1.b2ad324aa35c1p-57, +-0x1p-1, +0x1.5997ea2bcfb19p-5, +0x1.c7315899eaad7p-1, +-0x1.9be5dcd047da7p-57, +-0x1p-1, +0x1.4344523c8e3b5p-5, +0x1.c678b3488739bp-1, +0x1.d86cac7c5ff5bp-57, +-0x1p-1, +0x1.2cf9d182f7939p-5, +0x1.c5bef59fef85ap-1, +-0x1.f0a406c8b7468p-58, +-0x1p-1, +0x1.16b875bf19d4p-5, +0x1.c5042012b6907p-1, +-0x1.5c058dd8eaba5p-57, +-0x1p-1, +0x1.00804cab5f113p-5, +0x1.c44833141c004p-1, +0x1.23e0521df01a2p-56, +-0x1p-1, +0x1.d4a2c7f909c4ep-6, +0x1.c38b2f180bdb1p-1, +-0x1.6e0b1757c8d07p-56, +-0x1p-1, +0x1.a85792c327db2p-6, +0x1.c2cd14931e3f1p-1, +0x1.2ce2f9d4600f5p-56, +-0x1p-1, +0x1.7c1f1507aeec3p-6, +0x1.c20de3fa971bp-1, +-0x1.b4ca2bab1322cp-55, +-0x1p-1, +0x1.4ff96a0da9dfbp-6, +0x1.c14d9dc465e57p-1, +0x1.ce36b64c7f3ccp-55, +-0x1p-1, +0x1.23e6ad10872a7p-6, +0x1.c08c426725549p-1, +0x1.b157fd80e2946p-58, +-0x1p-1, +0x1.efcdf2801004ap-7, +0x1.bfc9d25a1b147p-1, +-0x1.51bf4ee01357p-61, +-0x1p-1, +0x1.97f4d3805f318p-7, +0x1.bf064e15377ddp-1, +0x1.2156026a1e028p-57, +-0x1p-1, +0x1.4042335264ba3p-7, +0x1.be41b611154c1p-1, +-0x1.fdcdad3a6877ep-55, +-0x1p-1, +0x1.d16c901d95181p-8, +0x1.bd7c0ac6f952ap-1, +-0x1.825a732ac700ap-55, +-0x1p-1, +0x1.22a28f6cb488bp-8, +0x1.bcb54cb0d2327p-1, +0x1.410923c55523ep-62, +-0x1p-1, +0x1.d09b418edf04ap-10, +0x1.bbed7c49380eap-1, +0x1.beacbd88500b4p-59, +-0x1p-1, +-0x1.d0320ae0b8293p-11, +0x1.bb249a0b6c40dp-1, +-0x1.d6318ee919f7ap-58, +-0x1p-1, +-0x1.cfc874c3eb6d9p-9, +0x1.ba5aa673590d2p-1, +0x1.7ea4e370753b6p-55, +-0x1p-1, +-0x1.9572af6decac8p-8, +0x1.b98fa1fd9155ep-1, +0x1.5559034fe85a4p-55, +-0x1p-1, +-0x1.21589ab88869cp-7, +0x1.b8c38d27504e9p-1, +-0x1.1529abff40e45p-55, +-0x1p-1, +-0x1.77cfb0c6e2db8p-7, +0x1.b7f6686e792e9p-1, +0x1.87665bfea06aap-55, +-0x1p-1, +-0x1.ce1e648bffb66p-7, +0x1.b728345196e3ep-1, +-0x1.bc69f324e6d61p-55, +-0x1p-1, +-0x1.1222406561182p-6, +0x1.b658f14fdbc47p-1, +0x1.52b5308f397dep-57, +-0x1p-1, +-0x1.3d20e82f8bc1p-6, +0x1.b5889fe921405p-1, +-0x1.df49b307c8602p-57, +-0x1p-1, +-0x1.680b0f1f0bd73p-6, +0x1.b4b7409de7925p-1, +0x1.f4e257bde73d8p-56, +-0x1p-1, +-0x1.92e09abb131d4p-6, +0x1.b3e4d3ef55712p-1, +-0x1.eb6b8bf11a493p-55, +-0x1p-1, +-0x1.bda17097896b4p-6, +0x1.b3115a5f37bf3p-1, +0x1.dde2726e34fe1p-55, +-0x1p-1, +-0x1.e84d76551cfb2p-6, +0x1.b23cd470013b4p-1, +0x1.5a1bb35ad6d2ep-56, +-0x1p-1, +-0x1.097248d0a956ap-5, +0x1.b16742a4ca2f5p-1, +-0x1.ba70972b80438p-55, +-0x1p-1, +-0x1.1eb3541b4b228p-5, +0x1.b090a581502p-1, +-0x1.926da300ffccep-55, +-0x1p-1, +-0x1.33e9cfee254edp-5, +0x1.afb8fd89f57b6p-1, +0x1.1ced12d2899b8p-60, +-0x1p-1, +-0x1.4915af336ceb4p-5, +0x1.aee04b43c1474p-1, +-0x1.3a79a438bf8ccp-55, +-0x1p-1, +-0x1.5e36e4dbe2bc2p-5, +0x1.ae068f345ecefp-1, +-0x1.33934c4029a4cp-56, +-0x1p-1, +-0x1.734d63dedb48ap-5, +0x1.ad2bc9e21d511p-1, +-0x1.47fbe07bea548p-55, +-0x1p-1, +-0x1.88591f3a46e4dp-5, +0x1.ac4ffbd3efac8p-1, +-0x1.818504103fa16p-56, +-0x1p-1, +-0x1.9d5a09f2b9b7fp-5, +0x1.ab7325916c0d4p-1, +0x1.a8b8c85baaa9bp-55, +-0x1p-1, +-0x1.b250171373be9p-5, +0x1.aa9547a2cb98ep-1, +0x1.87d00ae97abaap-60, +-0x1p-1, +-0x1.c73b39ae68c87p-5, +0x1.a9b66290ea1a3p-1, +0x1.9f630e8b6dac8p-60, +-0x1p-1, +-0x1.dc1b64dc48722p-5, +0x1.a8d676e545ad2p-1, +-0x1.b11dcce2e74bdp-59, +-0x1p-1, +-0x1.f0f08bbc861afp-5, +0x1.a7f58529fe69dp-1, +-0x1.97a441584a179p-55, +-0x1p-1, +-0x1.02dd50bab06b2p-4, +0x1.a7138de9d60f5p-1, +-0x1.f1ab82a9c5f2dp-55, +-0x1p-1, +-0x1.0d3ccc99f5ac6p-4, +0x1.a63091b02fae2p-1, +-0x1.e911152248d1p-56, +-0x1p-1, +-0x1.1796b31609f0cp-4, +0x1.a54c91090f523p-1, +0x1.184300fd1c1cep-56, +-0x1p-1, +-0x1.21eafdcc560fap-4, +0x1.a4678c8119ac8p-1, +0x1.1b4c0dd3f212ap-55, +-0x1p-1, +-0x1.2c39a65db8881p-4, +0x1.a38184a593bc6p-1, +-0x1.bc92c5bd2d288p-55, +-0x1p-1, +-0x1.3682a66e896f5p-4, +0x1.a29a7a0462782p-1, +-0x1.128bb015df175p-56, +-0x1p-1, +-0x1.40c5f7a69e5cep-4, +0x1.a1b26d2c0a75ep-1, +0x1.30ef431d627a6p-57, +-0x1p-1, +-0x1.4b0393b14e541p-4, +0x1.a0c95eabaf937p-1, +-0x1.e0ca3acbd049ap-55, +-0x1p-1, +-0x1.553b743d75acp-4, +0x1.9fdf4f13149dep-1, +0x1.1e6d79006ec09p-55, +-0x1p-1, +-0x1.5f6d92fd79f5p-4, +0x1.9ef43ef29af94p-1, +0x1.b1dfcb60445c2p-56, +-0x1p-1, +-0x1.6999e9a74ddbep-4, +0x1.9e082edb42472p-1, +0x1.5809a4e121e22p-57, +-0x1p-1, +-0x1.73c071f4750b5p-4, +0x1.9d1b1f5ea80d5p-1, +0x1.c5fadd5ffb36fp-55, +-0x1p-1, +-0x1.7de125a2080a9p-4, +0x1.9c2d110f075c2p-1, +0x1.d9c9f1c8c30dp-55, +-0x1p-1, +-0x1.87fbfe70b81a7p-4, +0x1.9b3e047f38741p-1, +-0x1.30ee286712474p-55, +-0x1p-1, +-0x1.9210f624d30fbp-4, +0x1.9a4dfa42b06b2p-1, +-0x1.829b6b8b1c947p-56, +-0x1p-1, +-0x1.9c200686472b5p-4, +0x1.995cf2ed80d22p-1, +0x1.7783e907fbd7bp-56, +-0x1p-1, +-0x1.a6292960a6f0bp-4, +0x1.986aef1457594p-1, +-0x1.af03e318f38fcp-55, +-0x1p-1, +-0x1.b02c58832cf96p-4, +0x1.9777ef4c7d742p-1, +-0x1.15479a240665ep-55, +-0x1p-1, +-0x1.ba298dc0bfc6bp-4, +0x1.9683f42bd7fe1p-1, +-0x1.11bad933c835ep-57, +-0x1p-1, +-0x1.c420c2eff590ep-4, +0x1.958efe48e6dd7p-1, +-0x1.561335da0f4e7p-55, +-0x1p-1, +-0x1.ce11f1eb18148p-4, +0x1.94990e3ac4a6cp-1, +0x1.a95328edeb3e6p-56, +-0x1p-1, +-0x1.d7fd1490285cap-4, +0x1.93a22499263fbp-1, +0x1.3d419a920df0bp-55, +-0x1p-1, +-0x1.e1e224c0e28bdp-4, +0x1.92aa41fc5a815p-1, +-0x1.68f89e2d23db7p-57, +-0x1p-1, +-0x1.ebc11c62c1a1ep-4, +0x1.91b166fd49da2p-1, +-0x1.3be953a7fe996p-57, +-0x1p-1, +-0x1.f599f55f034p-4, +0x1.90b7943575efep-1, +0x1.4ecb0c5273706p-57, +-0x1p-1, +-0x1.ff6ca9a2ab6a2p-4, +0x1.8fbcca3ef940dp-1, +-0x1.6dfa99c86f2f1p-57, +-0x1p-1, +-0x1.049c998f44231p-3, +0x1.8ec109b486c49p-1, +-0x1.cb2a3eb6af617p-56, +-0x1p-1, +-0x1.097fc5e39aec5p-3, +0x1.8dc45331698ccp-1, +0x1.1d9fcd83634d7p-57, +-0x1p-1, +-0x1.0e5fd6ca90dffp-3, +0x1.8cc6a75184655p-1, +-0x1.e18b3657e2285p-55, +-0x1p-1, +-0x1.133cc94247758p-3, +0x1.8bc806b151741p-1, +-0x1.2c5e12ed1336dp-55, +-0x1p-1, +-0x1.18169a4acca89p-3, +0x1.8ac871ede1d88p-1, +-0x1.9afaa5b7cfc55p-55, +-0x1p-1, +-0x1.1ced46e61cd1cp-3, +0x1.89c7e9a4dd4aap-1, +0x1.db6ea04a8678fp-55, +-0x1p-1, +-0x1.21c0cc18247fcp-3, +0x1.88c66e7481ba1p-1, +-0x1.5c6228970cf35p-56, +-0x1p-1, +-0x1.269126e6c24e3p-3, +0x1.87c400fba2ebfp-1, +-0x1.2dabc0c3f64cdp-55, +-0x1p-1, +-0x1.2b5e5459c8bc3p-3, +0x1.86c0a1d9aa195p-1, +0x1.84564f09c3726p-59, +-0x1p-1, +-0x1.3028517b0001p-3, +0x1.85bc51ae958ccp-1, +0x1.45ba6478086ccp-55, +-0x1p-1, +-0x1.34ef1b5627dfdp-3, +0x1.84b7111af83fap-1, +-0x1.63a47df0b21bap-55, +-0x1p-1, +-0x1.39b2aef8f97a4p-3, +0x1.83b0e0bff976ep-1, +-0x1.6f420f8ea3475p-56, +-0x1p-1, +-0x1.3e73097329219p-3, +0x1.82a9c13f545ffp-1, +-0x1.65e87a7a8cde9p-56, +-0x1p-1, +-0x1.433027d66826dp-3, +0x1.81a1b33b57accp-1, +-0x1.5dea12d66bb66p-55, +-0x1p-1, +-0x1.47ea073666a98p-3, +0x1.8098b756e52fap-1, +0x1.9136e834b4707p-55, +-0x1p-1, +-0x1.4ca0a4a8d5657p-3, +0x1.7f8ece3571771p-1, +-0x1.9c8d8ce93c917p-55, +-0x1p-1, +-0x1.5153fd45677efp-3, +0x1.7e83f87b03686p-1, +0x1.b61a8ccabad6p-57, +-0x1p-1, +-0x1.56040e25d44ddp-3, +0x1.7d7836cc33db2p-1, +0x1.162715ef03f85p-56, +-0x1p-1, +-0x1.5ab0d465d927ap-3, +0x1.7c6b89ce2d333p-1, +-0x1.cfd628084982cp-56, +-0x1p-1, +-0x1.5f5a4d233b27fp-3, +0x1.7b5df226aafafp-1, +-0x1.0f537acdf0ad7p-56, +-0x1p-1, +-0x1.6400757dc8f7dp-3, +0x1.7a4f707bf97d2p-1, +0x1.3c9751b491eafp-55, +-0x1p-1, +-0x1.68a34a975c941p-3, +0x1.79400574f55e5p-1, +-0x1.0adadbdb4c65ap-55, +-0x1p-1, +-0x1.6d42c993dd121p-3, +0x1.782fb1b90b35bp-1, +-0x1.3e46c1dfd001cp-55, +-0x1p-1, +-0x1.71deef9940631p-3, +0x1.771e75f037261p-1, +0x1.5cfce8d84068fp-56, +-0x1p-1, +-0x1.7677b9cf8d17p-3, +0x1.760c52c304764p-1, +-0x1.11d76f8e50f1fp-55, +-0x1p-1, +-0x1.7b0d2560dc1d1p-3, +0x1.74f948da8d28dp-1, +0x1.19900a3b9a3a2p-63, +-0x1p-1, +-0x1.7f9f2f795a83ep-3, +0x1.73e558e079942p-1, +-0x1.2663126697f5ep-55, +-0x1p-1, +-0x1.842dd5474b37bp-3, +0x1.72d0837efff96p-1, +0x1.0d4ef0f1d915cp-55, +-0x1p-1, +-0x1.88b913fb08bfdp-3, +0x1.71bac960e41bfp-1, +-0x1.b858d90b0f7d8p-56, +-0x1p-1, +-0x1.8d40e8c706fa4p-3, +0x1.70a42b3176d7ap-1, +-0x1.d9e3fbe2e15ap-56, +-0x1p-1, +-0x1.91c550dfd4d6bp-3, +0x1.6f8ca99c95b75p-1, +0x1.f22e7a35723f4p-56, +-0x1p-1, +-0x1.9646497c1e0f6p-3, +0x1.6e74454eaa8afp-1, +-0x1.dbc03c84e226ep-55, +-0x1p-1, +-0x1.9ac3cfd4ace19p-3, +0x1.6d5afef4aafcdp-1, +-0x1.868a696b8835ep-55, +-0x1p-1, +-0x1.9f3de1246bc4p-3, +0x1.6c40d73c18275p-1, +0x1.25d4f802be257p-57, +-0x1p-1, +-0x1.a3b47aa8671c5p-3, +0x1.6b25ced2fe29cp-1, +-0x1.5ac64116beda5p-55, +-0x1p-1, +0, +0x1.6a09e667f3bcdp-1, +-0x1.bdd3413b26456p-55, +0, +0x1.29b4625a03ac9p-2, +0x1.68ed1eaa19c71p-1, +0x1.fd4a85350f69p-56, +-0x1p0, +0x1.277e5187cfb16p-2, +0x1.67cf78491af1p-1, +0x1.750ab23477b61p-59, +-0x1p0, +0x1.254a0216aa067p-2, +0x1.66b0f3f52b386p-1, +0x1.1e2eb31a8848bp-55, +-0x1p0, +0x1.23177562aaea3p-2, +0x1.6591925f0783dp-1, +0x1.c3d64fbf5de23p-55, +-0x1p0, +0x1.20e6acc6d4916p-2, +0x1.64715437f535bp-1, +-0x1.7c399c15a17dp-55, +-0x1p0, +0x1.1eb7a99d1250cp-2, +0x1.63503a31c1be9p-1, +0x1.1248f09e6587cp-57, +-0x1p0, +0x1.1c8a6d3e37c82p-2, +0x1.622e44fec22ffp-1, +0x1.f98d8be132d57p-56, +-0x1p0, +0x1.1a5ef902000d3p-2, +0x1.610b7551d2cdfp-1, +-0x1.251b352ff2a37p-56, +-0x1p0, +0x1.18354e3f0cd7dp-2, +0x1.5fe7cbde56a1p-1, +-0x1.fcb9cc30cc01ep-55, +-0x1p0, +0x1.160d6e4ae5ae6p-2, +0x1.5ec3495837074p-1, +0x1.dea89a9b8f727p-56, +-0x1p0, +0x1.13e75a79f7139p-2, +0x1.5d9dee73e345cp-1, +-0x1.de1165ecdf7a3p-57, +-0x1p0, +0x1.11c3141f91b3ep-2, +0x1.5c77bbe65018cp-1, +0x1.069ea9c0bc32ap-55, +-0x1p0, +0x1.0fa09c8de994bp-2, +0x1.5b50b264f7448p-1, +0x1.519d30d4cfebp-56, +-0x1p0, +0x1.0d7ff51615437p-2, +0x1.5a28d2a5d725p-1, +0x1.57a25f8b1343p-55, +-0x1p0, +0x1.0b611f080d05bp-2, +0x1.59001d5f723dfp-1, +0x1.a9f86ba0dde98p-56, +-0x1p0, +0x1.09441bb2aa0a2p-2, +0x1.57d69348cecap-1, +-0x1.75720992bfbb2p-55, +-0x1p0, +0x1.0728ec63a599ap-2, +0x1.56ac35197649fp-1, +-0x1.f7874188cb279p-55, +-0x1p0, +0x1.050f92679849cp-2, +0x1.5581038975137p-1, +0x1.4570d9efe26dfp-55, +-0x1p0, +0x1.02f80f09f92f4p-2, +0x1.5454ff5159dfcp-1, +-0x1.4e247588bf256p-55, +-0x1p0, +0x1.00e263951d11fp-2, +0x1.5328292a35596p-1, +-0x1.a12eb89da0257p-56, +-0x1p0, +0x1.fd9d22a46b416p-3, +0x1.51fa81cd99aa6p-1, +-0x1.499f59d8560e9p-63, +-0x1p0, +0x1.f9793312a14d1p-3, +0x1.50cc09f59a09bp-1, +0x1.693463a2c2e6fp-56, +-0x1p0, +0x1.f558fb02ae805p-3, +0x1.4f9cc25cca486p-1, +0x1.48b5951cfc2b5p-55, +-0x1p0, +0x1.f13c7d001a249p-3, +0x1.4e6cabbe3e5e9p-1, +0x1.3c293edceb327p-57, +-0x1p0, +0x1.ed23bb941f019p-3, +0x1.4d3bc6d589f7fp-1, +0x1.6e4d9d6b72011p-55, +-0x1p0, +0x1.e90eb945a9ccfp-3, +0x1.4c0a145ec0004p-1, +0x1.2630cfafceaa1p-58, +-0x1p0, +0x1.e4fd7899579acp-3, +0x1.4ad79516722f1p-1, +-0x1.1273b163000f7p-55, +-0x1p0, +0x1.e0effc1174505p-3, +0x1.49a449b9b0939p-1, +-0x1.27ee16d719b94p-55, +-0x1p0, +0x1.dce6462df917dp-3, +0x1.48703306091ffp-1, +-0x1.70813b86159fdp-57, +-0x1p0, +0x1.d8e0596c8ad56p-3, +0x1.473b51b987347p-1, +0x1.ca1953514e41bp-57, +-0x1p0, +0x1.d4de3848789e2p-3, +0x1.4605a692b32a2p-1, +0x1.21ca219b97107p-55, +-0x1p0, +0x1.d0dfe53aba2fdp-3, +0x1.44cf325091dd6p-1, +0x1.8076a2cfdc6b3p-57, +-0x1p0, +0x1.cce562b9ee6aep-3, +0x1.4397f5b2a438p-1, +-0x1.7274c9e48c226p-55, +-0x1p0, +0x1.c8eeb33a59cdp-3, +0x1.425ff178e6bb1p-1, +0x1.7b38d675140cap-55, +-0x1p0, +0x1.c4fbd92de4eddp-3, +0x1.41272663d108cp-1, +0x1.1bbe7636fadf5p-55, +-0x1p0, +0x1.c10cd7041afccp-3, +0x1.3fed9534556d4p-1, +0x1.36916608c5061p-55, +-0x1p0, +0x1.bd21af2a28408p-3, +0x1.3eb33eabe068p-1, +0x1.86a2357d1a0d3p-58, +-0x1p0, +0x1.b93a640ad8978p-3, +0x1.3d78238c58344p-1, +-0x1.0219f5f0f79cep-55, +-0x1p0, +0x1.b556f80e95facp-3, +0x1.3c3c44981c518p-1, +-0x1.b5e9a9644151bp-55, +-0x1p0, +0x1.b1776d9b67013p-3, +0x1.3affa292050b9p-1, +0x1.e3e25e3954964p-56, +-0x1p0, +0x1.ad9bc714ed64fp-3, +0x1.39c23e3d63029p-1, +-0x1.3b05b276085c1p-58, +-0x1p0, +0x1.a9c406dc648a5p-3, +0x1.3884185dfeb22p-1, +-0x1.a038026abe6b2p-56, +-0x1p0, +0x1.a5f02f50a007cp-3, +0x1.374531b817f8dp-1, +0x1.444d2b0a747fep-55, +-0x1p0, +0x1.a22042ce0a2f9p-3, +0x1.36058b10659f3p-1, +-0x1.1fcb3a35857e7p-55, +-0x1p0, +0x1.9e5443aea29b2p-3, +0x1.34c5252c14de1p-1, +0x1.583f49632ab2bp-55, +-0x1p0, +0x1.9a8c3449fcb77p-3, +0x1.338400d0c8e57p-1, +-0x1.abf2a5e95e6e5p-55, +-0x1p0, +0x1.96c816f53e539p-3, +0x1.32421ec49a61fp-1, +0x1.65e25cc951bfep-55, +-0x1p0, +0x1.9307ee031e2fdp-3, +0x1.30ff7fce17035p-1, +-0x1.efcc626f74a6fp-57, +-0x1p0, +0x1.8f4bbbc3e28f6p-3, +0x1.2fbc24b441015p-1, +0x1.dba4875410874p-57, +-0x1p0, +0x1.8b9382855fcaap-3, +0x1.2e780e3e8ea17p-1, +-0x1.b19fafe36587ap-55, +-0x1p0, +0x1.87df4492f6e38p-3, +0x1.2d333d34e9bb8p-1, +-0x1.0e2c2c5549e26p-55, +-0x1p0, +0x1.842f0435941afp-3, +0x1.2bedb25faf3eap-1, +-0x1.14981c796ee46p-58, +-0x1p0, +0x1.8082c3b3ad887p-3, +0x1.2aa76e87aeb58p-1, +0x1.fd600833287a7p-59, +-0x1p0, +0x1.7cda855141b26p-3, +0x1.2960727629ca8p-1, +0x1.56d6c7af02d5cp-56, +-0x1p0, +0x1.79364b4fd6288p-3, +0x1.2818bef4d3cbap-1, +-0x1.e3fffeb76568ap-56, +-0x1p0, +0x1.759617ee761f9p-3, +0x1.26d054cdd12dfp-1, +-0x1.5da743ef3770cp-55, +-0x1p0, +0x1.71f9ed69b10eap-3, +0x1.258734cbb711p-1, +0x1.3a3f0903ce09dp-57, +-0x1p0, +0x1.6e61cdfb994dfp-3, +0x1.243d5fb98ac1fp-1, +0x1.c533d0a284a8dp-56, +-0x1p0, +0x1.6acdbbdbc2b73p-3, +0x1.22f2d662c13e2p-1, +-0x1.d5cc7580cb6d2p-55, +-0x1p0, +0x1.673db93f41479p-3, +0x1.21a799933eb59p-1, +-0x1.3a7b177c68fb2p-55, +-0x1p0, +0x1.63b1c858a7c2ep-3, +0x1.205baa17560d6p-1, +0x1.b7b144016c7a3p-56, +-0x1p0, +0x1.6029eb580658ep-3, +0x1.1f0f08bbc861bp-1, +-0x1.10d9dcafb74cbp-57, +-0x1p0, +0x1.5ca6246ae94b8p-3, +0x1.1dc1b64dc4872p-1, +0x1.f15e1c468be78p-57, +-0x1p0, +0x1.592675bc57974p-3, +0x1.1c73b39ae68c8p-1, +0x1.b25dd267f66p-55, +-0x1p0, +0x1.55aae174d19c8p-3, +0x1.1b250171373bfp-1, +-0x1.b210e95e1ca4cp-55, +-0x1p0, +0x1.523369ba4fcaep-3, +0x1.19d5a09f2b9b8p-1, +-0x1.33656c68a1d4ap-57, +-0x1p0, +0x1.4ec010b0414e1p-3, +0x1.188591f3a46e5p-1, +-0x1.bbefe5a524346p-56, +-0x1p0, +0x1.4b50d8778abbdp-3, +0x1.1734d63dedb49p-1, +-0x1.7eef2ccc50575p-55, +-0x1p0, +0x1.47e5c32e84c45p-3, +0x1.15e36e4dbe2bcp-1, +0x1.3c545f7d79eaep-56, +-0x1p0, +0x1.447ed2f0fae31p-3, +0x1.14915af336cebp-1, +0x1.f3660558a0213p-56, +-0x1p0, +0x1.411c09d82a128p-3, +0x1.133e9cfee254fp-1, +-0x1.a1377cfd5ce5p-56, +-0x1p0, +0x1.3dbd69fabf802p-3, +0x1.11eb3541b4b23p-1, +-0x1.ef23b69abe4f1p-55, +-0x1p0, +0x1.3a62f56cd742ep-3, +0x1.1097248d0a957p-1, +-0x1.7a58759ba80ddp-55, +-0x1p0, +0x1.370cae3ffb12fp-3, +0x1.0f426bb2a8e7ep-1, +-0x1.bb58fb774f8eep-55, +-0x1p0, +0x1.33ba968321032p-3, +0x1.0ded0b84bc4b6p-1, +-0x1.8540fa327c55cp-55, +-0x1p0, +0x1.306cb042aa3bap-3, +0x1.0c9704d5d898fp-1, +-0x1.8d3d7de6ee9b2p-55, +-0x1p0, +0x1.2d22fd8861b6bp-3, +0x1.0b405878f85ecp-1, +-0x1.ad66c3bb80da5p-55, +-0x1p0, +0x1.29dd805b7afecp-3, +0x1.09e907417c5e1p-1, +-0x1.fe573741a9bd4p-55, +-0x1p0, +0x1.269c3ac090ee4p-3, +0x1.089112032b08cp-1, +0x1.3248ddf9fe619p-57, +-0x1p0, +0x1.235f2eb9a470ap-3, +0x1.073879922ffeep-1, +-0x1.a5a014347406cp-55, +-0x1p0, +0x1.20265e461b45ap-3, +0x1.05df3ec31b8b7p-1, +-0x1.e2dcad34d9c1dp-57, +-0x1p0, +0x1.1cf1cb62bec5dp-3, +0x1.0485626ae221ap-1, +0x1.b937d9091ff7p-55, +-0x1p0, +0x1.19c17809baa87p-3, +0x1.032ae55edbd96p-1, +-0x1.bdb022b40107ap-55, +-0x1p0, +0x1.169566329bcb7p-3, +0x1.01cfc874c3eb7p-1, +-0x1.34a35e7c2368cp-56, +-0x1p0, +0x1.136d97d24efccp-3, +0x1.00740c82b82e1p-1, +-0x1.6d48563c60e87p-55, +-0x1p0, +0x1.104a0edb1fc58p-3, +0x1.fe2f64be7121p-2, +-0x1.297ab1ca2d7dbp-56, +-0x1p0, +0x1.0d2acd3cb7364p-3, +0x1.fb7575c24d2dep-2, +-0x1.5bfdc883c8664p-57, +-0x1p0, +0x1.0a0fd4e41ab5ap-3, +0x1.f8ba4dbf89abap-2, +-0x1.2ec1fc1b776b8p-60, +-0x1p0, +0x1.06f927bbaacfep-3, +0x1.f5fdee656cda3p-2, +-0x1.7bf9780816b05p-58, +-0x1p0, +0x1.03e6c7ab2208cp-3, +0x1.f3405963fd067p-2, +0x1.06846d44a238fp-56, +-0x1p0, +0x1.00d8b69793ae4p-3, +0x1.f081906bff7fep-2, +-0x1.4cab2d4ff6fccp-56, +-0x1p0, +0x1.fb9decc6d55b8p-4, +0x1.edc1952ef78d6p-2, +-0x1.dd0f7c33edee6p-56, +-0x1p0, +0x1.f59311dcd0d44p-4, +0x1.eb00695f2562p-2, +0x1.53c9fd3083e22p-56, +-0x1p0, +0x1.ef90e02b47283p-4, +0x1.e83e0eaf85114p-2, +-0x1.7bc380ef24ba7p-57, +-0x1p0, +0x1.e9975b670e077p-4, +0x1.e57a86d3cd825p-2, +-0x1.2c80dcd511e87p-57, +-0x1p0, +0x1.e3a6873fa1279p-4, +0x1.e2b5d3806f63bp-2, +0x1.e0d891d3c6841p-58, +-0x1p0, +0x1.ddbe675f1ffdfp-4, +0x1.dfeff66a941dep-2, +-0x1.a756c6e625f96p-56, +-0x1p0, +0x1.d7deff6a4b7c9p-4, +0x1.dd28f1481cc58p-2, +-0x1.e7576fa6c944ep-59, +-0x1p0, +0x1.d208530083d3p-4, +0x1.da60c5cfa10d9p-2, +-0x1.0f38e2143c8d5p-57, +-0x1p0, +0x1.cc3a65bbc6327p-4, +0x1.d79775b86e389p-2, +0x1.550ec87bc0575p-56, +-0x1p0, +0x1.c6753b30aa949p-4, +0x1.d4cd02ba8609dp-2, +-0x1.37f33c63033d6p-57, +-0x1p0, +0x1.c0b8d6ee61867p-4, +0x1.d2016e8e9db5bp-2, +-0x1.c8bce9d93efb8p-57, +-0x1p0, +0x1.bb053c7eb1f68p-4, +0x1.cf34baee1cd21p-2, +-0x1.118724d19d014p-56, +-0x1p0, +0x1.b55a6f65f7058p-4, +0x1.cc66e9931c45ep-2, +0x1.6850e59c37f8fp-58, +-0x1p0, +0x1.afb873231ddb9p-4, +0x1.c997fc3865389p-2, +-0x1.6295f8b0ca33bp-56, +-0x1p0, +0x1.aa1f4b2fa37fcp-4, +0x1.c6c7f4997000bp-2, +-0x1.bec2669c68e74p-56, +-0x1p0, +0x1.a48efaff92b3bp-4, +0x1.c3f6d47263129p-2, +0x1.9c7bd0fcdecddp-56, +-0x1p0, +0x1.9f07860181d1ep-4, +0x1.c1249d8011ee7p-2, +-0x1.813aabb515206p-56, +-0x1p0, +0x1.9988ef9e90b04p-4, +0x1.be51517ffc0d9p-2, +0x1.2b667131a5f16p-56, +-0x1p0, +0x1.94133b3a66851p-4, +0x1.bb7cf2304bd01p-2, +0x1.9e1a5bd9269d4p-57, +-0x1p0, +0x1.8ea66c332fd01p-4, +0x1.b8a7814fd5693p-2, +0x1.9a9e6651cc119p-56, +-0x1p0, +0x1.894285e19c468p-4, +0x1.b5d1009e15ccp-2, +0x1.5b362cb974183p-57, +-0x1p0, +0x1.83e78b98dcc2bp-4, +0x1.b2f971db31972p-2, +0x1.fa971a4a41f2p-56, +-0x1p0, +0x1.7e9580a6a136ep-4, +0x1.b020d6c7f4009p-2, +0x1.414ae7e555208p-58, +-0x1p0, +0x1.794c685316a3cp-4, +0x1.ad473125cdc09p-2, +-0x1.379ede57649dap-58, +-0x1p0, +0x1.740c45e0e512p-4, +0x1.aa6c82b6d3fcap-2, +-0x1.d5f106ee5ccf7p-56, +-0x1p0, +0x1.6ed51c8d2d8fcp-4, +0x1.a790cd3dbf31bp-2, +-0x1.7f786986d9023p-57, +-0x1p0, +0x1.69a6ef8f8830ap-4, +0x1.a4b4127dea1e5p-2, +-0x1.bec6f01bc22f1p-56, +-0x1p0, +0x1.6481c21a02123p-4, +0x1.a1d6543b50acp-2, +-0x1.0246cfd8779fbp-57, +-0x1p0, +0x1.5f6597591b633p-4, +0x1.9ef7943a8ed8ap-2, +0x1.6da81290bdbabp-57, +-0x1p0, +0x1.5a527273c56e1p-4, +0x1.9c17d440df9f2p-2, +0x1.923c540a9eec4p-57, +-0x1p0, +0x1.5548568b60a7bp-4, +0x1.993716141bdffp-2, +-0x1.15e8cce261c55p-56, +-0x1p0, +0x1.504746bbbac0bp-4, +0x1.96555b7ab948fp-2, +0x1.7afd51eff33adp-56, +-0x1p0, +0x1.4b4f461b0cbaap-4, +0x1.9372a63bc93d7p-2, +0x1.684319e5ad5b1p-57, +-0x1p0, +0x1.466057b9f900ap-4, +0x1.908ef81ef7bd1p-2, +0x1.4c00267012357p-56, +-0x1p0, +0x1.417a7ea389835p-4, +0x1.8daa52ec8a4bp-2, +-0x1.72eb2db8c621ep-57, +-0x1p0, +0x1.3c9dbddd2dd84p-4, +0x1.8ac4b86d5ed44p-2, +0x1.17fa7f944ad5bp-56, +-0x1p0, +0x1.37ca1866b95cfp-4, +0x1.87de2a6aea963p-2, +-0x1.72cedd3d5a61p-57, +-0x1p0, +0x1.32ff913a615dp-4, +0x1.84f6aaaf3903fp-2, +0x1.6dcdc2bd47067p-57, +-0x1p0, +0x1.2e3e2b4cbb3c3p-4, +0x1.820e3b04eaac4p-2, +-0x1.92379eb01c6b6p-59, +-0x1p0, +0x1.2985e98cbaa3ap-4, +0x1.7f24dd37341e4p-2, +0x1.2791a1b5eb796p-57, +-0x1p0, +0x1.24d6cee3afb2ap-4, +0x1.7c3a9311dcce7p-2, +0x1.9a3f21ef3e8d9p-62, +-0x1p0, +0x1.2030de354532cp-4, +0x1.794f5e613dfaep-2, +0x1.820a4b0d21fc5p-57, +-0x1p0, +0x1.1b941a5f7ecffp-4, +0x1.766340f2418f6p-2, +0x1.2b2adc9041b2cp-56, +-0x1p0, +0x1.1700863ab7533p-4, +0x1.73763c9261092p-2, +-0x1.52324face3b1ap-57, +-0x1p0, +0x1.127624999ee1dp-4, +0x1.7088530fa459fp-2, +-0x1.44b19e0864c5dp-56, +-0x1p0, +0x1.0df4f849393f5p-4, +0x1.6d998638a0cb6p-2, +-0x1.1ca14532860dfp-61, +-0x1p0, +0x1.097d0410dc132p-4, +0x1.6aa9d7dc77e17p-2, +-0x1.38b470592c7b3p-56, +-0x1p0, +0x1.050e4ab22d321p-4, +0x1.67b949cad63cbp-2, +-0x1.a23369348d7efp-56, +-0x1p0, +0x1.00a8cee920eabp-4, +0x1.64c7ddd3f27c6p-2, +0x1.10d2b4a664121p-58, +-0x1p0, +0x1.f89926d7f0ab8p-5, +0x1.61d595c88c202p-2, +0x1.f6b1e333415d7p-56, +-0x1p0, +0x1.eff335d67f541p-5, +0x1.5ee27379ea693p-2, +0x1.634ff2fa75245p-56, +-0x1p0, +0x1.e75fd0239926cp-5, +0x1.5bee78b9db3b6p-2, +0x1.e734a63158dfdp-58, +-0x1p0, +0x1.dedefb09791b4p-5, +0x1.58f9a75ab1fddp-2, +-0x1.efdc0d58cf62p-62, +-0x1p0, +0x1.d670bbc6e685ep-5, +0x1.5604012f467b4p-2, +0x1.a0e0b2a5b25p-56, +-0x1p0, +0x1.ce15178f31db3p-5, +0x1.530d880af3c24p-2, +-0x1.fab8e2103fbd6p-56, +-0x1p0, +0x1.c5cc138a317afp-5, +0x1.50163dc197048p-2, +-0x1.ec66cb05c7ea4p-56, +-0x1p0, +0x1.bd95b4d43e819p-5, +0x1.4d1e24278e76ap-2, +0x1.2417218792858p-57, +-0x1p0, +0x1.b572007e31a1bp-5, +0x1.4a253d11b82f3p-2, +-0x1.2afa4d6d42a55p-58, +-0x1p0, +0x1.ad60fb8d6003ap-5, +0x1.472b8a5571054p-2, +-0x1.01ea0fe4dff23p-56, +-0x1p0, +0x1.a562aafb982cdp-5, +0x1.44310dc8936fp-2, +0x1.8b694e91d3125p-56, +-0x1p0, +0x1.9d7713b71eee1p-5, +0x1.4135c94176601p-2, +0x1.0c97c4afa2518p-56, +-0x1p0, +0x1.959e3aa2ac58dp-5, +0x1.3e39be96ec271p-2, +0x1.814c6de9aaaf6p-56, +-0x1p0, +0x1.8dd8249568bbbp-5, +0x1.3b3cefa0414b7p-2, +0x1.f36dc4a9c2294p-56, +-0x1p0, +0x1.8624d65ae9a63p-5, +0x1.383f5e353b6abp-2, +-0x1.a812a4a5c3d44p-56, +-0x1p0, +0x1.7e8454b32ef34p-5, +0x1.35410c2e18152p-2, +-0x1.3cb002f96e062p-56, +-0x1p0, +0x1.76f6a4529fdb5p-5, +0x1.3241fb638baafp-2, +0x1.ecee8f76f8c51p-60, +-0x1p0, +0x1.6f7bc9e2080d9p-5, +0x1.2f422daec0387p-2, +-0x1.7501ba473da6fp-56, +-0x1p0, +0x1.6813c9fe94cfbp-5, +0x1.2c41a4e95452p-2, +0x1.9cf0354aad2dcp-56, +-0x1p0, +0x1.60bea939d225ap-5, +0x1.294062ed59f06p-2, +-0x1.5d28da2c4612dp-56, +-0x1p0, +0x1.597c6c19a8003p-5, +0x1.263e6995554bap-2, +0x1.1d350ffc5ff32p-56, +-0x1p0, +0x1.524d171857726p-5, +0x1.233bbabc3bb71p-2, +0x1.99b04e23259efp-56, +-0x1p0, +0x1.4b30aea477eeep-5, +0x1.2038583d727bep-2, +-0x1.c69cd46300a3p-57, +-0x1p0, +0x1.44273720f48bcp-5, +0x1.1d3443f4cdb3ep-2, +-0x1.720d41c13519ep-57, +-0x1p0, +0x1.3d30b4e5094ep-5, +0x1.1a2f7fbe8f243p-2, +0x1.6465ac86ba7b2p-56, +-0x1p0, +0x1.364d2c3c407bep-5, +0x1.172a0d7765177p-2, +0x1.22575f33366bep-57, +-0x1p0, +0x1.2f7ca1666ff6fp-5, +0x1.1423eefc69378p-2, +0x1.22d3368ec9b62p-56, +-0x1p0, +0x1.28bf1897b69ccp-5, +0x1.111d262b1f677p-2, +0x1.824c20ab7aa9ap-56, +-0x1p0, +0x1.221495f879af5p-5, +0x1.0e15b4e1749cep-2, +-0x1.5b7fb156c550ap-56, +-0x1p0, +0x1.1b7d1da562443p-5, +0x1.0b0d9cfdbdb9p-2, +0x1.3b3a7b8d1200dp-58, +-0x1p0, +0x1.14f8b3af5abb9p-5, +0x1.0804e05eb661ep-2, +0x1.54e583d92d3d8p-56, +-0x1p0, +0x1.0e875c1b8c3dap-5, +0x1.04fb80e37fdaep-2, +-0x1.412cdb72583ccp-63, +-0x1p0, +0x1.08291ae35c407p-5, +0x1.01f1806b9fdd2p-2, +-0x1.448135394b8bap-56, +-0x1p0, +0x1.01ddf3f46a139p-5, +0x1.fdcdc1adfedf9p-3, +-0x1.2dba4580ed7bbp-57, +-0x1p0, +0x1.f74bd66118e8dp-6, +0x1.f7b7480bd3802p-3, +-0x1.9a96d967ee12ep-57, +-0x1p0, +0x1.eb0208db9e51bp-6, +0x1.f19f97b215f1bp-3, +-0x1.42deef11da2c4p-57, +-0x1p0, +0x1.dede86ece142ep-6, +0x1.eb86b462de348p-3, +-0x1.bfcde46f90b62p-57, +-0x1p0, +0x1.d2e15811bf462p-6, +0x1.e56ca1e101a1bp-3, +0x1.46ac3f9fd0227p-57, +-0x1p0, +0x1.c70a83af71ef5p-6, +0x1.df5163f01099ap-3, +-0x1.01f7d79906e86p-57, +-0x1p0, +0x1.bb5a11138a4c9p-6, +0x1.d934fe5454311p-3, +0x1.75b92277107adp-57, +-0x1p0, +0x1.afd00773ec64fp-6, +0x1.d31774d2cbdeep-3, +0x1.2fdc8e5791a0bp-57, +-0x1p0, +0x1.a46c6deecac5fp-6, +0x1.ccf8cb312b286p-3, +0x1.2382b0aecadf8p-58, +-0x1p0, +0x1.992f4b8aa21f8p-6, +0x1.c6d90535d74ddp-3, +-0x1.bfb2be2264962p-59, +-0x1p0, +0x1.8e18a73634ee7p-6, +0x1.c0b826a7e4f63p-3, +-0x1.af1439e521935p-62, +-0x1p0, +0x1.832887c88735dp-6, +0x1.ba96334f15dadp-3, +-0x1.75098c05dd18ap-57, +-0x1p0, +0x1.785ef400da46cp-6, +0x1.b4732ef3d6722p-3, +0x1.bbe5d5d75cbd8p-57, +-0x1p0, +0x1.6dbbf286a8971p-6, +0x1.ae4f1d5f3b9abp-3, +0x1.aa8bbcef9b68ep-57, +-0x1p0, +0x1.633f89e9a1a66p-6, +0x1.a82a025b00451p-3, +-0x1.87905ffd084adp-57, +-0x1p0, +0x1.58e9c0a1a5f21p-6, +0x1.a203e1b1831dap-3, +0x1.c1aadb580a1ecp-58, +-0x1p0, +0x1.4eba9d0ec2f7cp-6, +0x1.9bdcbf2dc4366p-3, +0x1.9632d189956fep-57, +-0x1p0, +0x1.44b225792f46bp-6, +0x1.95b49e9b62afap-3, +-0x1.100b3d1dbfeaap-59, +-0x1p0, +0x1.3ad06011469fbp-6, +0x1.8f8b83c69a60bp-3, +-0x1.26d19b9ff8d82p-57, +-0x1p0, +0x1.311552ef8623cp-6, +0x1.8961727c41804p-3, +0x1.3fdab4e42640ap-58, +-0x1p0, +0x1.278104148891ap-6, +0x1.83366e89c64c6p-3, +-0x1.192952df10db8p-57, +-0x1p0, +0x1.1e1379690291cp-6, +0x1.7d0a7bbd2cb1cp-3, +-0x1.cf900f27c58efp-57, +-0x1p0, +0x1.14ccb8bdbf114p-6, +0x1.76dd9de50bf31p-3, +0x1.1d5eeec501b2fp-57, +-0x1p0, +0x1.0bacc7cb9babap-6, +0x1.70afd8d08c4ffp-3, +0x1.260c3f1369484p-57, +-0x1p0, +0x1.02b3ac3385232p-6, +0x1.6a81304f64ab2p-3, +0x1.f0cd73fb5d8d4p-58, +-0x1p0, +0x1.f3c2d6fce7cfap-7, +0x1.6451a831d830dp-3, +0x1.ad16031a34d5p-58, +-0x1p0, +0x1.e26c163ad15b3p-7, +0x1.5e214448b3fc6p-3, +0x1.531ff779ddac6p-57, +-0x1p0, +0x1.d16320d2d221ep-7, +0x1.57f008654cbdep-3, +0x1.908c95c4c9118p-58, +-0x1p0, +0x1.c0a80146f894cp-7, +0x1.51bdf8597c5f2p-3, +-0x1.9f9976af04aa5p-61, +-0x1p0, +0x1.b03ac1e94fe1dp-7, +0x1.4b8b17f79fa88p-3, +0x1.b534fe588f0dp-57, +-0x1p0, +0x1.a01b6cdbd995ep-7, +0x1.45576b1293e5ap-3, +-0x1.285a24119f7b1p-58, +-0x1p0, +0x1.904a0c10875cep-7, +0x1.3f22f57db4893p-3, +0x1.bfe7ff2274956p-59, +-0x1p0, +0x1.80c6a94934dfp-7, +0x1.38edbb0cd8d14p-3, +-0x1.198c21fbf7718p-57, +-0x1p0, +0x1.71914e17a1bc6p-7, +0x1.32b7bf94516a7p-3, +0x1.2a24e2431ef29p-57, +-0x1p0, +0x1.62aa03dd6ba58p-7, +0x1.2c8106e8e613ap-3, +0x1.13000a89a11ep-58, +-0x1p0, +0x1.5410d3cc0891ep-7, +0x1.264994dfd3409p-3, +0x1.a744ce26f39cp-57, +-0x1p0, +0x1.45c5c6e4c114ap-7, +0x1.20116d4ec7bcfp-3, +-0x1.242c8e1053452p-57, +-0x1p0, +0x1.37c8e5f8aacep-7, +0x1.19d8940be24e7p-3, +0x1.e8dcdca90cc74p-58, +-0x1p0, +0x1.2a1a39a8a2fb7p-7, +0x1.139f0cedaf577p-3, +-0x1.523434d1b3cfap-57, +-0x1p0, +0x1.1cb9ca654924fp-7, +0x1.0d64dbcb26786p-3, +-0x1.713a562132055p-58, +-0x1p0, +0x1.0fa7a06ef9e81p-7, +0x1.072a047ba831dp-3, +0x1.19db1f70118cap-58, +-0x1p0, +0x1.02e3c3d5c9e17p-7, +0x1.00ee8ad6fb85bp-3, +0x1.673eac8308f11p-58, +-0x1p0, +0x1.ecdc78f30165cp-8, +0x1.f564e56a9730ep-4, +0x1.a2704729ae56dp-59, +-0x1p0, +0x1.d48e24132851p-8, +0x1.e8eb7fde4aa3fp-4, +-0x1.23758f2d5bb8bp-58, +-0x1p0, +0x1.bcdc980a46f5ap-8, +0x1.dc70ecbae9fc9p-4, +0x1.2fda2d73295eep-60, +-0x1p0, +0x1.a5c7e375e55dep-8, +0x1.cff533b307dc1p-4, +0x1.8feeb8f9c3334p-59, +-0x1p0, +0x1.8f501492cc296p-8, +0x1.c3785c79ec2d5p-4, +-0x1.4f39df133fb21p-61, +-0x1p0, +0x1.7975393cfbc4dp-8, +0x1.b6fa6ec38f64cp-4, +0x1.db5d943691f09p-58, +-0x1p0, +0x1.64375eefa3dd6p-8, +0x1.aa7b724495c03p-4, +0x1.e5399ba0967b8p-58, +-0x1p0, +0x1.4f9692c51b0fbp-8, +0x1.9dfb6eb24a85cp-4, +0x1.e96b47b8c44e6p-59, +-0x1p0, +0x1.3b92e176d6d31p-8, +0x1.917a6bc29b42cp-4, +-0x1.e2718d26ed688p-60, +-0x1p0, +0x1.282c575d639fcp-8, +0x1.84f8712c130a1p-4, +-0x1.e626ebafe374ep-58, +-0x1p0, +0x1.156300705d51bp-8, +0x1.787586a5d5b21p-4, +0x1.5f7589f083399p-58, +-0x1p0, +0x1.0336e84667c66p-8, +0x1.6bf1b3e79b129p-4, +-0x1.14b6da08765p-58, +-0x1p0, +0x1.e350342a4f6e6p-9, +0x1.5f6d00a9aa419p-4, +-0x1.f4022d03f6c9ap-59, +-0x1p0, +0x1.c16d4162779e5p-9, +0x1.52e774a4d4d0ap-4, +0x1.b2edf18c730cbp-60, +-0x1p0, +0x1.a0c50d1c6bf93p-9, +0x1.4661179272096p-4, +-0x1.4b109f2406c4cp-58, +-0x1p0, +0x1.8157ab7d29fd9p-9, +0x1.39d9f12c5a299p-4, +0x1.1287ff27ae554p-62, +-0x1p0, +0x1.63252fe77c5ebp-9, +0x1.2d52092ce19f6p-4, +-0x1.9a088a8bf6b2cp-59, +-0x1p0, +0x1.462dacfbef0f3p-9, +0x1.20c9674ed444dp-4, +-0x1.f9d48faba7974p-58, +-0x1p0, +0x1.2a713498c3c3dp-9, +0x1.1440134d709b3p-4, +-0x1.fec446daea6adp-58, +-0x1p0, +0x1.0fefd7d9e6ed8p-9, +0x1.07b614e463064p-4, +-0x1.384f8c3ee7605p-58, +-0x1p0, +0x1.ed534e31ca57fp-10, +0x1.f656e79f820ep-5, +-0x1.2e1ebe392bffep-61, +-0x1p0, +0x1.bd3d63d9c26efp-10, +0x1.dd406f9808ec9p-5, +0x1.1313a4b4068bdp-62, +-0x1p0, +0x1.8f9e0e5514865p-10, +0x1.c428d12c0d7e3p-5, +-0x1.89bc74b58c513p-60, +-0x1p0, +0x1.647569c825ae1p-10, +0x1.ab101bd5f8317p-5, +-0x1.65c6175c6dc68p-59, +-0x1p0, +0x1.3bc390d250439p-10, +0x1.91f65f10dd814p-5, +-0x1.912bd0d569a9p-61, +-0x1p0, +0x1.15889c8dd385fp-10, +0x1.78dbaa5874686p-5, +-0x1.4a0ef4035c29cp-60, +-0x1p0, +0x1.e389491f8833ap-11, +0x1.5fc00d290cd43p-5, +0x1.a2669a693a8e1p-59, +-0x1p0, +0x1.a0ef7dcffafabp-11, +0x1.46a396ff86179p-5, +0x1.136ac00fa2da9p-61, +-0x1p0, +0x1.6344004228d8bp-11, +0x1.2d865759455cdp-5, +0x1.686f65ba93acp-61, +-0x1p0, +0x1.2a86f68094692p-11, +0x1.14685db42c17fp-5, +-0x1.2890d277cb974p-59, +-0x1p0, +0x1.ed71071603e86p-12, +0x1.f693731d1cf01p-6, +-0x1.3fe9bc66286c7p-66, +-0x1p0, +0x1.8fb18eacc3af8p-12, +0x1.c454f4ce53b1dp-6, +-0x1.d63d7fef0e36cp-60, +-0x1p0, +0x1.3bcfbd9979a27p-12, +0x1.92155f7a3667ep-6, +-0x1.b1d63091a013p-64, +-0x1p0, +0x1.e3978f34889d9p-13, +0x1.5fd4d21fab226p-6, +-0x1.0c0a91c37851cp-61, +-0x1p0, +0x1.634bb4ae5ed49p-13, +0x1.2d936bbe30efdp-6, +0x1.b5f91ee371d64p-61, +-0x1p0, +0x1.ed7875885ea3ap-14, +0x1.f6a296ab997cbp-7, +-0x1.f2943d8fe7033p-61, +-0x1p0, +0x1.3bd2c8da49511p-14, +0x1.921d1fcdec784p-7, +0x1.9878ebe836d9dp-61, +-0x1p0, +0x1.634da1cec522dp-15, +0x1.2d96b0e509703p-7, +-0x1.1e9131ff52dc9p-63, +-0x1p0, +0x1.3bd38bab6d94cp-16, +0x1.921f0fe670071p-8, +0x1.ab967fe6b7a9bp-64, +-0x1p0, +0x1.3bd3bc5fc5ab4p-18, +0x1.921f8becca4bap-9, +0x1.2ba407bcab5b2p-63, +-0x1p0, +0, +0, +0, +-0x1p0, +0x1.3bd3bc5fc5ab4p-18, +-0x1.921f8becca4bap-9, +-0x1.2ba407bcab5b2p-63, +-0x1p0, +0x1.3bd38bab6d94cp-16, +-0x1.921f0fe670071p-8, +-0x1.ab967fe6b7a9bp-64, +-0x1p0, +0x1.634da1cec522dp-15, +-0x1.2d96b0e509703p-7, +0x1.1e9131ff52dc9p-63, +-0x1p0, +0x1.3bd2c8da49511p-14, +-0x1.921d1fcdec784p-7, +-0x1.9878ebe836d9dp-61, +-0x1p0, +0x1.ed7875885ea3ap-14, +-0x1.f6a296ab997cbp-7, +0x1.f2943d8fe7033p-61, +-0x1p0, +0x1.634bb4ae5ed49p-13, +-0x1.2d936bbe30efdp-6, +-0x1.b5f91ee371d64p-61, +-0x1p0, +0x1.e3978f34889d9p-13, +-0x1.5fd4d21fab226p-6, +0x1.0c0a91c37851cp-61, +-0x1p0, +0x1.3bcfbd9979a27p-12, +-0x1.92155f7a3667ep-6, +0x1.b1d63091a013p-64, +-0x1p0, +0x1.8fb18eacc3af8p-12, +-0x1.c454f4ce53b1dp-6, +0x1.d63d7fef0e36cp-60, +-0x1p0, +0x1.ed71071603e86p-12, +-0x1.f693731d1cf01p-6, +0x1.3fe9bc66286c7p-66, +-0x1p0, +0x1.2a86f68094692p-11, +-0x1.14685db42c17fp-5, +0x1.2890d277cb974p-59, +-0x1p0, +0x1.6344004228d8bp-11, +-0x1.2d865759455cdp-5, +-0x1.686f65ba93acp-61, +-0x1p0, +0x1.a0ef7dcffafabp-11, +-0x1.46a396ff86179p-5, +-0x1.136ac00fa2da9p-61, +-0x1p0, +0x1.e389491f8833ap-11, +-0x1.5fc00d290cd43p-5, +-0x1.a2669a693a8e1p-59, +-0x1p0, +0x1.15889c8dd385fp-10, +-0x1.78dbaa5874686p-5, +0x1.4a0ef4035c29cp-60, +-0x1p0, +0x1.3bc390d250439p-10, +-0x1.91f65f10dd814p-5, +0x1.912bd0d569a9p-61, +-0x1p0, +0x1.647569c825ae1p-10, +-0x1.ab101bd5f8317p-5, +0x1.65c6175c6dc68p-59, +-0x1p0, +0x1.8f9e0e5514865p-10, +-0x1.c428d12c0d7e3p-5, +0x1.89bc74b58c513p-60, +-0x1p0, +0x1.bd3d63d9c26efp-10, +-0x1.dd406f9808ec9p-5, +-0x1.1313a4b4068bdp-62, +-0x1p0, +0x1.ed534e31ca57fp-10, +-0x1.f656e79f820ep-5, +0x1.2e1ebe392bffep-61, +-0x1p0, +0x1.0fefd7d9e6ed8p-9, +-0x1.07b614e463064p-4, +0x1.384f8c3ee7605p-58, +-0x1p0, +0x1.2a713498c3c3dp-9, +-0x1.1440134d709b3p-4, +0x1.fec446daea6adp-58, +-0x1p0, +0x1.462dacfbef0f3p-9, +-0x1.20c9674ed444dp-4, +0x1.f9d48faba7974p-58, +-0x1p0, +0x1.63252fe77c5ebp-9, +-0x1.2d52092ce19f6p-4, +0x1.9a088a8bf6b2cp-59, +-0x1p0, +0x1.8157ab7d29fd9p-9, +-0x1.39d9f12c5a299p-4, +-0x1.1287ff27ae554p-62, +-0x1p0, +0x1.a0c50d1c6bf93p-9, +-0x1.4661179272096p-4, +0x1.4b109f2406c4cp-58, +-0x1p0, +0x1.c16d4162779e5p-9, +-0x1.52e774a4d4d0ap-4, +-0x1.b2edf18c730cbp-60, +-0x1p0, +0x1.e350342a4f6e6p-9, +-0x1.5f6d00a9aa419p-4, +0x1.f4022d03f6c9ap-59, +-0x1p0, +0x1.0336e84667c66p-8, +-0x1.6bf1b3e79b129p-4, +0x1.14b6da08765p-58, +-0x1p0, +0x1.156300705d51bp-8, +-0x1.787586a5d5b21p-4, +-0x1.5f7589f083399p-58, +-0x1p0, +0x1.282c575d639fcp-8, +-0x1.84f8712c130a1p-4, +0x1.e626ebafe374ep-58, +-0x1p0, +0x1.3b92e176d6d31p-8, +-0x1.917a6bc29b42cp-4, +0x1.e2718d26ed688p-60, +-0x1p0, +0x1.4f9692c51b0fbp-8, +-0x1.9dfb6eb24a85cp-4, +-0x1.e96b47b8c44e6p-59, +-0x1p0, +0x1.64375eefa3dd6p-8, +-0x1.aa7b724495c03p-4, +-0x1.e5399ba0967b8p-58, +-0x1p0, +0x1.7975393cfbc4dp-8, +-0x1.b6fa6ec38f64cp-4, +-0x1.db5d943691f09p-58, +-0x1p0, +0x1.8f501492cc296p-8, +-0x1.c3785c79ec2d5p-4, +0x1.4f39df133fb21p-61, +-0x1p0, +0x1.a5c7e375e55dep-8, +-0x1.cff533b307dc1p-4, +-0x1.8feeb8f9c3334p-59, +-0x1p0, +0x1.bcdc980a46f5ap-8, +-0x1.dc70ecbae9fc9p-4, +-0x1.2fda2d73295eep-60, +-0x1p0, +0x1.d48e24132851p-8, +-0x1.e8eb7fde4aa3fp-4, +0x1.23758f2d5bb8bp-58, +-0x1p0, +0x1.ecdc78f30165cp-8, +-0x1.f564e56a9730ep-4, +-0x1.a2704729ae56dp-59, +-0x1p0, +0x1.02e3c3d5c9e17p-7, +-0x1.00ee8ad6fb85bp-3, +-0x1.673eac8308f11p-58, +-0x1p0, +0x1.0fa7a06ef9e81p-7, +-0x1.072a047ba831dp-3, +-0x1.19db1f70118cap-58, +-0x1p0, +0x1.1cb9ca654924fp-7, +-0x1.0d64dbcb26786p-3, +0x1.713a562132055p-58, +-0x1p0, +0x1.2a1a39a8a2fb7p-7, +-0x1.139f0cedaf577p-3, +0x1.523434d1b3cfap-57, +-0x1p0, +0x1.37c8e5f8aacep-7, +-0x1.19d8940be24e7p-3, +-0x1.e8dcdca90cc74p-58, +-0x1p0, +0x1.45c5c6e4c114ap-7, +-0x1.20116d4ec7bcfp-3, +0x1.242c8e1053452p-57, +-0x1p0, +0x1.5410d3cc0891ep-7, +-0x1.264994dfd3409p-3, +-0x1.a744ce26f39cp-57, +-0x1p0, +0x1.62aa03dd6ba58p-7, +-0x1.2c8106e8e613ap-3, +-0x1.13000a89a11ep-58, +-0x1p0, +0x1.71914e17a1bc6p-7, +-0x1.32b7bf94516a7p-3, +-0x1.2a24e2431ef29p-57, +-0x1p0, +0x1.80c6a94934dfp-7, +-0x1.38edbb0cd8d14p-3, +0x1.198c21fbf7718p-57, +-0x1p0, +0x1.904a0c10875cep-7, +-0x1.3f22f57db4893p-3, +-0x1.bfe7ff2274956p-59, +-0x1p0, +0x1.a01b6cdbd995ep-7, +-0x1.45576b1293e5ap-3, +0x1.285a24119f7b1p-58, +-0x1p0, +0x1.b03ac1e94fe1dp-7, +-0x1.4b8b17f79fa88p-3, +-0x1.b534fe588f0dp-57, +-0x1p0, +0x1.c0a80146f894cp-7, +-0x1.51bdf8597c5f2p-3, +0x1.9f9976af04aa5p-61, +-0x1p0, +0x1.d16320d2d221ep-7, +-0x1.57f008654cbdep-3, +-0x1.908c95c4c9118p-58, +-0x1p0, +0x1.e26c163ad15b3p-7, +-0x1.5e214448b3fc6p-3, +-0x1.531ff779ddac6p-57, +-0x1p0, +0x1.f3c2d6fce7cfap-7, +-0x1.6451a831d830dp-3, +-0x1.ad16031a34d5p-58, +-0x1p0, +0x1.02b3ac3385232p-6, +-0x1.6a81304f64ab2p-3, +-0x1.f0cd73fb5d8d4p-58, +-0x1p0, +0x1.0bacc7cb9babap-6, +-0x1.70afd8d08c4ffp-3, +-0x1.260c3f1369484p-57, +-0x1p0, +0x1.14ccb8bdbf114p-6, +-0x1.76dd9de50bf31p-3, +-0x1.1d5eeec501b2fp-57, +-0x1p0, +0x1.1e1379690291cp-6, +-0x1.7d0a7bbd2cb1cp-3, +0x1.cf900f27c58efp-57, +-0x1p0, +0x1.278104148891ap-6, +-0x1.83366e89c64c6p-3, +0x1.192952df10db8p-57, +-0x1p0, +0x1.311552ef8623cp-6, +-0x1.8961727c41804p-3, +-0x1.3fdab4e42640ap-58, +-0x1p0, +0x1.3ad06011469fbp-6, +-0x1.8f8b83c69a60bp-3, +0x1.26d19b9ff8d82p-57, +-0x1p0, +0x1.44b225792f46bp-6, +-0x1.95b49e9b62afap-3, +0x1.100b3d1dbfeaap-59, +-0x1p0, +0x1.4eba9d0ec2f7cp-6, +-0x1.9bdcbf2dc4366p-3, +-0x1.9632d189956fep-57, +-0x1p0, +0x1.58e9c0a1a5f21p-6, +-0x1.a203e1b1831dap-3, +-0x1.c1aadb580a1ecp-58, +-0x1p0, +0x1.633f89e9a1a66p-6, +-0x1.a82a025b00451p-3, +0x1.87905ffd084adp-57, +-0x1p0, +0x1.6dbbf286a8971p-6, +-0x1.ae4f1d5f3b9abp-3, +-0x1.aa8bbcef9b68ep-57, +-0x1p0, +0x1.785ef400da46cp-6, +-0x1.b4732ef3d6722p-3, +-0x1.bbe5d5d75cbd8p-57, +-0x1p0, +0x1.832887c88735dp-6, +-0x1.ba96334f15dadp-3, +0x1.75098c05dd18ap-57, +-0x1p0, +0x1.8e18a73634ee7p-6, +-0x1.c0b826a7e4f63p-3, +0x1.af1439e521935p-62, +-0x1p0, +0x1.992f4b8aa21f8p-6, +-0x1.c6d90535d74ddp-3, +0x1.bfb2be2264962p-59, +-0x1p0, +0x1.a46c6deecac5fp-6, +-0x1.ccf8cb312b286p-3, +-0x1.2382b0aecadf8p-58, +-0x1p0, +0x1.afd00773ec64fp-6, +-0x1.d31774d2cbdeep-3, +-0x1.2fdc8e5791a0bp-57, +-0x1p0, +0x1.bb5a11138a4c9p-6, +-0x1.d934fe5454311p-3, +-0x1.75b92277107adp-57, +-0x1p0, +0x1.c70a83af71ef5p-6, +-0x1.df5163f01099ap-3, +0x1.01f7d79906e86p-57, +-0x1p0, +0x1.d2e15811bf462p-6, +-0x1.e56ca1e101a1bp-3, +-0x1.46ac3f9fd0227p-57, +-0x1p0, +0x1.dede86ece142ep-6, +-0x1.eb86b462de348p-3, +0x1.bfcde46f90b62p-57, +-0x1p0, +0x1.eb0208db9e51bp-6, +-0x1.f19f97b215f1bp-3, +0x1.42deef11da2c4p-57, +-0x1p0, +0x1.f74bd66118e8dp-6, +-0x1.f7b7480bd3802p-3, +0x1.9a96d967ee12ep-57, +-0x1p0, +0x1.01ddf3f46a139p-5, +-0x1.fdcdc1adfedf9p-3, +0x1.2dba4580ed7bbp-57, +-0x1p0, +0x1.08291ae35c407p-5, +-0x1.01f1806b9fdd2p-2, +0x1.448135394b8bap-56, +-0x1p0, +0x1.0e875c1b8c3dap-5, +-0x1.04fb80e37fdaep-2, +0x1.412cdb72583ccp-63, +-0x1p0, +0x1.14f8b3af5abb9p-5, +-0x1.0804e05eb661ep-2, +-0x1.54e583d92d3d8p-56, +-0x1p0, +0x1.1b7d1da562443p-5, +-0x1.0b0d9cfdbdb9p-2, +-0x1.3b3a7b8d1200dp-58, +-0x1p0, +0x1.221495f879af5p-5, +-0x1.0e15b4e1749cep-2, +0x1.5b7fb156c550ap-56, +-0x1p0, +0x1.28bf1897b69ccp-5, +-0x1.111d262b1f677p-2, +-0x1.824c20ab7aa9ap-56, +-0x1p0, +0x1.2f7ca1666ff6fp-5, +-0x1.1423eefc69378p-2, +-0x1.22d3368ec9b62p-56, +-0x1p0, +0x1.364d2c3c407bep-5, +-0x1.172a0d7765177p-2, +-0x1.22575f33366bep-57, +-0x1p0, +0x1.3d30b4e5094ep-5, +-0x1.1a2f7fbe8f243p-2, +-0x1.6465ac86ba7b2p-56, +-0x1p0, +0x1.44273720f48bcp-5, +-0x1.1d3443f4cdb3ep-2, +0x1.720d41c13519ep-57, +-0x1p0, +0x1.4b30aea477eeep-5, +-0x1.2038583d727bep-2, +0x1.c69cd46300a3p-57, +-0x1p0, +0x1.524d171857726p-5, +-0x1.233bbabc3bb71p-2, +-0x1.99b04e23259efp-56, +-0x1p0, +0x1.597c6c19a8003p-5, +-0x1.263e6995554bap-2, +-0x1.1d350ffc5ff32p-56, +-0x1p0, +0x1.60bea939d225ap-5, +-0x1.294062ed59f06p-2, +0x1.5d28da2c4612dp-56, +-0x1p0, +0x1.6813c9fe94cfbp-5, +-0x1.2c41a4e95452p-2, +-0x1.9cf0354aad2dcp-56, +-0x1p0, +0x1.6f7bc9e2080d9p-5, +-0x1.2f422daec0387p-2, +0x1.7501ba473da6fp-56, +-0x1p0, +0x1.76f6a4529fdb5p-5, +-0x1.3241fb638baafp-2, +-0x1.ecee8f76f8c51p-60, +-0x1p0, +0x1.7e8454b32ef34p-5, +-0x1.35410c2e18152p-2, +0x1.3cb002f96e062p-56, +-0x1p0, +0x1.8624d65ae9a63p-5, +-0x1.383f5e353b6abp-2, +0x1.a812a4a5c3d44p-56, +-0x1p0, +0x1.8dd8249568bbbp-5, +-0x1.3b3cefa0414b7p-2, +-0x1.f36dc4a9c2294p-56, +-0x1p0, +0x1.959e3aa2ac58dp-5, +-0x1.3e39be96ec271p-2, +-0x1.814c6de9aaaf6p-56, +-0x1p0, +0x1.9d7713b71eee1p-5, +-0x1.4135c94176601p-2, +-0x1.0c97c4afa2518p-56, +-0x1p0, +0x1.a562aafb982cdp-5, +-0x1.44310dc8936fp-2, +-0x1.8b694e91d3125p-56, +-0x1p0, +0x1.ad60fb8d6003ap-5, +-0x1.472b8a5571054p-2, +0x1.01ea0fe4dff23p-56, +-0x1p0, +0x1.b572007e31a1bp-5, +-0x1.4a253d11b82f3p-2, +0x1.2afa4d6d42a55p-58, +-0x1p0, +0x1.bd95b4d43e819p-5, +-0x1.4d1e24278e76ap-2, +-0x1.2417218792858p-57, +-0x1p0, +0x1.c5cc138a317afp-5, +-0x1.50163dc197048p-2, +0x1.ec66cb05c7ea4p-56, +-0x1p0, +0x1.ce15178f31db3p-5, +-0x1.530d880af3c24p-2, +0x1.fab8e2103fbd6p-56, +-0x1p0, +0x1.d670bbc6e685ep-5, +-0x1.5604012f467b4p-2, +-0x1.a0e0b2a5b25p-56, +-0x1p0, +0x1.dedefb09791b4p-5, +-0x1.58f9a75ab1fddp-2, +0x1.efdc0d58cf62p-62, +-0x1p0, +0x1.e75fd0239926cp-5, +-0x1.5bee78b9db3b6p-2, +-0x1.e734a63158dfdp-58, +-0x1p0, +0x1.eff335d67f541p-5, +-0x1.5ee27379ea693p-2, +-0x1.634ff2fa75245p-56, +-0x1p0, +0x1.f89926d7f0ab8p-5, +-0x1.61d595c88c202p-2, +-0x1.f6b1e333415d7p-56, +-0x1p0, +0x1.00a8cee920eabp-4, +-0x1.64c7ddd3f27c6p-2, +-0x1.10d2b4a664121p-58, +-0x1p0, +0x1.050e4ab22d321p-4, +-0x1.67b949cad63cbp-2, +0x1.a23369348d7efp-56, +-0x1p0, +0x1.097d0410dc132p-4, +-0x1.6aa9d7dc77e17p-2, +0x1.38b470592c7b3p-56, +-0x1p0, +0x1.0df4f849393f5p-4, +-0x1.6d998638a0cb6p-2, +0x1.1ca14532860dfp-61, +-0x1p0, +0x1.127624999ee1dp-4, +-0x1.7088530fa459fp-2, +0x1.44b19e0864c5dp-56, +-0x1p0, +0x1.1700863ab7533p-4, +-0x1.73763c9261092p-2, +0x1.52324face3b1ap-57, +-0x1p0, +0x1.1b941a5f7ecffp-4, +-0x1.766340f2418f6p-2, +-0x1.2b2adc9041b2cp-56, +-0x1p0, +0x1.2030de354532cp-4, +-0x1.794f5e613dfaep-2, +-0x1.820a4b0d21fc5p-57, +-0x1p0, +0x1.24d6cee3afb2ap-4, +-0x1.7c3a9311dcce7p-2, +-0x1.9a3f21ef3e8d9p-62, +-0x1p0, +0x1.2985e98cbaa3ap-4, +-0x1.7f24dd37341e4p-2, +-0x1.2791a1b5eb796p-57, +-0x1p0, +0x1.2e3e2b4cbb3c3p-4, +-0x1.820e3b04eaac4p-2, +0x1.92379eb01c6b6p-59, +-0x1p0, +0x1.32ff913a615dp-4, +-0x1.84f6aaaf3903fp-2, +-0x1.6dcdc2bd47067p-57, +-0x1p0, +0x1.37ca1866b95cfp-4, +-0x1.87de2a6aea963p-2, +0x1.72cedd3d5a61p-57, +-0x1p0, +0x1.3c9dbddd2dd84p-4, +-0x1.8ac4b86d5ed44p-2, +-0x1.17fa7f944ad5bp-56, +-0x1p0, +0x1.417a7ea389835p-4, +-0x1.8daa52ec8a4bp-2, +0x1.72eb2db8c621ep-57, +-0x1p0, +0x1.466057b9f900ap-4, +-0x1.908ef81ef7bd1p-2, +-0x1.4c00267012357p-56, +-0x1p0, +0x1.4b4f461b0cbaap-4, +-0x1.9372a63bc93d7p-2, +-0x1.684319e5ad5b1p-57, +-0x1p0, +0x1.504746bbbac0bp-4, +-0x1.96555b7ab948fp-2, +-0x1.7afd51eff33adp-56, +-0x1p0, +0x1.5548568b60a7bp-4, +-0x1.993716141bdffp-2, +0x1.15e8cce261c55p-56, +-0x1p0, +0x1.5a527273c56e1p-4, +-0x1.9c17d440df9f2p-2, +-0x1.923c540a9eec4p-57, +-0x1p0, +0x1.5f6597591b633p-4, +-0x1.9ef7943a8ed8ap-2, +-0x1.6da81290bdbabp-57, +-0x1p0, +0x1.6481c21a02123p-4, +-0x1.a1d6543b50acp-2, +0x1.0246cfd8779fbp-57, +-0x1p0, +0x1.69a6ef8f8830ap-4, +-0x1.a4b4127dea1e5p-2, +0x1.bec6f01bc22f1p-56, +-0x1p0, +0x1.6ed51c8d2d8fcp-4, +-0x1.a790cd3dbf31bp-2, +0x1.7f786986d9023p-57, +-0x1p0, +0x1.740c45e0e512p-4, +-0x1.aa6c82b6d3fcap-2, +0x1.d5f106ee5ccf7p-56, +-0x1p0, +0x1.794c685316a3cp-4, +-0x1.ad473125cdc09p-2, +0x1.379ede57649dap-58, +-0x1p0, +0x1.7e9580a6a136ep-4, +-0x1.b020d6c7f4009p-2, +-0x1.414ae7e555208p-58, +-0x1p0, +0x1.83e78b98dcc2bp-4, +-0x1.b2f971db31972p-2, +-0x1.fa971a4a41f2p-56, +-0x1p0, +0x1.894285e19c468p-4, +-0x1.b5d1009e15ccp-2, +-0x1.5b362cb974183p-57, +-0x1p0, +0x1.8ea66c332fd01p-4, +-0x1.b8a7814fd5693p-2, +-0x1.9a9e6651cc119p-56, +-0x1p0, +0x1.94133b3a66851p-4, +-0x1.bb7cf2304bd01p-2, +-0x1.9e1a5bd9269d4p-57, +-0x1p0, +0x1.9988ef9e90b04p-4, +-0x1.be51517ffc0d9p-2, +-0x1.2b667131a5f16p-56, +-0x1p0, +0x1.9f07860181d1ep-4, +-0x1.c1249d8011ee7p-2, +0x1.813aabb515206p-56, +-0x1p0, +0x1.a48efaff92b3bp-4, +-0x1.c3f6d47263129p-2, +-0x1.9c7bd0fcdecddp-56, +-0x1p0, +0x1.aa1f4b2fa37fcp-4, +-0x1.c6c7f4997000bp-2, +0x1.bec2669c68e74p-56, +-0x1p0, +0x1.afb873231ddb9p-4, +-0x1.c997fc3865389p-2, +0x1.6295f8b0ca33bp-56, +-0x1p0, +0x1.b55a6f65f7058p-4, +-0x1.cc66e9931c45ep-2, +-0x1.6850e59c37f8fp-58, +-0x1p0, +0x1.bb053c7eb1f68p-4, +-0x1.cf34baee1cd21p-2, +0x1.118724d19d014p-56, +-0x1p0, +0x1.c0b8d6ee61867p-4, +-0x1.d2016e8e9db5bp-2, +0x1.c8bce9d93efb8p-57, +-0x1p0, +0x1.c6753b30aa949p-4, +-0x1.d4cd02ba8609dp-2, +0x1.37f33c63033d6p-57, +-0x1p0, +0x1.cc3a65bbc6327p-4, +-0x1.d79775b86e389p-2, +-0x1.550ec87bc0575p-56, +-0x1p0, +0x1.d208530083d3p-4, +-0x1.da60c5cfa10d9p-2, +0x1.0f38e2143c8d5p-57, +-0x1p0, +0x1.d7deff6a4b7c9p-4, +-0x1.dd28f1481cc58p-2, +0x1.e7576fa6c944ep-59, +-0x1p0, +0x1.ddbe675f1ffdfp-4, +-0x1.dfeff66a941dep-2, +0x1.a756c6e625f96p-56, +-0x1p0, +0x1.e3a6873fa1279p-4, +-0x1.e2b5d3806f63bp-2, +-0x1.e0d891d3c6841p-58, +-0x1p0, +0x1.e9975b670e077p-4, +-0x1.e57a86d3cd825p-2, +0x1.2c80dcd511e87p-57, +-0x1p0, +0x1.ef90e02b47283p-4, +-0x1.e83e0eaf85114p-2, +0x1.7bc380ef24ba7p-57, +-0x1p0, +0x1.f59311dcd0d44p-4, +-0x1.eb00695f2562p-2, +-0x1.53c9fd3083e22p-56, +-0x1p0, +0x1.fb9decc6d55b8p-4, +-0x1.edc1952ef78d6p-2, +0x1.dd0f7c33edee6p-56, +-0x1p0, +0x1.00d8b69793ae4p-3, +-0x1.f081906bff7fep-2, +0x1.4cab2d4ff6fccp-56, +-0x1p0, +0x1.03e6c7ab2208cp-3, +-0x1.f3405963fd067p-2, +-0x1.06846d44a238fp-56, +-0x1p0, +0x1.06f927bbaacfep-3, +-0x1.f5fdee656cda3p-2, +0x1.7bf9780816b05p-58, +-0x1p0, +0x1.0a0fd4e41ab5ap-3, +-0x1.f8ba4dbf89abap-2, +0x1.2ec1fc1b776b8p-60, +-0x1p0, +0x1.0d2acd3cb7364p-3, +-0x1.fb7575c24d2dep-2, +0x1.5bfdc883c8664p-57, +-0x1p0, +0x1.104a0edb1fc58p-3, +-0x1.fe2f64be7121p-2, +0x1.297ab1ca2d7dbp-56, +-0x1p0, +0x1.136d97d24efccp-3, +-0x1.00740c82b82e1p-1, +0x1.6d48563c60e87p-55, +-0x1p0, +0x1.169566329bcb7p-3, +-0x1.01cfc874c3eb7p-1, +0x1.34a35e7c2368cp-56, +-0x1p0, +0x1.19c17809baa87p-3, +-0x1.032ae55edbd96p-1, +0x1.bdb022b40107ap-55, +-0x1p0, +0x1.1cf1cb62bec5dp-3, +-0x1.0485626ae221ap-1, +-0x1.b937d9091ff7p-55, +-0x1p0, +0x1.20265e461b45ap-3, +-0x1.05df3ec31b8b7p-1, +0x1.e2dcad34d9c1dp-57, +-0x1p0, +0x1.235f2eb9a470ap-3, +-0x1.073879922ffeep-1, +0x1.a5a014347406cp-55, +-0x1p0, +0x1.269c3ac090ee4p-3, +-0x1.089112032b08cp-1, +-0x1.3248ddf9fe619p-57, +-0x1p0, +0x1.29dd805b7afecp-3, +-0x1.09e907417c5e1p-1, +0x1.fe573741a9bd4p-55, +-0x1p0, +0x1.2d22fd8861b6bp-3, +-0x1.0b405878f85ecp-1, +0x1.ad66c3bb80da5p-55, +-0x1p0, +0x1.306cb042aa3bap-3, +-0x1.0c9704d5d898fp-1, +0x1.8d3d7de6ee9b2p-55, +-0x1p0, +0x1.33ba968321032p-3, +-0x1.0ded0b84bc4b6p-1, +0x1.8540fa327c55cp-55, +-0x1p0, +0x1.370cae3ffb12fp-3, +-0x1.0f426bb2a8e7ep-1, +0x1.bb58fb774f8eep-55, +-0x1p0, +0x1.3a62f56cd742ep-3, +-0x1.1097248d0a957p-1, +0x1.7a58759ba80ddp-55, +-0x1p0, +0x1.3dbd69fabf802p-3, +-0x1.11eb3541b4b23p-1, +0x1.ef23b69abe4f1p-55, +-0x1p0, +0x1.411c09d82a128p-3, +-0x1.133e9cfee254fp-1, +0x1.a1377cfd5ce5p-56, +-0x1p0, +0x1.447ed2f0fae31p-3, +-0x1.14915af336cebp-1, +-0x1.f3660558a0213p-56, +-0x1p0, +0x1.47e5c32e84c45p-3, +-0x1.15e36e4dbe2bcp-1, +-0x1.3c545f7d79eaep-56, +-0x1p0, +0x1.4b50d8778abbdp-3, +-0x1.1734d63dedb49p-1, +0x1.7eef2ccc50575p-55, +-0x1p0, +0x1.4ec010b0414e1p-3, +-0x1.188591f3a46e5p-1, +0x1.bbefe5a524346p-56, +-0x1p0, +0x1.523369ba4fcaep-3, +-0x1.19d5a09f2b9b8p-1, +0x1.33656c68a1d4ap-57, +-0x1p0, +0x1.55aae174d19c8p-3, +-0x1.1b250171373bfp-1, +0x1.b210e95e1ca4cp-55, +-0x1p0, +0x1.592675bc57974p-3, +-0x1.1c73b39ae68c8p-1, +-0x1.b25dd267f66p-55, +-0x1p0, +0x1.5ca6246ae94b8p-3, +-0x1.1dc1b64dc4872p-1, +-0x1.f15e1c468be78p-57, +-0x1p0, +0x1.6029eb580658ep-3, +-0x1.1f0f08bbc861bp-1, +0x1.10d9dcafb74cbp-57, +-0x1p0, +0x1.63b1c858a7c2ep-3, +-0x1.205baa17560d6p-1, +-0x1.b7b144016c7a3p-56, +-0x1p0, +0x1.673db93f41479p-3, +-0x1.21a799933eb59p-1, +0x1.3a7b177c68fb2p-55, +-0x1p0, +0x1.6acdbbdbc2b73p-3, +-0x1.22f2d662c13e2p-1, +0x1.d5cc7580cb6d2p-55, +-0x1p0, +0x1.6e61cdfb994dfp-3, +-0x1.243d5fb98ac1fp-1, +-0x1.c533d0a284a8dp-56, +-0x1p0, +0x1.71f9ed69b10eap-3, +-0x1.258734cbb711p-1, +-0x1.3a3f0903ce09dp-57, +-0x1p0, +0x1.759617ee761f9p-3, +-0x1.26d054cdd12dfp-1, +0x1.5da743ef3770cp-55, +-0x1p0, +0x1.79364b4fd6288p-3, +-0x1.2818bef4d3cbap-1, +0x1.e3fffeb76568ap-56, +-0x1p0, +0x1.7cda855141b26p-3, +-0x1.2960727629ca8p-1, +-0x1.56d6c7af02d5cp-56, +-0x1p0, +0x1.8082c3b3ad887p-3, +-0x1.2aa76e87aeb58p-1, +-0x1.fd600833287a7p-59, +-0x1p0, +0x1.842f0435941afp-3, +-0x1.2bedb25faf3eap-1, +0x1.14981c796ee46p-58, +-0x1p0, +0x1.87df4492f6e38p-3, +-0x1.2d333d34e9bb8p-1, +0x1.0e2c2c5549e26p-55, +-0x1p0, +0x1.8b9382855fcaap-3, +-0x1.2e780e3e8ea17p-1, +0x1.b19fafe36587ap-55, +-0x1p0, +0x1.8f4bbbc3e28f6p-3, +-0x1.2fbc24b441015p-1, +-0x1.dba4875410874p-57, +-0x1p0, +0x1.9307ee031e2fdp-3, +-0x1.30ff7fce17035p-1, +0x1.efcc626f74a6fp-57, +-0x1p0, +0x1.96c816f53e539p-3, +-0x1.32421ec49a61fp-1, +-0x1.65e25cc951bfep-55, +-0x1p0, +0x1.9a8c3449fcb77p-3, +-0x1.338400d0c8e57p-1, +0x1.abf2a5e95e6e5p-55, +-0x1p0, +0x1.9e5443aea29b2p-3, +-0x1.34c5252c14de1p-1, +-0x1.583f49632ab2bp-55, +-0x1p0, +0x1.a22042ce0a2f9p-3, +-0x1.36058b10659f3p-1, +0x1.1fcb3a35857e7p-55, +-0x1p0, +0x1.a5f02f50a007cp-3, +-0x1.374531b817f8dp-1, +-0x1.444d2b0a747fep-55, +-0x1p0, +0x1.a9c406dc648a5p-3, +-0x1.3884185dfeb22p-1, +0x1.a038026abe6b2p-56, +-0x1p0, +0x1.ad9bc714ed64fp-3, +-0x1.39c23e3d63029p-1, +0x1.3b05b276085c1p-58, +-0x1p0, +0x1.b1776d9b67013p-3, +-0x1.3affa292050b9p-1, +-0x1.e3e25e3954964p-56, +-0x1p0, +0x1.b556f80e95facp-3, +-0x1.3c3c44981c518p-1, +0x1.b5e9a9644151bp-55, +-0x1p0, +0x1.b93a640ad8978p-3, +-0x1.3d78238c58344p-1, +0x1.0219f5f0f79cep-55, +-0x1p0, +0x1.bd21af2a28408p-3, +-0x1.3eb33eabe068p-1, +-0x1.86a2357d1a0d3p-58, +-0x1p0, +0x1.c10cd7041afccp-3, +-0x1.3fed9534556d4p-1, +-0x1.36916608c5061p-55, +-0x1p0, +0x1.c4fbd92de4eddp-3, +-0x1.41272663d108cp-1, +-0x1.1bbe7636fadf5p-55, +-0x1p0, +0x1.c8eeb33a59cdp-3, +-0x1.425ff178e6bb1p-1, +-0x1.7b38d675140cap-55, +-0x1p0, +0x1.cce562b9ee6aep-3, +-0x1.4397f5b2a438p-1, +0x1.7274c9e48c226p-55, +-0x1p0, +0x1.d0dfe53aba2fdp-3, +-0x1.44cf325091dd6p-1, +-0x1.8076a2cfdc6b3p-57, +-0x1p0, +0x1.d4de3848789e2p-3, +-0x1.4605a692b32a2p-1, +-0x1.21ca219b97107p-55, +-0x1p0, +0x1.d8e0596c8ad56p-3, +-0x1.473b51b987347p-1, +-0x1.ca1953514e41bp-57, +-0x1p0, +0x1.dce6462df917dp-3, +-0x1.48703306091ffp-1, +0x1.70813b86159fdp-57, +-0x1p0, +0x1.e0effc1174505p-3, +-0x1.49a449b9b0939p-1, +0x1.27ee16d719b94p-55, +-0x1p0, +0x1.e4fd7899579acp-3, +-0x1.4ad79516722f1p-1, +0x1.1273b163000f7p-55, +-0x1p0, +0x1.e90eb945a9ccfp-3, +-0x1.4c0a145ec0004p-1, +-0x1.2630cfafceaa1p-58, +-0x1p0, +0x1.ed23bb941f019p-3, +-0x1.4d3bc6d589f7fp-1, +-0x1.6e4d9d6b72011p-55, +-0x1p0, +0x1.f13c7d001a249p-3, +-0x1.4e6cabbe3e5e9p-1, +-0x1.3c293edceb327p-57, +-0x1p0, +0x1.f558fb02ae805p-3, +-0x1.4f9cc25cca486p-1, +-0x1.48b5951cfc2b5p-55, +-0x1p0, +0x1.f9793312a14d1p-3, +-0x1.50cc09f59a09bp-1, +-0x1.693463a2c2e6fp-56, +-0x1p0, +0x1.fd9d22a46b416p-3, +-0x1.51fa81cd99aa6p-1, +0x1.499f59d8560e9p-63, +-0x1p0, +0x1.00e263951d11fp-2, +-0x1.5328292a35596p-1, +0x1.a12eb89da0257p-56, +-0x1p0, +0x1.02f80f09f92f4p-2, +-0x1.5454ff5159dfcp-1, +0x1.4e247588bf256p-55, +-0x1p0, +0x1.050f92679849cp-2, +-0x1.5581038975137p-1, +-0x1.4570d9efe26dfp-55, +-0x1p0, +0x1.0728ec63a599ap-2, +-0x1.56ac35197649fp-1, +0x1.f7874188cb279p-55, +-0x1p0, +0x1.09441bb2aa0a2p-2, +-0x1.57d69348cecap-1, +0x1.75720992bfbb2p-55, +-0x1p0, +0x1.0b611f080d05bp-2, +-0x1.59001d5f723dfp-1, +-0x1.a9f86ba0dde98p-56, +-0x1p0, +0x1.0d7ff51615437p-2, +-0x1.5a28d2a5d725p-1, +-0x1.57a25f8b1343p-55, +-0x1p0, +0x1.0fa09c8de994bp-2, +-0x1.5b50b264f7448p-1, +-0x1.519d30d4cfebp-56, +-0x1p0, +0x1.11c3141f91b3ep-2, +-0x1.5c77bbe65018cp-1, +-0x1.069ea9c0bc32ap-55, +-0x1p0, +0x1.13e75a79f7139p-2, +-0x1.5d9dee73e345cp-1, +0x1.de1165ecdf7a3p-57, +-0x1p0, +0x1.160d6e4ae5ae6p-2, +-0x1.5ec3495837074p-1, +-0x1.dea89a9b8f727p-56, +-0x1p0, +0x1.18354e3f0cd7dp-2, +-0x1.5fe7cbde56a1p-1, +0x1.fcb9cc30cc01ep-55, +-0x1p0, +0x1.1a5ef902000d3p-2, +-0x1.610b7551d2cdfp-1, +0x1.251b352ff2a37p-56, +-0x1p0, +0x1.1c8a6d3e37c82p-2, +-0x1.622e44fec22ffp-1, +-0x1.f98d8be132d57p-56, +-0x1p0, +0x1.1eb7a99d1250cp-2, +-0x1.63503a31c1be9p-1, +-0x1.1248f09e6587cp-57, +-0x1p0, +0x1.20e6acc6d4916p-2, +-0x1.64715437f535bp-1, +0x1.7c399c15a17dp-55, +-0x1p0, +0x1.23177562aaea3p-2, +-0x1.6591925f0783dp-1, +-0x1.c3d64fbf5de23p-55, +-0x1p0, +0x1.254a0216aa067p-2, +-0x1.66b0f3f52b386p-1, +-0x1.1e2eb31a8848bp-55, +-0x1p0, +0x1.277e5187cfb16p-2, +-0x1.67cf78491af1p-1, +-0x1.750ab23477b61p-59, +-0x1p0, +0x1.29b4625a03ac9p-2, +-0x1.68ed1eaa19c71p-1, +-0x1.fd4a85350f69p-56, +-0x1p0, +0, +-0x1.6a09e667f3bcdp-1, +0x1.bdd3413b26456p-55, +0, +-0x1.a3b47aa8671c5p-3, +-0x1.6b25ced2fe29cp-1, +0x1.5ac64116beda5p-55, +-0x1p-1, +-0x1.9f3de1246bc4p-3, +-0x1.6c40d73c18275p-1, +-0x1.25d4f802be257p-57, +-0x1p-1, +-0x1.9ac3cfd4ace19p-3, +-0x1.6d5afef4aafcdp-1, +0x1.868a696b8835ep-55, +-0x1p-1, +-0x1.9646497c1e0f6p-3, +-0x1.6e74454eaa8afp-1, +0x1.dbc03c84e226ep-55, +-0x1p-1, +-0x1.91c550dfd4d6bp-3, +-0x1.6f8ca99c95b75p-1, +-0x1.f22e7a35723f4p-56, +-0x1p-1, +-0x1.8d40e8c706fa4p-3, +-0x1.70a42b3176d7ap-1, +0x1.d9e3fbe2e15ap-56, +-0x1p-1, +-0x1.88b913fb08bfdp-3, +-0x1.71bac960e41bfp-1, +0x1.b858d90b0f7d8p-56, +-0x1p-1, +-0x1.842dd5474b37bp-3, +-0x1.72d0837efff96p-1, +-0x1.0d4ef0f1d915cp-55, +-0x1p-1, +-0x1.7f9f2f795a83ep-3, +-0x1.73e558e079942p-1, +0x1.2663126697f5ep-55, +-0x1p-1, +-0x1.7b0d2560dc1d1p-3, +-0x1.74f948da8d28dp-1, +-0x1.19900a3b9a3a2p-63, +-0x1p-1, +-0x1.7677b9cf8d17p-3, +-0x1.760c52c304764p-1, +0x1.11d76f8e50f1fp-55, +-0x1p-1, +-0x1.71deef9940631p-3, +-0x1.771e75f037261p-1, +-0x1.5cfce8d84068fp-56, +-0x1p-1, +-0x1.6d42c993dd121p-3, +-0x1.782fb1b90b35bp-1, +0x1.3e46c1dfd001cp-55, +-0x1p-1, +-0x1.68a34a975c941p-3, +-0x1.79400574f55e5p-1, +0x1.0adadbdb4c65ap-55, +-0x1p-1, +-0x1.6400757dc8f7dp-3, +-0x1.7a4f707bf97d2p-1, +-0x1.3c9751b491eafp-55, +-0x1p-1, +-0x1.5f5a4d233b27fp-3, +-0x1.7b5df226aafafp-1, +0x1.0f537acdf0ad7p-56, +-0x1p-1, +-0x1.5ab0d465d927ap-3, +-0x1.7c6b89ce2d333p-1, +0x1.cfd628084982cp-56, +-0x1p-1, +-0x1.56040e25d44ddp-3, +-0x1.7d7836cc33db2p-1, +-0x1.162715ef03f85p-56, +-0x1p-1, +-0x1.5153fd45677efp-3, +-0x1.7e83f87b03686p-1, +-0x1.b61a8ccabad6p-57, +-0x1p-1, +-0x1.4ca0a4a8d5657p-3, +-0x1.7f8ece3571771p-1, +0x1.9c8d8ce93c917p-55, +-0x1p-1, +-0x1.47ea073666a98p-3, +-0x1.8098b756e52fap-1, +-0x1.9136e834b4707p-55, +-0x1p-1, +-0x1.433027d66826dp-3, +-0x1.81a1b33b57accp-1, +0x1.5dea12d66bb66p-55, +-0x1p-1, +-0x1.3e73097329219p-3, +-0x1.82a9c13f545ffp-1, +0x1.65e87a7a8cde9p-56, +-0x1p-1, +-0x1.39b2aef8f97a4p-3, +-0x1.83b0e0bff976ep-1, +0x1.6f420f8ea3475p-56, +-0x1p-1, +-0x1.34ef1b5627dfdp-3, +-0x1.84b7111af83fap-1, +0x1.63a47df0b21bap-55, +-0x1p-1, +-0x1.3028517b0001p-3, +-0x1.85bc51ae958ccp-1, +-0x1.45ba6478086ccp-55, +-0x1p-1, +-0x1.2b5e5459c8bc3p-3, +-0x1.86c0a1d9aa195p-1, +-0x1.84564f09c3726p-59, +-0x1p-1, +-0x1.269126e6c24e3p-3, +-0x1.87c400fba2ebfp-1, +0x1.2dabc0c3f64cdp-55, +-0x1p-1, +-0x1.21c0cc18247fcp-3, +-0x1.88c66e7481ba1p-1, +0x1.5c6228970cf35p-56, +-0x1p-1, +-0x1.1ced46e61cd1cp-3, +-0x1.89c7e9a4dd4aap-1, +-0x1.db6ea04a8678fp-55, +-0x1p-1, +-0x1.18169a4acca89p-3, +-0x1.8ac871ede1d88p-1, +0x1.9afaa5b7cfc55p-55, +-0x1p-1, +-0x1.133cc94247758p-3, +-0x1.8bc806b151741p-1, +0x1.2c5e12ed1336dp-55, +-0x1p-1, +-0x1.0e5fd6ca90dffp-3, +-0x1.8cc6a75184655p-1, +0x1.e18b3657e2285p-55, +-0x1p-1, +-0x1.097fc5e39aec5p-3, +-0x1.8dc45331698ccp-1, +-0x1.1d9fcd83634d7p-57, +-0x1p-1, +-0x1.049c998f44231p-3, +-0x1.8ec109b486c49p-1, +0x1.cb2a3eb6af617p-56, +-0x1p-1, +-0x1.ff6ca9a2ab6a2p-4, +-0x1.8fbcca3ef940dp-1, +0x1.6dfa99c86f2f1p-57, +-0x1p-1, +-0x1.f599f55f034p-4, +-0x1.90b7943575efep-1, +-0x1.4ecb0c5273706p-57, +-0x1p-1, +-0x1.ebc11c62c1a1ep-4, +-0x1.91b166fd49da2p-1, +0x1.3be953a7fe996p-57, +-0x1p-1, +-0x1.e1e224c0e28bdp-4, +-0x1.92aa41fc5a815p-1, +0x1.68f89e2d23db7p-57, +-0x1p-1, +-0x1.d7fd1490285cap-4, +-0x1.93a22499263fbp-1, +-0x1.3d419a920df0bp-55, +-0x1p-1, +-0x1.ce11f1eb18148p-4, +-0x1.94990e3ac4a6cp-1, +-0x1.a95328edeb3e6p-56, +-0x1p-1, +-0x1.c420c2eff590ep-4, +-0x1.958efe48e6dd7p-1, +0x1.561335da0f4e7p-55, +-0x1p-1, +-0x1.ba298dc0bfc6bp-4, +-0x1.9683f42bd7fe1p-1, +0x1.11bad933c835ep-57, +-0x1p-1, +-0x1.b02c58832cf96p-4, +-0x1.9777ef4c7d742p-1, +0x1.15479a240665ep-55, +-0x1p-1, +-0x1.a6292960a6f0bp-4, +-0x1.986aef1457594p-1, +0x1.af03e318f38fcp-55, +-0x1p-1, +-0x1.9c200686472b5p-4, +-0x1.995cf2ed80d22p-1, +-0x1.7783e907fbd7bp-56, +-0x1p-1, +-0x1.9210f624d30fbp-4, +-0x1.9a4dfa42b06b2p-1, +0x1.829b6b8b1c947p-56, +-0x1p-1, +-0x1.87fbfe70b81a7p-4, +-0x1.9b3e047f38741p-1, +0x1.30ee286712474p-55, +-0x1p-1, +-0x1.7de125a2080a9p-4, +-0x1.9c2d110f075c2p-1, +-0x1.d9c9f1c8c30dp-55, +-0x1p-1, +-0x1.73c071f4750b5p-4, +-0x1.9d1b1f5ea80d5p-1, +-0x1.c5fadd5ffb36fp-55, +-0x1p-1, +-0x1.6999e9a74ddbep-4, +-0x1.9e082edb42472p-1, +-0x1.5809a4e121e22p-57, +-0x1p-1, +-0x1.5f6d92fd79f5p-4, +-0x1.9ef43ef29af94p-1, +-0x1.b1dfcb60445c2p-56, +-0x1p-1, +-0x1.553b743d75acp-4, +-0x1.9fdf4f13149dep-1, +-0x1.1e6d79006ec09p-55, +-0x1p-1, +-0x1.4b0393b14e541p-4, +-0x1.a0c95eabaf937p-1, +0x1.e0ca3acbd049ap-55, +-0x1p-1, +-0x1.40c5f7a69e5cep-4, +-0x1.a1b26d2c0a75ep-1, +-0x1.30ef431d627a6p-57, +-0x1p-1, +-0x1.3682a66e896f5p-4, +-0x1.a29a7a0462782p-1, +0x1.128bb015df175p-56, +-0x1p-1, +-0x1.2c39a65db8881p-4, +-0x1.a38184a593bc6p-1, +0x1.bc92c5bd2d288p-55, +-0x1p-1, +-0x1.21eafdcc560fap-4, +-0x1.a4678c8119ac8p-1, +-0x1.1b4c0dd3f212ap-55, +-0x1p-1, +-0x1.1796b31609f0cp-4, +-0x1.a54c91090f523p-1, +-0x1.184300fd1c1cep-56, +-0x1p-1, +-0x1.0d3ccc99f5ac6p-4, +-0x1.a63091b02fae2p-1, +0x1.e911152248d1p-56, +-0x1p-1, +-0x1.02dd50bab06b2p-4, +-0x1.a7138de9d60f5p-1, +0x1.f1ab82a9c5f2dp-55, +-0x1p-1, +-0x1.f0f08bbc861afp-5, +-0x1.a7f58529fe69dp-1, +0x1.97a441584a179p-55, +-0x1p-1, +-0x1.dc1b64dc48722p-5, +-0x1.a8d676e545ad2p-1, +0x1.b11dcce2e74bdp-59, +-0x1p-1, +-0x1.c73b39ae68c87p-5, +-0x1.a9b66290ea1a3p-1, +-0x1.9f630e8b6dac8p-60, +-0x1p-1, +-0x1.b250171373be9p-5, +-0x1.aa9547a2cb98ep-1, +-0x1.87d00ae97abaap-60, +-0x1p-1, +-0x1.9d5a09f2b9b7fp-5, +-0x1.ab7325916c0d4p-1, +-0x1.a8b8c85baaa9bp-55, +-0x1p-1, +-0x1.88591f3a46e4dp-5, +-0x1.ac4ffbd3efac8p-1, +0x1.818504103fa16p-56, +-0x1p-1, +-0x1.734d63dedb48ap-5, +-0x1.ad2bc9e21d511p-1, +0x1.47fbe07bea548p-55, +-0x1p-1, +-0x1.5e36e4dbe2bc2p-5, +-0x1.ae068f345ecefp-1, +0x1.33934c4029a4cp-56, +-0x1p-1, +-0x1.4915af336ceb4p-5, +-0x1.aee04b43c1474p-1, +0x1.3a79a438bf8ccp-55, +-0x1p-1, +-0x1.33e9cfee254edp-5, +-0x1.afb8fd89f57b6p-1, +-0x1.1ced12d2899b8p-60, +-0x1p-1, +-0x1.1eb3541b4b228p-5, +-0x1.b090a581502p-1, +0x1.926da300ffccep-55, +-0x1p-1, +-0x1.097248d0a956ap-5, +-0x1.b16742a4ca2f5p-1, +0x1.ba70972b80438p-55, +-0x1p-1, +-0x1.e84d76551cfb2p-6, +-0x1.b23cd470013b4p-1, +-0x1.5a1bb35ad6d2ep-56, +-0x1p-1, +-0x1.bda17097896b4p-6, +-0x1.b3115a5f37bf3p-1, +-0x1.dde2726e34fe1p-55, +-0x1p-1, +-0x1.92e09abb131d4p-6, +-0x1.b3e4d3ef55712p-1, +0x1.eb6b8bf11a493p-55, +-0x1p-1, +-0x1.680b0f1f0bd73p-6, +-0x1.b4b7409de7925p-1, +-0x1.f4e257bde73d8p-56, +-0x1p-1, +-0x1.3d20e82f8bc1p-6, +-0x1.b5889fe921405p-1, +0x1.df49b307c8602p-57, +-0x1p-1, +-0x1.1222406561182p-6, +-0x1.b658f14fdbc47p-1, +-0x1.52b5308f397dep-57, +-0x1p-1, +-0x1.ce1e648bffb66p-7, +-0x1.b728345196e3ep-1, +0x1.bc69f324e6d61p-55, +-0x1p-1, +-0x1.77cfb0c6e2db8p-7, +-0x1.b7f6686e792e9p-1, +-0x1.87665bfea06aap-55, +-0x1p-1, +-0x1.21589ab88869cp-7, +-0x1.b8c38d27504e9p-1, +0x1.1529abff40e45p-55, +-0x1p-1, +-0x1.9572af6decac8p-8, +-0x1.b98fa1fd9155ep-1, +-0x1.5559034fe85a4p-55, +-0x1p-1, +-0x1.cfc874c3eb6d9p-9, +-0x1.ba5aa673590d2p-1, +-0x1.7ea4e370753b6p-55, +-0x1p-1, +-0x1.d0320ae0b8293p-11, +-0x1.bb249a0b6c40dp-1, +0x1.d6318ee919f7ap-58, +-0x1p-1, +0x1.d09b418edf04ap-10, +-0x1.bbed7c49380eap-1, +-0x1.beacbd88500b4p-59, +-0x1p-1, +0x1.22a28f6cb488bp-8, +-0x1.bcb54cb0d2327p-1, +-0x1.410923c55523ep-62, +-0x1p-1, +0x1.d16c901d95181p-8, +-0x1.bd7c0ac6f952ap-1, +0x1.825a732ac700ap-55, +-0x1p-1, +0x1.4042335264ba3p-7, +-0x1.be41b611154c1p-1, +0x1.fdcdad3a6877ep-55, +-0x1p-1, +0x1.97f4d3805f318p-7, +-0x1.bf064e15377ddp-1, +-0x1.2156026a1e028p-57, +-0x1p-1, +0x1.efcdf2801004ap-7, +-0x1.bfc9d25a1b147p-1, +0x1.51bf4ee01357p-61, +-0x1p-1, +0x1.23e6ad10872a7p-6, +-0x1.c08c426725549p-1, +-0x1.b157fd80e2946p-58, +-0x1p-1, +0x1.4ff96a0da9dfbp-6, +-0x1.c14d9dc465e57p-1, +-0x1.ce36b64c7f3ccp-55, +-0x1p-1, +0x1.7c1f1507aeec3p-6, +-0x1.c20de3fa971bp-1, +0x1.b4ca2bab1322cp-55, +-0x1p-1, +0x1.a85792c327db2p-6, +-0x1.c2cd14931e3f1p-1, +-0x1.2ce2f9d4600f5p-56, +-0x1p-1, +0x1.d4a2c7f909c4ep-6, +-0x1.c38b2f180bdb1p-1, +0x1.6e0b1757c8d07p-56, +-0x1p-1, +0x1.00804cab5f113p-5, +-0x1.c44833141c004p-1, +-0x1.23e0521df01a2p-56, +-0x1p-1, +0x1.16b875bf19d4p-5, +-0x1.c5042012b6907p-1, +0x1.5c058dd8eaba5p-57, +-0x1p-1, +0x1.2cf9d182f7939p-5, +-0x1.c5bef59fef85ap-1, +0x1.f0a406c8b7468p-58, +-0x1p-1, +0x1.4344523c8e3b5p-5, +-0x1.c678b3488739bp-1, +-0x1.d86cac7c5ff5bp-57, +-0x1p-1, +0x1.5997ea2bcfb19p-5, +-0x1.c7315899eaad7p-1, +0x1.9be5dcd047da7p-57, +-0x1p-1, +0x1.6ff48b8b1252ap-5, +-0x1.c7e8e52233cf3p-1, +-0x1.b2ad324aa35c1p-57, +-0x1p-1, +0x1.865a288f196fap-5, +-0x1.c89f587029c13p-1, +-0x1.588358ed6e78fp-58, +-0x1p-1, +0x1.9cc8b3671dd0fp-5, +-0x1.c954b213411f5p-1, +0x1.2fb761e946603p-58, +-0x1p-1, +0x1.b3401e3cd63bbp-5, +-0x1.ca08f19b9c449p-1, +0x1.431e0a5a737fdp-56, +-0x1p-1, +0x1.c9c05b347ffabp-5, +-0x1.cabc169a0b9p-1, +-0x1.c42d3e10851d1p-55, +-0x1p-1, +0x1.e0495c6ce76b5p-5, +-0x1.cb6e20a00da99p-1, +0x1.4fb24b5194c1bp-55, +-0x1p-1, +0x1.f6db13ff708cbp-5, +-0x1.cc1f0f3fcfc5cp-1, +-0x1.e57613b68f6abp-56, +-0x1p-1, +0x1.06baba000fc9bp-4, +-0x1.cccee20c2deap-1, +0x1.d3116ae0e69e4p-55, +-0x1p-1, +0x1.120c373ed0bfbp-4, +-0x1.cd7d9898b32f6p-1, +0x1.f2fa062496738p-57, +-0x1p-1, +0x1.1d61fac0aa5b2p-4, +-0x1.ce2b32799a06p-1, +0x1.631d457e46317p-56, +-0x1p-1, +0x1.28bbfd87a8cffp-4, +-0x1.ced7af43cc773p-1, +0x1.e7b6bb5ab58aep-58, +-0x1p-1, +0x1.341a389339a36p-4, +-0x1.cf830e8ce467bp-1, +0x1.7b9202780d49dp-55, +-0x1p-1, +0x1.3f7ca4e02ffdcp-4, +-0x1.d02d4feb2bd92p-1, +-0x1.195ff41bc55fep-55, +-0x1p-1, +0x1.4ae33b68c8fdcp-4, +-0x1.d0d672f59d2b9p-1, +0x1.c83009f0c39dep-55, +-0x1p-1, +0x1.564df524b00dap-4, +-0x1.d17e7743e35dcp-1, +0x1.101da3540130ap-58, +-0x1p-1, +0x1.61bccb0903395p-4, +-0x1.d2255c6e5a4e1p-1, +0x1.d129a71ecafc9p-55, +-0x1p-1, +0x1.6d2fb6085786ep-4, +-0x1.d2cb220e0ef9fp-1, +0x1.f07656d4e6652p-56, +-0x1p-1, +0x1.78a6af12bd501p-4, +-0x1.d36fc7bcbfbdcp-1, +0x1.ba196d95a177dp-55, +-0x1p-1, +0x1.8421af15c49d7p-4, +-0x1.d4134d14dc93ap-1, +0x1.4ef5295d25af2p-55, +-0x1p-1, +0x1.8fa0aefc81837p-4, +-0x1.d4b5b1b187524p-1, +0x1.f56be6b42b76dp-57, +-0x1p-1, +0x1.9b23a7af90805p-4, +-0x1.d556f52e93eb1p-1, +0x1.80ed9233a963p-55, +-0x1p-1, +0x1.a6aa92151adc3p-4, +-0x1.d5f7172888a7fp-1, +0x1.68663e2225755p-55, +-0x1p-1, +0x1.b2356710db0a3p-4, +-0x1.d696173c9e68bp-1, +0x1.e8c61c6393d55p-56, +-0x1p-1, +0x1.bdc41f84210bbp-4, +-0x1.d733f508c0dffp-1, +0x1.007928e770cd5p-55, +-0x1p-1, +0x1.c956b44dd6d41p-4, +-0x1.d7d0b02b8ecf9p-1, +-0x1.800f4ce65cd6ep-55, +-0x1p-1, +0x1.d4ed1e4a84aefp-4, +-0x1.d86c48445a44fp-1, +-0x1.e8813c023d71fp-55, +-0x1p-1, +0x1.e087565455a75p-4, +-0x1.d906bcf328d46p-1, +-0x1.457e610231ac2p-56, +-0x1p-1, +0x1.ec2555431bf03p-4, +-0x1.d9a00dd8b3d46p-1, +-0x1.bea0e4bac8e16p-58, +-0x1p-1, +0x1.f7c713ec554fp-4, +-0x1.da383a9668988p-1, +0x1.5811000b39d84p-55, +-0x1p-1, +0x1.01b6459197c38p-3, +-0x1.dacf42ce68ab9p-1, +0x1.fe8d76efdf896p-56, +-0x1p-1, +0x1.078ad9dc46632p-3, +-0x1.db6526238a09bp-1, +0x1.adee7eae6946p-56, +-0x1p-1, +0x1.0d61433d840a4p-3, +-0x1.dbf9e4395759ap-1, +-0x1.d8ff7350f75fdp-55, +-0x1p-1, +0x1.13397e1b7ce13p-3, +-0x1.dc8d7cb41026p-1, +-0x1.6b7872773830dp-56, +-0x1p-1, +0x1.191386db3dedcp-3, +-0x1.dd1fef38a915ap-1, +0x1.782f169e17f3bp-55, +-0x1p-1, +0x1.1eef59e0b74c3p-3, +-0x1.ddb13b6ccc23cp-1, +-0x1.83c37c6107db3p-55, +-0x1p-1, +0x1.24ccf38ebe694p-3, +-0x1.de4160f6d8d81p-1, +-0x1.9bf11cc5f8776p-55, +-0x1p-1, +0x1.2aac5047103d3p-3, +-0x1.ded05f7de47dap-1, +0x1.2cc4c1f8ba966p-55, +-0x1p-1, +-0x1.9ee5272b58f2ap-4, +-0x1.df5e36a9ba59cp-1, +0x1.e01f8bceb43d3p-57, +-0x1p-2, +-0x1.931f774fc9f18p-4, +-0x1.dfeae622dbe2bp-1, +0x1.514ea88425567p-55, +-0x1p-2, +-0x1.875657223080ap-4, +-0x1.e0766d9280f54p-1, +-0x1.f44c969cf62e3p-55, +-0x1p-2, +-0x1.7b89cde7a9a4dp-4, +-0x1.e100cca2980acp-1, +0x1.02d182acdf825p-57, +-0x1p-2, +-0x1.6fb9e2e76ced8p-4, +-0x1.e18a02fdc66d9p-1, +-0x1.07e272abd88cfp-55, +-0x1p-2, +-0x1.63e69d6ac7f74p-4, +-0x1.e212104f686e5p-1, +0x1.014c76c126527p-55, +-0x1p-2, +-0x1.581004bd19ed2p-4, +-0x1.e298f4439197ap-1, +-0x1.e84e601038eb2p-57, +-0x1p-2, +-0x1.4c36202bcf08ep-4, +-0x1.e31eae870ce25p-1, +0x1.bc7094538d678p-56, +-0x1p-2, +-0x1.4058f7065c11ep-4, +-0x1.e3a33ec75ce85p-1, +-0x1.45089cd46bbb8p-57, +-0x1p-2, +-0x1.3478909e39da9p-4, +-0x1.e426a4b2bc17ep-1, +-0x1.a873889744882p-55, +-0x1p-2, +-0x1.2894f446e0bccp-4, +-0x1.e4a8dff81ce5ep-1, +-0x1.43578776c0f46p-55, +-0x1p-2, +-0x1.1cae2955c414fp-4, +-0x1.e529f04729ffcp-1, +-0x1.9075d6e6dfc8bp-55, +-0x1p-2, +-0x1.10c437224dbc2p-4, +-0x1.e5a9d550467d3p-1, +-0x1.7d431be53f92fp-56, +-0x1p-2, +-0x1.04d72505d9805p-4, +-0x1.e6288ec48e112p-1, +0x1.16b56f2847754p-57, +-0x1p-2, +-0x1.f1cdf4b76138bp-5, +-0x1.e6a61c55d53a7p-1, +-0x1.660d981acdcf7p-56, +-0x1p-2, +-0x1.d9e77d020a5bcp-5, +-0x1.e7227db6a9744p-1, +-0x1.2128794da5a5p-55, +-0x1p-2, +-0x1.c1faf1a9db555p-5, +-0x1.e79db29a5165ap-1, +0x1.75e710aca58p-56, +-0x1p-2, +-0x1.aa086170c0a8ep-5, +-0x1.e817bab4cd10dp-1, +0x1.d0afe686b5e0ap-56, +-0x1p-2, +-0x1.920fdb1c5d578p-5, +-0x1.e89095bad6025p-1, +0x1.5a4cc0fcbccap-55, +-0x1p-2, +-0x1.7a116d7601c35p-5, +-0x1.e9084361df7f2p-1, +-0x1.cdfc7ce9dc3e9p-55, +-0x1p-2, +-0x1.620d274aa2903p-5, +-0x1.e97ec36016b3p-1, +-0x1.5bc48562557d3p-55, +-0x1p-2, +-0x1.4a03176acf82dp-5, +-0x1.e9f4156c62ddap-1, +-0x1.760b1e2e3f81ep-55, +-0x1p-2, +-0x1.31f34caaaa5d2p-5, +-0x1.ea68393e658p-1, +0x1.467259bb7b556p-56, +-0x1p-2, +-0x1.19ddd5e1ddb8bp-5, +-0x1.eadb2e8e7a88ep-1, +0x1.92ec52ea226a3p-55, +-0x1p-2, +-0x1.01c2c1eb93deep-5, +-0x1.eb4cf515b8811p-1, +-0x1.95da1ba97ec5ep-57, +-0x1p-2, +-0x1.d3443f4cdb3ddp-6, +-0x1.ebbd8c8df0b74p-1, +-0x1.c6c8c615e7277p-56, +-0x1p-2, +-0x1.a2f7fbe8f2436p-6, +-0x1.ec2cf4b1af6b2p-1, +-0x1.34ee3f2caa62dp-59, +-0x1p-2, +-0x1.72a0d77651772p-6, +-0x1.ec9b2d3c3bf84p-1, +-0x1.19119d358de05p-56, +-0x1p-2, +-0x1.423eefc693785p-6, +-0x1.ed0835e999009p-1, +-0x1.499d188aa32fap-57, +-0x1p-2, +-0x1.11d262b1f6776p-6, +-0x1.ed740e7684963p-1, +-0x1.e82c791f59cc2p-56, +-0x1p-2, +-0x1.c2b69c2e939b5p-7, +-0x1.eddeb6a078651p-1, +0x1.3b579af740a74p-55, +-0x1p-2, +-0x1.61b39fb7b7202p-7, +-0x1.ee482e25a9dbcp-1, +0x1.b6066ef81af2ap-56, +-0x1p-2, +-0x1.009c0bd6cc3cbp-7, +-0x1.eeb074c50a544p-1, +-0x1.d925f656c43b4p-55, +-0x1p-2, +-0x1.3ee038dff6b8p-8, +-0x1.ef178a3e473c2p-1, +-0x1.6310a67fe774fp-55, +-0x1p-2, +-0x1.f1806b9fdd1afp-10, +-0x1.ef7d6e51ca3cp-1, +0x1.a3c67c3d3f604p-55, +-0x1p-2, +0x1.191f2900903a6p-10, +-0x1.efe220c0b95ecp-1, +-0x1.c853b7bf7e0cdp-55, +-0x1p-2, +0x1.0916fe858ffcdp-8, +-0x1.f045a14cf738cp-1, +0x1.a52c44f45216cp-55, +-0x1p-2, +0x1.cc0d09bd41caap-8, +-0x1.f0a7efb9230d7p-1, +-0x1.52c7adc6b4989p-56, +-0x1p-2, +0x1.4794b9d21cb87p-7, +-0x1.f1090bc898f5fp-1, +0x1.baa64ab102a93p-55, +-0x1p-2, +0x1.a935e1efe5e4bp-7, +-0x1.f168f53f7205dp-1, +0x1.26a6c1f015601p-57, +-0x1p-2, +0x1.0574e07f7b332p-6, +-0x1.f1c7abe284708p-1, +-0x1.504b80c8a63fcp-55, +-0x1p-2, +0x1.36580d5d5e775p-6, +-0x1.f2252f7763adap-1, +0x1.20cb81c8d94abp-55, +-0x1p-2, +0x1.67445969a108ep-6, +-0x1.f2817fc4609cep-1, +0x1.dd1f8eaf65689p-55, +-0x1p-2, +0x1.9839a676a6bcfp-6, +-0x1.f2dc9c9089a9dp-1, +-0x1.5407460bdfc07p-59, +-0x1p-2, +0x1.c937d65145919p-6, +-0x1.f33685a3aaefp-1, +-0x1.eb78685d850f8p-56, +-0x1p-2, +0x1.fa3ecac0d84e8p-6, +-0x1.f38f3ac64e589p-1, +0x1.d7bafb51f72e6p-56, +-0x1p-2, +0x1.15a732c3a894dp-5, +-0x1.f3e6bbc1bbc65p-1, +-0x1.5774bb7e8a21ep-57, +-0x1p-2, +0x1.2e334430a6376p-5, +-0x1.f43d085ff92ddp-1, +0x1.8fde71e361c05p-55, +-0x1p-2, +0x1.46c38a8311952p-5, +-0x1.f492206bcabb4p-1, +-0x1.d1e921bbe3bd3p-55, +-0x1p-2, +0x1.5f57f693feebep-5, +-0x1.f4e603b0b2f2dp-1, +0x1.8ee01e695ac05p-56, +-0x1p-2, +0x1.77f07939f3897p-5, +-0x1.f538b1faf2d07p-1, +0x1.5f7cd5099519cp-59, +-0x1p-2, +0x1.908d0348ef266p-5, +-0x1.f58a2b1789e84p-1, +-0x1.1f4a188aa368p-56, +-0x1p-2, +0x1.a92d859275418p-5, +-0x1.f5da6ed43685dp-1, +0x1.536fc33bf9dd8p-55, +-0x1p-2, +0x1.c1d1f0e5967d5p-5, +-0x1.f6297cff75cbp-1, +-0x1.562172a361fd3p-56, +-0x1p-2, +0x1.da7a360ef9fefp-5, +-0x1.f677556883ceep-1, +-0x1.ef696a8d070f4p-57, +-0x1p-2, +0x1.f32645d8e6ce9p-5, +-0x1.f6c3f7df5bbb7p-1, +-0x1.8561ce9d5ef5bp-56, +-0x1p-2, +0x1.05eb0885a69c9p-4, +-0x1.f70f6434b7eb7p-1, +-0x1.1775df66f0ec4p-56, +-0x1p-2, +0x1.1244c435e819dp-4, +-0x1.f7599a3a12077p-1, +-0x1.84f31d743195cp-55, +-0x1p-2, +0x1.1ea04e5ee7601p-4, +-0x1.f7a299c1a322ap-1, +-0x1.6e7190c94899ep-56, +-0x1p-2, +0x1.2afd9f6136a9cp-4, +-0x1.f7ea629e63d6ep-1, +-0x1.ba92d57ebfeddp-55, +-0x1p-2, +-0x1.9146a0c760c35p-5, +-0x1.f830f4a40c60cp-1, +-0x1.8528676925128p-57, +-0x1p-3, +-0x1.78851122cff19p-5, +-0x1.f8764fa714ba9p-1, +-0x1.ab256778ffcb6p-56, +-0x1p-3, +-0x1.5fc0219532f79p-5, +-0x1.f8ba737cb4b78p-1, +0x1.da71f96d5a49cp-55, +-0x1p-3, +-0x1.46f7e165f17c8p-5, +-0x1.f8fd5ffae41dbp-1, +0x1.8cfd77fd970d2p-56, +-0x1p-3, +-0x1.2e2c5fde7ea22p-5, +-0x1.f93f14f85ac08p-1, +0x1.cfd153e9a9c1ap-55, +-0x1p-3, +-0x1.155dac4a4f967p-5, +-0x1.f97f924c9099bp-1, +0x1.e2ae0eea5963bp-55, +-0x1p-3, +-0x1.f917abeda4499p-6, +-0x1.f9bed7cfbde29p-1, +0x1.b35b1f9bcf70bp-56, +-0x1p-3, +-0x1.c76dd866c689ep-6, +-0x1.f9fce55adb2c8p-1, +-0x1.f2a06fab9f9d1p-56, +-0x1p-3, +-0x1.95bdfca28b53ap-6, +-0x1.fa39bac7a1791p-1, +0x1.94f388f1b4e1ep-57, +-0x1p-3, +-0x1.64083747309d1p-6, +-0x1.fa7557f08a517p-1, +0x1.7a0a8ca13571fp-55, +-0x1p-3, +-0x1.324ca6fe9a04bp-6, +-0x1.faafbcb0cfddcp-1, +0x1.e349cb4d3e866p-55, +-0x1p-3, +-0x1.008b6a763de76p-6, +-0x1.fae8e8e46cfbbp-1, +0x1.3a9e414732d97p-56, +-0x1p-3, +-0x1.9d8940be24e74p-7, +-0x1.fb20dc681d54dp-1, +0x1.ff148ec7c5fafp-55, +-0x1p-3, +-0x1.39f0cedaf576bp-7, +-0x1.fb5797195d741p-1, +-0x1.1bfac7397cc08p-56, +-0x1p-3, +-0x1.ac9b7964cf0bap-8, +-0x1.fb8d18d66adb7p-1, +0x1.d0b66224cce2ep-56, +-0x1p-3, +-0x1.ca811eea0c749p-9, +-0x1.fbc1617e44186p-1, +0x1.58ec496dc4ecbp-59, +-0x1p-3, +-0x1.dd15adf70b65ap-12, +-0x1.fbf470f0a8d88p-1, +0x1.6bb200d1d70b7p-55, +-0x1p-3, +0x1.536352ad19e39p-9, +-0x1.fc26470e19fd3p-1, +-0x1.1ec8668ecaceep-55, +-0x1p-3, +0x1.7148021b55c15p-8, +-0x1.fc56e3b7d9af6p-1, +0x1.03ff7a673d3bdp-56, +-0x1p-3, +0x1.1c789a28b01b7p-7, +-0x1.fc8646cfeb721p-1, +-0x1.3143dc43a9b9dp-55, +-0x1p-3, +0x1.80566267c11f6p-7, +-0x1.fcb4703914354p-1, +-0x1.126aa7d51b25cp-55, +-0x1p-3, +0x1.e43d1c309e958p-7, +-0x1.fce15fd6da67bp-1, +0x1.5dd6f830d4c09p-56, +-0x1p-3, +0x1.241644f1c26cep-6, +-0x1.fd0d158d86087p-1, +-0x1.9705a7b864883p-55, +-0x1p-3, +0x1.561236eda8ff2p-6, +-0x1.fd37914220b84p-1, +-0x1.52e9d7b772791p-55, +-0x1p-3, +0x1.88124536d5e8fp-6, +-0x1.fd60d2da75c9ep-1, +-0x1.36dedb314f0ebp-58, +-0x1p-3, +0x1.ba1650f592f5p-6, +-0x1.fd88da3d12526p-1, +0x1.87df6378811c7p-55, +-0x1p-3, +0x1.ec1e3b4fb3d7ep-6, +-0x1.fdafa7514538cp-1, +-0x1.d97c45ca4d398p-59, +-0x1p-3, +0x1.0f14f2b4549bdp-5, +-0x1.fdd539ff1f456p-1, +0x1.ab13cbbec1781p-56, +-0x1p-3, +0x1.281c9830c9dafp-5, +-0x1.fdf9922f73307p-1, +-0x1.a5e0abd3a9b65p-56, +-0x1p-3, +-0x1.7db402a6a9063p-6, +-0x1.fe1cafcbd5b09p-1, +-0x1.a23e3202a884ep-57, +-0x1p-4, +-0x1.4b9dd29353428p-6, +-0x1.fe3e92be9d886p-1, +-0x1.afeb2e264d46bp-57, +-0x1p-4, +-0x1.19845e49c8257p-6, +-0x1.fe5f3af2e394p-1, +-0x1.b213f18c9cf17p-55, +-0x1p-4, +-0x1.cecf8962d14c8p-7, +-0x1.fe7ea85482d6p-1, +-0x1.34b085c1828f7p-56, +-0x1p-4, +-0x1.6a9049670cfaep-7, +-0x1.fe9cdad01883ap-1, +-0x1.521ecd0c67e35p-57, +-0x1p-4, +-0x1.064b3a76a2264p-7, +-0x1.feb9d2530410fp-1, +-0x1.9d429eeda9bb9p-58, +-0x1p-4, +-0x1.440134d709b28p-8, +-0x1.fed58ecb673c4p-1, +0x1.e6e462a7ae686p-56, +-0x1p-4, +-0x1.ed853918c18ecp-10, +-0x1.fef0102826191p-1, +-0x1.3c3ea4f30addap-56, +-0x1p-4, +0x1.35230c0fbe402p-10, +-0x1.ff095658e71adp-1, +-0x1.01a8ce18a4b9ep-55, +-0x1p-4, +0x1.15fc833fb89b8p-8, +-0x1.ff21614e131edp-1, +0x1.de692a167353p-55, +-0x1p-4, +0x1.deb9769f940eap-8, +-0x1.ff3830f8d575cp-1, +0x1.95e1e79d335f7p-56, +-0x1p-4, +0x1.53bf90a81f3a5p-7, +-0x1.ff4dc54b1bed3p-1, +0x1.c1169ccd1e92ep-55, +-0x1p-4, +0x1.b82683bc89fbp-7, +-0x1.ff621e3796d7ep-1, +0x1.c57bc2e24aa15p-57, +-0x1p-4, +0x1.0e48ab4f172f4p-6, +-0x1.ff753bb1b9164p-1, +0x1.7c330129f56efp-56, +-0x1p-4, +-0x1.7f0034a43350ep-7, +-0x1.ff871dadb81dfp-1, +-0x1.8b1c676208aa4p-56, +-0x1p-5, +-0x1.1a8e5bfe185e4p-7, +-0x1.ff97c4208c014p-1, +-0x1.52ab2b947e843p-57, +-0x1p-5, +-0x1.6c32baca2ae69p-8, +-0x1.ffa72effef75dp-1, +0x1.8b4cdcdb25956p-55, +-0x1p-5, +-0x1.4685db42c17ebp-9, +-0x1.ffb55e425fdaep-1, +-0x1.6da7ec781c225p-55, +-0x1p-5, +0x1.2d919c5c61fep-11, +-0x1.ffc251df1d3f8p-1, +-0x1.7a7d209f32d43p-56, +-0x1p-5, +0x1.dd58598d6271cp-9, +-0x1.ffce09ce2a679p-1, +0x1.7bd62ab5ee228p-55, +-0x1p-5, +0x1.b7aa821726608p-8, +-0x1.ffd886084cd0dp-1, +0x1.1354d4556e4cbp-55, +-0x1p-5, +-0x1.7f53487eac897p-8, +-0x1.ffe1c6870cb77p-1, +-0x1.89aa14768323ep-55, +-0x1p-6, +-0x1.6c9b5df1877eap-9, +-0x1.ffe9cb44b51a1p-1, +-0x1.5b43366df667p-56, +-0x1p-6, +0x1.2bad2a8cd06bp-12, +-0x1.fff0943c53bd1p-1, +0x1.47399f361d158p-55, +-0x1p-6, +0x1.b78b80c84e1eep-9, +-0x1.fff62169b92dbp-1, +-0x1.5dda3c81fbd0dp-55, +-0x1p-6, +-0x1.6cb587284b817p-10, +-0x1.fffa72c978c4fp-1, +0x1.22cb000328f91p-55, +-0x1p-7, +0x1.b783c0663fe3cp-10, +-0x1.fffd8858e8a92p-1, +-0x1.359c71883bcf7p-55, +-0x1p-7, +0x1.b781d04cd6d17p-11, +-0x1.ffff621621d02p-1, +0x1.6acfcebc82813p-56, +-0x1p-8, +0, +-0x1p0, +0, +0, +-0x1.b781d04cd6d17p-11, +-0x1.ffff621621d02p-1, +0x1.6acfcebc82813p-56, +0x1p-8, +-0x1.b783c0663fe3cp-10, +-0x1.fffd8858e8a92p-1, +-0x1.359c71883bcf7p-55, +0x1p-7, +0x1.6cb587284b817p-10, +-0x1.fffa72c978c4fp-1, +0x1.22cb000328f91p-55, +0x1p-7, +-0x1.b78b80c84e1eep-9, +-0x1.fff62169b92dbp-1, +-0x1.5dda3c81fbd0dp-55, +0x1p-6, +-0x1.2bad2a8cd06bp-12, +-0x1.fff0943c53bd1p-1, +0x1.47399f361d158p-55, +0x1p-6, +0x1.6c9b5df1877eap-9, +-0x1.ffe9cb44b51a1p-1, +-0x1.5b43366df667p-56, +0x1p-6, +0x1.7f53487eac897p-8, +-0x1.ffe1c6870cb77p-1, +-0x1.89aa14768323ep-55, +0x1p-6, +-0x1.b7aa821726608p-8, +-0x1.ffd886084cd0dp-1, +0x1.1354d4556e4cbp-55, +0x1p-5, +-0x1.dd58598d6271cp-9, +-0x1.ffce09ce2a679p-1, +0x1.7bd62ab5ee228p-55, +0x1p-5, +-0x1.2d919c5c61fep-11, +-0x1.ffc251df1d3f8p-1, +-0x1.7a7d209f32d43p-56, +0x1p-5, +0x1.4685db42c17ebp-9, +-0x1.ffb55e425fdaep-1, +-0x1.6da7ec781c225p-55, +0x1p-5, +0x1.6c32baca2ae69p-8, +-0x1.ffa72effef75dp-1, +0x1.8b4cdcdb25956p-55, +0x1p-5, +0x1.1a8e5bfe185e4p-7, +-0x1.ff97c4208c014p-1, +-0x1.52ab2b947e843p-57, +0x1p-5, +0x1.7f0034a43350ep-7, +-0x1.ff871dadb81dfp-1, +-0x1.8b1c676208aa4p-56, +0x1p-5, +-0x1.0e48ab4f172f4p-6, +-0x1.ff753bb1b9164p-1, +0x1.7c330129f56efp-56, +0x1p-4, +-0x1.b82683bc89fbp-7, +-0x1.ff621e3796d7ep-1, +0x1.c57bc2e24aa15p-57, +0x1p-4, +-0x1.53bf90a81f3a5p-7, +-0x1.ff4dc54b1bed3p-1, +0x1.c1169ccd1e92ep-55, +0x1p-4, +-0x1.deb9769f940eap-8, +-0x1.ff3830f8d575cp-1, +0x1.95e1e79d335f7p-56, +0x1p-4, +-0x1.15fc833fb89b8p-8, +-0x1.ff21614e131edp-1, +0x1.de692a167353p-55, +0x1p-4, +-0x1.35230c0fbe402p-10, +-0x1.ff095658e71adp-1, +-0x1.01a8ce18a4b9ep-55, +0x1p-4, +0x1.ed853918c18ecp-10, +-0x1.fef0102826191p-1, +-0x1.3c3ea4f30addap-56, +0x1p-4, +0x1.440134d709b28p-8, +-0x1.fed58ecb673c4p-1, +0x1.e6e462a7ae686p-56, +0x1p-4, +0x1.064b3a76a2264p-7, +-0x1.feb9d2530410fp-1, +-0x1.9d429eeda9bb9p-58, +0x1p-4, +0x1.6a9049670cfaep-7, +-0x1.fe9cdad01883ap-1, +-0x1.521ecd0c67e35p-57, +0x1p-4, +0x1.cecf8962d14c8p-7, +-0x1.fe7ea85482d6p-1, +-0x1.34b085c1828f7p-56, +0x1p-4, +0x1.19845e49c8257p-6, +-0x1.fe5f3af2e394p-1, +-0x1.b213f18c9cf17p-55, +0x1p-4, +0x1.4b9dd29353428p-6, +-0x1.fe3e92be9d886p-1, +-0x1.afeb2e264d46bp-57, +0x1p-4, +0x1.7db402a6a9063p-6, +-0x1.fe1cafcbd5b09p-1, +-0x1.a23e3202a884ep-57, +0x1p-4, +-0x1.281c9830c9dafp-5, +-0x1.fdf9922f73307p-1, +-0x1.a5e0abd3a9b65p-56, +0x1p-3, +-0x1.0f14f2b4549bdp-5, +-0x1.fdd539ff1f456p-1, +0x1.ab13cbbec1781p-56, +0x1p-3, +-0x1.ec1e3b4fb3d7ep-6, +-0x1.fdafa7514538cp-1, +-0x1.d97c45ca4d398p-59, +0x1p-3, +-0x1.ba1650f592f5p-6, +-0x1.fd88da3d12526p-1, +0x1.87df6378811c7p-55, +0x1p-3, +-0x1.88124536d5e8fp-6, +-0x1.fd60d2da75c9ep-1, +-0x1.36dedb314f0ebp-58, +0x1p-3, +-0x1.561236eda8ff2p-6, +-0x1.fd37914220b84p-1, +-0x1.52e9d7b772791p-55, +0x1p-3, +-0x1.241644f1c26cep-6, +-0x1.fd0d158d86087p-1, +-0x1.9705a7b864883p-55, +0x1p-3, +-0x1.e43d1c309e958p-7, +-0x1.fce15fd6da67bp-1, +0x1.5dd6f830d4c09p-56, +0x1p-3, +-0x1.80566267c11f6p-7, +-0x1.fcb4703914354p-1, +-0x1.126aa7d51b25cp-55, +0x1p-3, +-0x1.1c789a28b01b7p-7, +-0x1.fc8646cfeb721p-1, +-0x1.3143dc43a9b9dp-55, +0x1p-3, +-0x1.7148021b55c15p-8, +-0x1.fc56e3b7d9af6p-1, +0x1.03ff7a673d3bdp-56, +0x1p-3, +-0x1.536352ad19e39p-9, +-0x1.fc26470e19fd3p-1, +-0x1.1ec8668ecaceep-55, +0x1p-3, +0x1.dd15adf70b65ap-12, +-0x1.fbf470f0a8d88p-1, +0x1.6bb200d1d70b7p-55, +0x1p-3, +0x1.ca811eea0c749p-9, +-0x1.fbc1617e44186p-1, +0x1.58ec496dc4ecbp-59, +0x1p-3, +0x1.ac9b7964cf0bap-8, +-0x1.fb8d18d66adb7p-1, +0x1.d0b66224cce2ep-56, +0x1p-3, +0x1.39f0cedaf576bp-7, +-0x1.fb5797195d741p-1, +-0x1.1bfac7397cc08p-56, +0x1p-3, +0x1.9d8940be24e74p-7, +-0x1.fb20dc681d54dp-1, +0x1.ff148ec7c5fafp-55, +0x1p-3, +0x1.008b6a763de76p-6, +-0x1.fae8e8e46cfbbp-1, +0x1.3a9e414732d97p-56, +0x1p-3, +0x1.324ca6fe9a04bp-6, +-0x1.faafbcb0cfddcp-1, +0x1.e349cb4d3e866p-55, +0x1p-3, +0x1.64083747309d1p-6, +-0x1.fa7557f08a517p-1, +0x1.7a0a8ca13571fp-55, +0x1p-3, +0x1.95bdfca28b53ap-6, +-0x1.fa39bac7a1791p-1, +0x1.94f388f1b4e1ep-57, +0x1p-3, +0x1.c76dd866c689ep-6, +-0x1.f9fce55adb2c8p-1, +-0x1.f2a06fab9f9d1p-56, +0x1p-3, +0x1.f917abeda4499p-6, +-0x1.f9bed7cfbde29p-1, +0x1.b35b1f9bcf70bp-56, +0x1p-3, +0x1.155dac4a4f967p-5, +-0x1.f97f924c9099bp-1, +0x1.e2ae0eea5963bp-55, +0x1p-3, +0x1.2e2c5fde7ea22p-5, +-0x1.f93f14f85ac08p-1, +0x1.cfd153e9a9c1ap-55, +0x1p-3, +0x1.46f7e165f17c8p-5, +-0x1.f8fd5ffae41dbp-1, +0x1.8cfd77fd970d2p-56, +0x1p-3, +0x1.5fc0219532f79p-5, +-0x1.f8ba737cb4b78p-1, +0x1.da71f96d5a49cp-55, +0x1p-3, +0x1.78851122cff19p-5, +-0x1.f8764fa714ba9p-1, +-0x1.ab256778ffcb6p-56, +0x1p-3, +0x1.9146a0c760c35p-5, +-0x1.f830f4a40c60cp-1, +-0x1.8528676925128p-57, +0x1p-3, +-0x1.2afd9f6136a9cp-4, +-0x1.f7ea629e63d6ep-1, +-0x1.ba92d57ebfeddp-55, +0x1p-2, +-0x1.1ea04e5ee7601p-4, +-0x1.f7a299c1a322ap-1, +-0x1.6e7190c94899ep-56, +0x1p-2, +-0x1.1244c435e819dp-4, +-0x1.f7599a3a12077p-1, +-0x1.84f31d743195cp-55, +0x1p-2, +-0x1.05eb0885a69c9p-4, +-0x1.f70f6434b7eb7p-1, +-0x1.1775df66f0ec4p-56, +0x1p-2, +-0x1.f32645d8e6ce9p-5, +-0x1.f6c3f7df5bbb7p-1, +-0x1.8561ce9d5ef5bp-56, +0x1p-2, +-0x1.da7a360ef9fefp-5, +-0x1.f677556883ceep-1, +-0x1.ef696a8d070f4p-57, +0x1p-2, +-0x1.c1d1f0e5967d5p-5, +-0x1.f6297cff75cbp-1, +-0x1.562172a361fd3p-56, +0x1p-2, +-0x1.a92d859275418p-5, +-0x1.f5da6ed43685dp-1, +0x1.536fc33bf9dd8p-55, +0x1p-2, +-0x1.908d0348ef266p-5, +-0x1.f58a2b1789e84p-1, +-0x1.1f4a188aa368p-56, +0x1p-2, +-0x1.77f07939f3897p-5, +-0x1.f538b1faf2d07p-1, +0x1.5f7cd5099519cp-59, +0x1p-2, +-0x1.5f57f693feebep-5, +-0x1.f4e603b0b2f2dp-1, +0x1.8ee01e695ac05p-56, +0x1p-2, +-0x1.46c38a8311952p-5, +-0x1.f492206bcabb4p-1, +-0x1.d1e921bbe3bd3p-55, +0x1p-2, +-0x1.2e334430a6376p-5, +-0x1.f43d085ff92ddp-1, +0x1.8fde71e361c05p-55, +0x1p-2, +-0x1.15a732c3a894dp-5, +-0x1.f3e6bbc1bbc65p-1, +-0x1.5774bb7e8a21ep-57, +0x1p-2, +-0x1.fa3ecac0d84e8p-6, +-0x1.f38f3ac64e589p-1, +0x1.d7bafb51f72e6p-56, +0x1p-2, +-0x1.c937d65145919p-6, +-0x1.f33685a3aaefp-1, +-0x1.eb78685d850f8p-56, +0x1p-2, +-0x1.9839a676a6bcfp-6, +-0x1.f2dc9c9089a9dp-1, +-0x1.5407460bdfc07p-59, +0x1p-2, +-0x1.67445969a108ep-6, +-0x1.f2817fc4609cep-1, +0x1.dd1f8eaf65689p-55, +0x1p-2, +-0x1.36580d5d5e775p-6, +-0x1.f2252f7763adap-1, +0x1.20cb81c8d94abp-55, +0x1p-2, +-0x1.0574e07f7b332p-6, +-0x1.f1c7abe284708p-1, +-0x1.504b80c8a63fcp-55, +0x1p-2, +-0x1.a935e1efe5e4bp-7, +-0x1.f168f53f7205dp-1, +0x1.26a6c1f015601p-57, +0x1p-2, +-0x1.4794b9d21cb87p-7, +-0x1.f1090bc898f5fp-1, +0x1.baa64ab102a93p-55, +0x1p-2, +-0x1.cc0d09bd41caap-8, +-0x1.f0a7efb9230d7p-1, +-0x1.52c7adc6b4989p-56, +0x1p-2, +-0x1.0916fe858ffcdp-8, +-0x1.f045a14cf738cp-1, +0x1.a52c44f45216cp-55, +0x1p-2, +-0x1.191f2900903a6p-10, +-0x1.efe220c0b95ecp-1, +-0x1.c853b7bf7e0cdp-55, +0x1p-2, +0x1.f1806b9fdd1afp-10, +-0x1.ef7d6e51ca3cp-1, +0x1.a3c67c3d3f604p-55, +0x1p-2, +0x1.3ee038dff6b8p-8, +-0x1.ef178a3e473c2p-1, +-0x1.6310a67fe774fp-55, +0x1p-2, +0x1.009c0bd6cc3cbp-7, +-0x1.eeb074c50a544p-1, +-0x1.d925f656c43b4p-55, +0x1p-2, +0x1.61b39fb7b7202p-7, +-0x1.ee482e25a9dbcp-1, +0x1.b6066ef81af2ap-56, +0x1p-2, +0x1.c2b69c2e939b5p-7, +-0x1.eddeb6a078651p-1, +0x1.3b579af740a74p-55, +0x1p-2, +0x1.11d262b1f6776p-6, +-0x1.ed740e7684963p-1, +-0x1.e82c791f59cc2p-56, +0x1p-2, +0x1.423eefc693785p-6, +-0x1.ed0835e999009p-1, +-0x1.499d188aa32fap-57, +0x1p-2, +0x1.72a0d77651772p-6, +-0x1.ec9b2d3c3bf84p-1, +-0x1.19119d358de05p-56, +0x1p-2, +0x1.a2f7fbe8f2436p-6, +-0x1.ec2cf4b1af6b2p-1, +-0x1.34ee3f2caa62dp-59, +0x1p-2, +0x1.d3443f4cdb3ddp-6, +-0x1.ebbd8c8df0b74p-1, +-0x1.c6c8c615e7277p-56, +0x1p-2, +0x1.01c2c1eb93deep-5, +-0x1.eb4cf515b8811p-1, +-0x1.95da1ba97ec5ep-57, +0x1p-2, +0x1.19ddd5e1ddb8bp-5, +-0x1.eadb2e8e7a88ep-1, +0x1.92ec52ea226a3p-55, +0x1p-2, +0x1.31f34caaaa5d2p-5, +-0x1.ea68393e658p-1, +0x1.467259bb7b556p-56, +0x1p-2, +0x1.4a03176acf82dp-5, +-0x1.e9f4156c62ddap-1, +-0x1.760b1e2e3f81ep-55, +0x1p-2, +0x1.620d274aa2903p-5, +-0x1.e97ec36016b3p-1, +-0x1.5bc48562557d3p-55, +0x1p-2, +0x1.7a116d7601c35p-5, +-0x1.e9084361df7f2p-1, +-0x1.cdfc7ce9dc3e9p-55, +0x1p-2, +0x1.920fdb1c5d578p-5, +-0x1.e89095bad6025p-1, +0x1.5a4cc0fcbccap-55, +0x1p-2, +0x1.aa086170c0a8ep-5, +-0x1.e817bab4cd10dp-1, +0x1.d0afe686b5e0ap-56, +0x1p-2, +0x1.c1faf1a9db555p-5, +-0x1.e79db29a5165ap-1, +0x1.75e710aca58p-56, +0x1p-2, +0x1.d9e77d020a5bcp-5, +-0x1.e7227db6a9744p-1, +-0x1.2128794da5a5p-55, +0x1p-2, +0x1.f1cdf4b76138bp-5, +-0x1.e6a61c55d53a7p-1, +-0x1.660d981acdcf7p-56, +0x1p-2, +0x1.04d72505d9805p-4, +-0x1.e6288ec48e112p-1, +0x1.16b56f2847754p-57, +0x1p-2, +0x1.10c437224dbc2p-4, +-0x1.e5a9d550467d3p-1, +-0x1.7d431be53f92fp-56, +0x1p-2, +0x1.1cae2955c414fp-4, +-0x1.e529f04729ffcp-1, +-0x1.9075d6e6dfc8bp-55, +0x1p-2, +0x1.2894f446e0bccp-4, +-0x1.e4a8dff81ce5ep-1, +-0x1.43578776c0f46p-55, +0x1p-2, +0x1.3478909e39da9p-4, +-0x1.e426a4b2bc17ep-1, +-0x1.a873889744882p-55, +0x1p-2, +0x1.4058f7065c11ep-4, +-0x1.e3a33ec75ce85p-1, +-0x1.45089cd46bbb8p-57, +0x1p-2, +0x1.4c36202bcf08ep-4, +-0x1.e31eae870ce25p-1, +0x1.bc7094538d678p-56, +0x1p-2, +0x1.581004bd19ed2p-4, +-0x1.e298f4439197ap-1, +-0x1.e84e601038eb2p-57, +0x1p-2, +0x1.63e69d6ac7f74p-4, +-0x1.e212104f686e5p-1, +0x1.014c76c126527p-55, +0x1p-2, +0x1.6fb9e2e76ced8p-4, +-0x1.e18a02fdc66d9p-1, +-0x1.07e272abd88cfp-55, +0x1p-2, +0x1.7b89cde7a9a4dp-4, +-0x1.e100cca2980acp-1, +0x1.02d182acdf825p-57, +0x1p-2, +0x1.875657223080ap-4, +-0x1.e0766d9280f54p-1, +-0x1.f44c969cf62e3p-55, +0x1p-2, +0x1.931f774fc9f18p-4, +-0x1.dfeae622dbe2bp-1, +0x1.514ea88425567p-55, +0x1p-2, +0x1.9ee5272b58f2ap-4, +-0x1.df5e36a9ba59cp-1, +0x1.e01f8bceb43d3p-57, +0x1p-2, +-0x1.2aac5047103d3p-3, +-0x1.ded05f7de47dap-1, +0x1.2cc4c1f8ba966p-55, +0x1p-1, +-0x1.24ccf38ebe694p-3, +-0x1.de4160f6d8d81p-1, +-0x1.9bf11cc5f8776p-55, +0x1p-1, +-0x1.1eef59e0b74c3p-3, +-0x1.ddb13b6ccc23cp-1, +-0x1.83c37c6107db3p-55, +0x1p-1, +-0x1.191386db3dedcp-3, +-0x1.dd1fef38a915ap-1, +0x1.782f169e17f3bp-55, +0x1p-1, +-0x1.13397e1b7ce13p-3, +-0x1.dc8d7cb41026p-1, +-0x1.6b7872773830dp-56, +0x1p-1, +-0x1.0d61433d840a4p-3, +-0x1.dbf9e4395759ap-1, +-0x1.d8ff7350f75fdp-55, +0x1p-1, +-0x1.078ad9dc46632p-3, +-0x1.db6526238a09bp-1, +0x1.adee7eae6946p-56, +0x1p-1, +-0x1.01b6459197c38p-3, +-0x1.dacf42ce68ab9p-1, +0x1.fe8d76efdf896p-56, +0x1p-1, +-0x1.f7c713ec554fp-4, +-0x1.da383a9668988p-1, +0x1.5811000b39d84p-55, +0x1p-1, +-0x1.ec2555431bf03p-4, +-0x1.d9a00dd8b3d46p-1, +-0x1.bea0e4bac8e16p-58, +0x1p-1, +-0x1.e087565455a75p-4, +-0x1.d906bcf328d46p-1, +-0x1.457e610231ac2p-56, +0x1p-1, +-0x1.d4ed1e4a84aefp-4, +-0x1.d86c48445a44fp-1, +-0x1.e8813c023d71fp-55, +0x1p-1, +-0x1.c956b44dd6d41p-4, +-0x1.d7d0b02b8ecf9p-1, +-0x1.800f4ce65cd6ep-55, +0x1p-1, +-0x1.bdc41f84210bbp-4, +-0x1.d733f508c0dffp-1, +0x1.007928e770cd5p-55, +0x1p-1, +-0x1.b2356710db0a3p-4, +-0x1.d696173c9e68bp-1, +0x1.e8c61c6393d55p-56, +0x1p-1, +-0x1.a6aa92151adc3p-4, +-0x1.d5f7172888a7fp-1, +0x1.68663e2225755p-55, +0x1p-1, +-0x1.9b23a7af90805p-4, +-0x1.d556f52e93eb1p-1, +0x1.80ed9233a963p-55, +0x1p-1, +-0x1.8fa0aefc81837p-4, +-0x1.d4b5b1b187524p-1, +0x1.f56be6b42b76dp-57, +0x1p-1, +-0x1.8421af15c49d7p-4, +-0x1.d4134d14dc93ap-1, +0x1.4ef5295d25af2p-55, +0x1p-1, +-0x1.78a6af12bd501p-4, +-0x1.d36fc7bcbfbdcp-1, +0x1.ba196d95a177dp-55, +0x1p-1, +-0x1.6d2fb6085786ep-4, +-0x1.d2cb220e0ef9fp-1, +0x1.f07656d4e6652p-56, +0x1p-1, +-0x1.61bccb0903395p-4, +-0x1.d2255c6e5a4e1p-1, +0x1.d129a71ecafc9p-55, +0x1p-1, +-0x1.564df524b00dap-4, +-0x1.d17e7743e35dcp-1, +0x1.101da3540130ap-58, +0x1p-1, +-0x1.4ae33b68c8fdcp-4, +-0x1.d0d672f59d2b9p-1, +0x1.c83009f0c39dep-55, +0x1p-1, +-0x1.3f7ca4e02ffdcp-4, +-0x1.d02d4feb2bd92p-1, +-0x1.195ff41bc55fep-55, +0x1p-1, +-0x1.341a389339a36p-4, +-0x1.cf830e8ce467bp-1, +0x1.7b9202780d49dp-55, +0x1p-1, +-0x1.28bbfd87a8cffp-4, +-0x1.ced7af43cc773p-1, +0x1.e7b6bb5ab58aep-58, +0x1p-1, +-0x1.1d61fac0aa5b2p-4, +-0x1.ce2b32799a06p-1, +0x1.631d457e46317p-56, +0x1p-1, +-0x1.120c373ed0bfbp-4, +-0x1.cd7d9898b32f6p-1, +0x1.f2fa062496738p-57, +0x1p-1, +-0x1.06baba000fc9bp-4, +-0x1.cccee20c2deap-1, +0x1.d3116ae0e69e4p-55, +0x1p-1, +-0x1.f6db13ff708cbp-5, +-0x1.cc1f0f3fcfc5cp-1, +-0x1.e57613b68f6abp-56, +0x1p-1, +-0x1.e0495c6ce76b5p-5, +-0x1.cb6e20a00da99p-1, +0x1.4fb24b5194c1bp-55, +0x1p-1, +-0x1.c9c05b347ffabp-5, +-0x1.cabc169a0b9p-1, +-0x1.c42d3e10851d1p-55, +0x1p-1, +-0x1.b3401e3cd63bbp-5, +-0x1.ca08f19b9c449p-1, +0x1.431e0a5a737fdp-56, +0x1p-1, +-0x1.9cc8b3671dd0fp-5, +-0x1.c954b213411f5p-1, +0x1.2fb761e946603p-58, +0x1p-1, +-0x1.865a288f196fap-5, +-0x1.c89f587029c13p-1, +-0x1.588358ed6e78fp-58, +0x1p-1, +-0x1.6ff48b8b1252ap-5, +-0x1.c7e8e52233cf3p-1, +-0x1.b2ad324aa35c1p-57, +0x1p-1, +-0x1.5997ea2bcfb19p-5, +-0x1.c7315899eaad7p-1, +0x1.9be5dcd047da7p-57, +0x1p-1, +-0x1.4344523c8e3b5p-5, +-0x1.c678b3488739bp-1, +-0x1.d86cac7c5ff5bp-57, +0x1p-1, +-0x1.2cf9d182f7939p-5, +-0x1.c5bef59fef85ap-1, +0x1.f0a406c8b7468p-58, +0x1p-1, +-0x1.16b875bf19d4p-5, +-0x1.c5042012b6907p-1, +0x1.5c058dd8eaba5p-57, +0x1p-1, +-0x1.00804cab5f113p-5, +-0x1.c44833141c004p-1, +-0x1.23e0521df01a2p-56, +0x1p-1, +-0x1.d4a2c7f909c4ep-6, +-0x1.c38b2f180bdb1p-1, +0x1.6e0b1757c8d07p-56, +0x1p-1, +-0x1.a85792c327db2p-6, +-0x1.c2cd14931e3f1p-1, +-0x1.2ce2f9d4600f5p-56, +0x1p-1, +-0x1.7c1f1507aeec3p-6, +-0x1.c20de3fa971bp-1, +0x1.b4ca2bab1322cp-55, +0x1p-1, +-0x1.4ff96a0da9dfbp-6, +-0x1.c14d9dc465e57p-1, +-0x1.ce36b64c7f3ccp-55, +0x1p-1, +-0x1.23e6ad10872a7p-6, +-0x1.c08c426725549p-1, +-0x1.b157fd80e2946p-58, +0x1p-1, +-0x1.efcdf2801004ap-7, +-0x1.bfc9d25a1b147p-1, +0x1.51bf4ee01357p-61, +0x1p-1, +-0x1.97f4d3805f318p-7, +-0x1.bf064e15377ddp-1, +-0x1.2156026a1e028p-57, +0x1p-1, +-0x1.4042335264ba3p-7, +-0x1.be41b611154c1p-1, +0x1.fdcdad3a6877ep-55, +0x1p-1, +-0x1.d16c901d95181p-8, +-0x1.bd7c0ac6f952ap-1, +0x1.825a732ac700ap-55, +0x1p-1, +-0x1.22a28f6cb488bp-8, +-0x1.bcb54cb0d2327p-1, +-0x1.410923c55523ep-62, +0x1p-1, +-0x1.d09b418edf04ap-10, +-0x1.bbed7c49380eap-1, +-0x1.beacbd88500b4p-59, +0x1p-1, +0x1.d0320ae0b8293p-11, +-0x1.bb249a0b6c40dp-1, +0x1.d6318ee919f7ap-58, +0x1p-1, +0x1.cfc874c3eb6d9p-9, +-0x1.ba5aa673590d2p-1, +-0x1.7ea4e370753b6p-55, +0x1p-1, +0x1.9572af6decac8p-8, +-0x1.b98fa1fd9155ep-1, +-0x1.5559034fe85a4p-55, +0x1p-1, +0x1.21589ab88869cp-7, +-0x1.b8c38d27504e9p-1, +0x1.1529abff40e45p-55, +0x1p-1, +0x1.77cfb0c6e2db8p-7, +-0x1.b7f6686e792e9p-1, +-0x1.87665bfea06aap-55, +0x1p-1, +0x1.ce1e648bffb66p-7, +-0x1.b728345196e3ep-1, +0x1.bc69f324e6d61p-55, +0x1p-1, +0x1.1222406561182p-6, +-0x1.b658f14fdbc47p-1, +-0x1.52b5308f397dep-57, +0x1p-1, +0x1.3d20e82f8bc1p-6, +-0x1.b5889fe921405p-1, +0x1.df49b307c8602p-57, +0x1p-1, +0x1.680b0f1f0bd73p-6, +-0x1.b4b7409de7925p-1, +-0x1.f4e257bde73d8p-56, +0x1p-1, +0x1.92e09abb131d4p-6, +-0x1.b3e4d3ef55712p-1, +0x1.eb6b8bf11a493p-55, +0x1p-1, +0x1.bda17097896b4p-6, +-0x1.b3115a5f37bf3p-1, +-0x1.dde2726e34fe1p-55, +0x1p-1, +0x1.e84d76551cfb2p-6, +-0x1.b23cd470013b4p-1, +-0x1.5a1bb35ad6d2ep-56, +0x1p-1, +0x1.097248d0a956ap-5, +-0x1.b16742a4ca2f5p-1, +0x1.ba70972b80438p-55, +0x1p-1, +0x1.1eb3541b4b228p-5, +-0x1.b090a581502p-1, +0x1.926da300ffccep-55, +0x1p-1, +0x1.33e9cfee254edp-5, +-0x1.afb8fd89f57b6p-1, +-0x1.1ced12d2899b8p-60, +0x1p-1, +0x1.4915af336ceb4p-5, +-0x1.aee04b43c1474p-1, +0x1.3a79a438bf8ccp-55, +0x1p-1, +0x1.5e36e4dbe2bc2p-5, +-0x1.ae068f345ecefp-1, +0x1.33934c4029a4cp-56, +0x1p-1, +0x1.734d63dedb48ap-5, +-0x1.ad2bc9e21d511p-1, +0x1.47fbe07bea548p-55, +0x1p-1, +0x1.88591f3a46e4dp-5, +-0x1.ac4ffbd3efac8p-1, +0x1.818504103fa16p-56, +0x1p-1, +0x1.9d5a09f2b9b7fp-5, +-0x1.ab7325916c0d4p-1, +-0x1.a8b8c85baaa9bp-55, +0x1p-1, +0x1.b250171373be9p-5, +-0x1.aa9547a2cb98ep-1, +-0x1.87d00ae97abaap-60, +0x1p-1, +0x1.c73b39ae68c87p-5, +-0x1.a9b66290ea1a3p-1, +-0x1.9f630e8b6dac8p-60, +0x1p-1, +0x1.dc1b64dc48722p-5, +-0x1.a8d676e545ad2p-1, +0x1.b11dcce2e74bdp-59, +0x1p-1, +0x1.f0f08bbc861afp-5, +-0x1.a7f58529fe69dp-1, +0x1.97a441584a179p-55, +0x1p-1, +0x1.02dd50bab06b2p-4, +-0x1.a7138de9d60f5p-1, +0x1.f1ab82a9c5f2dp-55, +0x1p-1, +0x1.0d3ccc99f5ac6p-4, +-0x1.a63091b02fae2p-1, +0x1.e911152248d1p-56, +0x1p-1, +0x1.1796b31609f0cp-4, +-0x1.a54c91090f523p-1, +-0x1.184300fd1c1cep-56, +0x1p-1, +0x1.21eafdcc560fap-4, +-0x1.a4678c8119ac8p-1, +-0x1.1b4c0dd3f212ap-55, +0x1p-1, +0x1.2c39a65db8881p-4, +-0x1.a38184a593bc6p-1, +0x1.bc92c5bd2d288p-55, +0x1p-1, +0x1.3682a66e896f5p-4, +-0x1.a29a7a0462782p-1, +0x1.128bb015df175p-56, +0x1p-1, +0x1.40c5f7a69e5cep-4, +-0x1.a1b26d2c0a75ep-1, +-0x1.30ef431d627a6p-57, +0x1p-1, +0x1.4b0393b14e541p-4, +-0x1.a0c95eabaf937p-1, +0x1.e0ca3acbd049ap-55, +0x1p-1, +0x1.553b743d75acp-4, +-0x1.9fdf4f13149dep-1, +-0x1.1e6d79006ec09p-55, +0x1p-1, +0x1.5f6d92fd79f5p-4, +-0x1.9ef43ef29af94p-1, +-0x1.b1dfcb60445c2p-56, +0x1p-1, +0x1.6999e9a74ddbep-4, +-0x1.9e082edb42472p-1, +-0x1.5809a4e121e22p-57, +0x1p-1, +0x1.73c071f4750b5p-4, +-0x1.9d1b1f5ea80d5p-1, +-0x1.c5fadd5ffb36fp-55, +0x1p-1, +0x1.7de125a2080a9p-4, +-0x1.9c2d110f075c2p-1, +-0x1.d9c9f1c8c30dp-55, +0x1p-1, +0x1.87fbfe70b81a7p-4, +-0x1.9b3e047f38741p-1, +0x1.30ee286712474p-55, +0x1p-1, +0x1.9210f624d30fbp-4, +-0x1.9a4dfa42b06b2p-1, +0x1.829b6b8b1c947p-56, +0x1p-1, +0x1.9c200686472b5p-4, +-0x1.995cf2ed80d22p-1, +-0x1.7783e907fbd7bp-56, +0x1p-1, +0x1.a6292960a6f0bp-4, +-0x1.986aef1457594p-1, +0x1.af03e318f38fcp-55, +0x1p-1, +0x1.b02c58832cf96p-4, +-0x1.9777ef4c7d742p-1, +0x1.15479a240665ep-55, +0x1p-1, +0x1.ba298dc0bfc6bp-4, +-0x1.9683f42bd7fe1p-1, +0x1.11bad933c835ep-57, +0x1p-1, +0x1.c420c2eff590ep-4, +-0x1.958efe48e6dd7p-1, +0x1.561335da0f4e7p-55, +0x1p-1, +0x1.ce11f1eb18148p-4, +-0x1.94990e3ac4a6cp-1, +-0x1.a95328edeb3e6p-56, +0x1p-1, +0x1.d7fd1490285cap-4, +-0x1.93a22499263fbp-1, +-0x1.3d419a920df0bp-55, +0x1p-1, +0x1.e1e224c0e28bdp-4, +-0x1.92aa41fc5a815p-1, +0x1.68f89e2d23db7p-57, +0x1p-1, +0x1.ebc11c62c1a1ep-4, +-0x1.91b166fd49da2p-1, +0x1.3be953a7fe996p-57, +0x1p-1, +0x1.f599f55f034p-4, +-0x1.90b7943575efep-1, +-0x1.4ecb0c5273706p-57, +0x1p-1, +0x1.ff6ca9a2ab6a2p-4, +-0x1.8fbcca3ef940dp-1, +0x1.6dfa99c86f2f1p-57, +0x1p-1, +0x1.049c998f44231p-3, +-0x1.8ec109b486c49p-1, +0x1.cb2a3eb6af617p-56, +0x1p-1, +0x1.097fc5e39aec5p-3, +-0x1.8dc45331698ccp-1, +-0x1.1d9fcd83634d7p-57, +0x1p-1, +0x1.0e5fd6ca90dffp-3, +-0x1.8cc6a75184655p-1, +0x1.e18b3657e2285p-55, +0x1p-1, +0x1.133cc94247758p-3, +-0x1.8bc806b151741p-1, +0x1.2c5e12ed1336dp-55, +0x1p-1, +0x1.18169a4acca89p-3, +-0x1.8ac871ede1d88p-1, +0x1.9afaa5b7cfc55p-55, +0x1p-1, +0x1.1ced46e61cd1cp-3, +-0x1.89c7e9a4dd4aap-1, +-0x1.db6ea04a8678fp-55, +0x1p-1, +0x1.21c0cc18247fcp-3, +-0x1.88c66e7481ba1p-1, +0x1.5c6228970cf35p-56, +0x1p-1, +0x1.269126e6c24e3p-3, +-0x1.87c400fba2ebfp-1, +0x1.2dabc0c3f64cdp-55, +0x1p-1, +0x1.2b5e5459c8bc3p-3, +-0x1.86c0a1d9aa195p-1, +-0x1.84564f09c3726p-59, +0x1p-1, +0x1.3028517b0001p-3, +-0x1.85bc51ae958ccp-1, +-0x1.45ba6478086ccp-55, +0x1p-1, +0x1.34ef1b5627dfdp-3, +-0x1.84b7111af83fap-1, +0x1.63a47df0b21bap-55, +0x1p-1, +0x1.39b2aef8f97a4p-3, +-0x1.83b0e0bff976ep-1, +0x1.6f420f8ea3475p-56, +0x1p-1, +0x1.3e73097329219p-3, +-0x1.82a9c13f545ffp-1, +0x1.65e87a7a8cde9p-56, +0x1p-1, +0x1.433027d66826dp-3, +-0x1.81a1b33b57accp-1, +0x1.5dea12d66bb66p-55, +0x1p-1, +0x1.47ea073666a98p-3, +-0x1.8098b756e52fap-1, +-0x1.9136e834b4707p-55, +0x1p-1, +0x1.4ca0a4a8d5657p-3, +-0x1.7f8ece3571771p-1, +0x1.9c8d8ce93c917p-55, +0x1p-1, +0x1.5153fd45677efp-3, +-0x1.7e83f87b03686p-1, +-0x1.b61a8ccabad6p-57, +0x1p-1, +0x1.56040e25d44ddp-3, +-0x1.7d7836cc33db2p-1, +-0x1.162715ef03f85p-56, +0x1p-1, +0x1.5ab0d465d927ap-3, +-0x1.7c6b89ce2d333p-1, +0x1.cfd628084982cp-56, +0x1p-1, +0x1.5f5a4d233b27fp-3, +-0x1.7b5df226aafafp-1, +0x1.0f537acdf0ad7p-56, +0x1p-1, +0x1.6400757dc8f7dp-3, +-0x1.7a4f707bf97d2p-1, +-0x1.3c9751b491eafp-55, +0x1p-1, +0x1.68a34a975c941p-3, +-0x1.79400574f55e5p-1, +0x1.0adadbdb4c65ap-55, +0x1p-1, +0x1.6d42c993dd121p-3, +-0x1.782fb1b90b35bp-1, +0x1.3e46c1dfd001cp-55, +0x1p-1, +0x1.71deef9940631p-3, +-0x1.771e75f037261p-1, +-0x1.5cfce8d84068fp-56, +0x1p-1, +0x1.7677b9cf8d17p-3, +-0x1.760c52c304764p-1, +0x1.11d76f8e50f1fp-55, +0x1p-1, +0x1.7b0d2560dc1d1p-3, +-0x1.74f948da8d28dp-1, +-0x1.19900a3b9a3a2p-63, +0x1p-1, +0x1.7f9f2f795a83ep-3, +-0x1.73e558e079942p-1, +0x1.2663126697f5ep-55, +0x1p-1, +0x1.842dd5474b37bp-3, +-0x1.72d0837efff96p-1, +-0x1.0d4ef0f1d915cp-55, +0x1p-1, +0x1.88b913fb08bfdp-3, +-0x1.71bac960e41bfp-1, +0x1.b858d90b0f7d8p-56, +0x1p-1, +0x1.8d40e8c706fa4p-3, +-0x1.70a42b3176d7ap-1, +0x1.d9e3fbe2e15ap-56, +0x1p-1, +0x1.91c550dfd4d6bp-3, +-0x1.6f8ca99c95b75p-1, +-0x1.f22e7a35723f4p-56, +0x1p-1, +0x1.9646497c1e0f6p-3, +-0x1.6e74454eaa8afp-1, +0x1.dbc03c84e226ep-55, +0x1p-1, +0x1.9ac3cfd4ace19p-3, +-0x1.6d5afef4aafcdp-1, +0x1.868a696b8835ep-55, +0x1p-1, +0x1.9f3de1246bc4p-3, +-0x1.6c40d73c18275p-1, +-0x1.25d4f802be257p-57, +0x1p-1, +0x1.a3b47aa8671c5p-3, +-0x1.6b25ced2fe29cp-1, +0x1.5ac64116beda5p-55, +0x1p-1, +0, +-0x1.6a09e667f3bcdp-1, +0x1.bdd3413b26456p-55, +0, +-0x1.29b4625a03ac9p-2, +-0x1.68ed1eaa19c71p-1, +-0x1.fd4a85350f69p-56, +0x1p0, +-0x1.277e5187cfb16p-2, +-0x1.67cf78491af1p-1, +-0x1.750ab23477b61p-59, +0x1p0, +-0x1.254a0216aa067p-2, +-0x1.66b0f3f52b386p-1, +-0x1.1e2eb31a8848bp-55, +0x1p0, +-0x1.23177562aaea3p-2, +-0x1.6591925f0783dp-1, +-0x1.c3d64fbf5de23p-55, +0x1p0, +-0x1.20e6acc6d4916p-2, +-0x1.64715437f535bp-1, +0x1.7c399c15a17dp-55, +0x1p0, +-0x1.1eb7a99d1250cp-2, +-0x1.63503a31c1be9p-1, +-0x1.1248f09e6587cp-57, +0x1p0, +-0x1.1c8a6d3e37c82p-2, +-0x1.622e44fec22ffp-1, +-0x1.f98d8be132d57p-56, +0x1p0, +-0x1.1a5ef902000d3p-2, +-0x1.610b7551d2cdfp-1, +0x1.251b352ff2a37p-56, +0x1p0, +-0x1.18354e3f0cd7dp-2, +-0x1.5fe7cbde56a1p-1, +0x1.fcb9cc30cc01ep-55, +0x1p0, +-0x1.160d6e4ae5ae6p-2, +-0x1.5ec3495837074p-1, +-0x1.dea89a9b8f727p-56, +0x1p0, +-0x1.13e75a79f7139p-2, +-0x1.5d9dee73e345cp-1, +0x1.de1165ecdf7a3p-57, +0x1p0, +-0x1.11c3141f91b3ep-2, +-0x1.5c77bbe65018cp-1, +-0x1.069ea9c0bc32ap-55, +0x1p0, +-0x1.0fa09c8de994bp-2, +-0x1.5b50b264f7448p-1, +-0x1.519d30d4cfebp-56, +0x1p0, +-0x1.0d7ff51615437p-2, +-0x1.5a28d2a5d725p-1, +-0x1.57a25f8b1343p-55, +0x1p0, +-0x1.0b611f080d05bp-2, +-0x1.59001d5f723dfp-1, +-0x1.a9f86ba0dde98p-56, +0x1p0, +-0x1.09441bb2aa0a2p-2, +-0x1.57d69348cecap-1, +0x1.75720992bfbb2p-55, +0x1p0, +-0x1.0728ec63a599ap-2, +-0x1.56ac35197649fp-1, +0x1.f7874188cb279p-55, +0x1p0, +-0x1.050f92679849cp-2, +-0x1.5581038975137p-1, +-0x1.4570d9efe26dfp-55, +0x1p0, +-0x1.02f80f09f92f4p-2, +-0x1.5454ff5159dfcp-1, +0x1.4e247588bf256p-55, +0x1p0, +-0x1.00e263951d11fp-2, +-0x1.5328292a35596p-1, +0x1.a12eb89da0257p-56, +0x1p0, +-0x1.fd9d22a46b416p-3, +-0x1.51fa81cd99aa6p-1, +0x1.499f59d8560e9p-63, +0x1p0, +-0x1.f9793312a14d1p-3, +-0x1.50cc09f59a09bp-1, +-0x1.693463a2c2e6fp-56, +0x1p0, +-0x1.f558fb02ae805p-3, +-0x1.4f9cc25cca486p-1, +-0x1.48b5951cfc2b5p-55, +0x1p0, +-0x1.f13c7d001a249p-3, +-0x1.4e6cabbe3e5e9p-1, +-0x1.3c293edceb327p-57, +0x1p0, +-0x1.ed23bb941f019p-3, +-0x1.4d3bc6d589f7fp-1, +-0x1.6e4d9d6b72011p-55, +0x1p0, +-0x1.e90eb945a9ccfp-3, +-0x1.4c0a145ec0004p-1, +-0x1.2630cfafceaa1p-58, +0x1p0, +-0x1.e4fd7899579acp-3, +-0x1.4ad79516722f1p-1, +0x1.1273b163000f7p-55, +0x1p0, +-0x1.e0effc1174505p-3, +-0x1.49a449b9b0939p-1, +0x1.27ee16d719b94p-55, +0x1p0, +-0x1.dce6462df917dp-3, +-0x1.48703306091ffp-1, +0x1.70813b86159fdp-57, +0x1p0, +-0x1.d8e0596c8ad56p-3, +-0x1.473b51b987347p-1, +-0x1.ca1953514e41bp-57, +0x1p0, +-0x1.d4de3848789e2p-3, +-0x1.4605a692b32a2p-1, +-0x1.21ca219b97107p-55, +0x1p0, +-0x1.d0dfe53aba2fdp-3, +-0x1.44cf325091dd6p-1, +-0x1.8076a2cfdc6b3p-57, +0x1p0, +-0x1.cce562b9ee6aep-3, +-0x1.4397f5b2a438p-1, +0x1.7274c9e48c226p-55, +0x1p0, +-0x1.c8eeb33a59cdp-3, +-0x1.425ff178e6bb1p-1, +-0x1.7b38d675140cap-55, +0x1p0, +-0x1.c4fbd92de4eddp-3, +-0x1.41272663d108cp-1, +-0x1.1bbe7636fadf5p-55, +0x1p0, +-0x1.c10cd7041afccp-3, +-0x1.3fed9534556d4p-1, +-0x1.36916608c5061p-55, +0x1p0, +-0x1.bd21af2a28408p-3, +-0x1.3eb33eabe068p-1, +-0x1.86a2357d1a0d3p-58, +0x1p0, +-0x1.b93a640ad8978p-3, +-0x1.3d78238c58344p-1, +0x1.0219f5f0f79cep-55, +0x1p0, +-0x1.b556f80e95facp-3, +-0x1.3c3c44981c518p-1, +0x1.b5e9a9644151bp-55, +0x1p0, +-0x1.b1776d9b67013p-3, +-0x1.3affa292050b9p-1, +-0x1.e3e25e3954964p-56, +0x1p0, +-0x1.ad9bc714ed64fp-3, +-0x1.39c23e3d63029p-1, +0x1.3b05b276085c1p-58, +0x1p0, +-0x1.a9c406dc648a5p-3, +-0x1.3884185dfeb22p-1, +0x1.a038026abe6b2p-56, +0x1p0, +-0x1.a5f02f50a007cp-3, +-0x1.374531b817f8dp-1, +-0x1.444d2b0a747fep-55, +0x1p0, +-0x1.a22042ce0a2f9p-3, +-0x1.36058b10659f3p-1, +0x1.1fcb3a35857e7p-55, +0x1p0, +-0x1.9e5443aea29b2p-3, +-0x1.34c5252c14de1p-1, +-0x1.583f49632ab2bp-55, +0x1p0, +-0x1.9a8c3449fcb77p-3, +-0x1.338400d0c8e57p-1, +0x1.abf2a5e95e6e5p-55, +0x1p0, +-0x1.96c816f53e539p-3, +-0x1.32421ec49a61fp-1, +-0x1.65e25cc951bfep-55, +0x1p0, +-0x1.9307ee031e2fdp-3, +-0x1.30ff7fce17035p-1, +0x1.efcc626f74a6fp-57, +0x1p0, +-0x1.8f4bbbc3e28f6p-3, +-0x1.2fbc24b441015p-1, +-0x1.dba4875410874p-57, +0x1p0, +-0x1.8b9382855fcaap-3, +-0x1.2e780e3e8ea17p-1, +0x1.b19fafe36587ap-55, +0x1p0, +-0x1.87df4492f6e38p-3, +-0x1.2d333d34e9bb8p-1, +0x1.0e2c2c5549e26p-55, +0x1p0, +-0x1.842f0435941afp-3, +-0x1.2bedb25faf3eap-1, +0x1.14981c796ee46p-58, +0x1p0, +-0x1.8082c3b3ad887p-3, +-0x1.2aa76e87aeb58p-1, +-0x1.fd600833287a7p-59, +0x1p0, +-0x1.7cda855141b26p-3, +-0x1.2960727629ca8p-1, +-0x1.56d6c7af02d5cp-56, +0x1p0, +-0x1.79364b4fd6288p-3, +-0x1.2818bef4d3cbap-1, +0x1.e3fffeb76568ap-56, +0x1p0, +-0x1.759617ee761f9p-3, +-0x1.26d054cdd12dfp-1, +0x1.5da743ef3770cp-55, +0x1p0, +-0x1.71f9ed69b10eap-3, +-0x1.258734cbb711p-1, +-0x1.3a3f0903ce09dp-57, +0x1p0, +-0x1.6e61cdfb994dfp-3, +-0x1.243d5fb98ac1fp-1, +-0x1.c533d0a284a8dp-56, +0x1p0, +-0x1.6acdbbdbc2b73p-3, +-0x1.22f2d662c13e2p-1, +0x1.d5cc7580cb6d2p-55, +0x1p0, +-0x1.673db93f41479p-3, +-0x1.21a799933eb59p-1, +0x1.3a7b177c68fb2p-55, +0x1p0, +-0x1.63b1c858a7c2ep-3, +-0x1.205baa17560d6p-1, +-0x1.b7b144016c7a3p-56, +0x1p0, +-0x1.6029eb580658ep-3, +-0x1.1f0f08bbc861bp-1, +0x1.10d9dcafb74cbp-57, +0x1p0, +-0x1.5ca6246ae94b8p-3, +-0x1.1dc1b64dc4872p-1, +-0x1.f15e1c468be78p-57, +0x1p0, +-0x1.592675bc57974p-3, +-0x1.1c73b39ae68c8p-1, +-0x1.b25dd267f66p-55, +0x1p0, +-0x1.55aae174d19c8p-3, +-0x1.1b250171373bfp-1, +0x1.b210e95e1ca4cp-55, +0x1p0, +-0x1.523369ba4fcaep-3, +-0x1.19d5a09f2b9b8p-1, +0x1.33656c68a1d4ap-57, +0x1p0, +-0x1.4ec010b0414e1p-3, +-0x1.188591f3a46e5p-1, +0x1.bbefe5a524346p-56, +0x1p0, +-0x1.4b50d8778abbdp-3, +-0x1.1734d63dedb49p-1, +0x1.7eef2ccc50575p-55, +0x1p0, +-0x1.47e5c32e84c45p-3, +-0x1.15e36e4dbe2bcp-1, +-0x1.3c545f7d79eaep-56, +0x1p0, +-0x1.447ed2f0fae31p-3, +-0x1.14915af336cebp-1, +-0x1.f3660558a0213p-56, +0x1p0, +-0x1.411c09d82a128p-3, +-0x1.133e9cfee254fp-1, +0x1.a1377cfd5ce5p-56, +0x1p0, +-0x1.3dbd69fabf802p-3, +-0x1.11eb3541b4b23p-1, +0x1.ef23b69abe4f1p-55, +0x1p0, +-0x1.3a62f56cd742ep-3, +-0x1.1097248d0a957p-1, +0x1.7a58759ba80ddp-55, +0x1p0, +-0x1.370cae3ffb12fp-3, +-0x1.0f426bb2a8e7ep-1, +0x1.bb58fb774f8eep-55, +0x1p0, +-0x1.33ba968321032p-3, +-0x1.0ded0b84bc4b6p-1, +0x1.8540fa327c55cp-55, +0x1p0, +-0x1.306cb042aa3bap-3, +-0x1.0c9704d5d898fp-1, +0x1.8d3d7de6ee9b2p-55, +0x1p0, +-0x1.2d22fd8861b6bp-3, +-0x1.0b405878f85ecp-1, +0x1.ad66c3bb80da5p-55, +0x1p0, +-0x1.29dd805b7afecp-3, +-0x1.09e907417c5e1p-1, +0x1.fe573741a9bd4p-55, +0x1p0, +-0x1.269c3ac090ee4p-3, +-0x1.089112032b08cp-1, +-0x1.3248ddf9fe619p-57, +0x1p0, +-0x1.235f2eb9a470ap-3, +-0x1.073879922ffeep-1, +0x1.a5a014347406cp-55, +0x1p0, +-0x1.20265e461b45ap-3, +-0x1.05df3ec31b8b7p-1, +0x1.e2dcad34d9c1dp-57, +0x1p0, +-0x1.1cf1cb62bec5dp-3, +-0x1.0485626ae221ap-1, +-0x1.b937d9091ff7p-55, +0x1p0, +-0x1.19c17809baa87p-3, +-0x1.032ae55edbd96p-1, +0x1.bdb022b40107ap-55, +0x1p0, +-0x1.169566329bcb7p-3, +-0x1.01cfc874c3eb7p-1, +0x1.34a35e7c2368cp-56, +0x1p0, +-0x1.136d97d24efccp-3, +-0x1.00740c82b82e1p-1, +0x1.6d48563c60e87p-55, +0x1p0, +-0x1.104a0edb1fc58p-3, +-0x1.fe2f64be7121p-2, +0x1.297ab1ca2d7dbp-56, +0x1p0, +-0x1.0d2acd3cb7364p-3, +-0x1.fb7575c24d2dep-2, +0x1.5bfdc883c8664p-57, +0x1p0, +-0x1.0a0fd4e41ab5ap-3, +-0x1.f8ba4dbf89abap-2, +0x1.2ec1fc1b776b8p-60, +0x1p0, +-0x1.06f927bbaacfep-3, +-0x1.f5fdee656cda3p-2, +0x1.7bf9780816b05p-58, +0x1p0, +-0x1.03e6c7ab2208cp-3, +-0x1.f3405963fd067p-2, +-0x1.06846d44a238fp-56, +0x1p0, +-0x1.00d8b69793ae4p-3, +-0x1.f081906bff7fep-2, +0x1.4cab2d4ff6fccp-56, +0x1p0, +-0x1.fb9decc6d55b8p-4, +-0x1.edc1952ef78d6p-2, +0x1.dd0f7c33edee6p-56, +0x1p0, +-0x1.f59311dcd0d44p-4, +-0x1.eb00695f2562p-2, +-0x1.53c9fd3083e22p-56, +0x1p0, +-0x1.ef90e02b47283p-4, +-0x1.e83e0eaf85114p-2, +0x1.7bc380ef24ba7p-57, +0x1p0, +-0x1.e9975b670e077p-4, +-0x1.e57a86d3cd825p-2, +0x1.2c80dcd511e87p-57, +0x1p0, +-0x1.e3a6873fa1279p-4, +-0x1.e2b5d3806f63bp-2, +-0x1.e0d891d3c6841p-58, +0x1p0, +-0x1.ddbe675f1ffdfp-4, +-0x1.dfeff66a941dep-2, +0x1.a756c6e625f96p-56, +0x1p0, +-0x1.d7deff6a4b7c9p-4, +-0x1.dd28f1481cc58p-2, +0x1.e7576fa6c944ep-59, +0x1p0, +-0x1.d208530083d3p-4, +-0x1.da60c5cfa10d9p-2, +0x1.0f38e2143c8d5p-57, +0x1p0, +-0x1.cc3a65bbc6327p-4, +-0x1.d79775b86e389p-2, +-0x1.550ec87bc0575p-56, +0x1p0, +-0x1.c6753b30aa949p-4, +-0x1.d4cd02ba8609dp-2, +0x1.37f33c63033d6p-57, +0x1p0, +-0x1.c0b8d6ee61867p-4, +-0x1.d2016e8e9db5bp-2, +0x1.c8bce9d93efb8p-57, +0x1p0, +-0x1.bb053c7eb1f68p-4, +-0x1.cf34baee1cd21p-2, +0x1.118724d19d014p-56, +0x1p0, +-0x1.b55a6f65f7058p-4, +-0x1.cc66e9931c45ep-2, +-0x1.6850e59c37f8fp-58, +0x1p0, +-0x1.afb873231ddb9p-4, +-0x1.c997fc3865389p-2, +0x1.6295f8b0ca33bp-56, +0x1p0, +-0x1.aa1f4b2fa37fcp-4, +-0x1.c6c7f4997000bp-2, +0x1.bec2669c68e74p-56, +0x1p0, +-0x1.a48efaff92b3bp-4, +-0x1.c3f6d47263129p-2, +-0x1.9c7bd0fcdecddp-56, +0x1p0, +-0x1.9f07860181d1ep-4, +-0x1.c1249d8011ee7p-2, +0x1.813aabb515206p-56, +0x1p0, +-0x1.9988ef9e90b04p-4, +-0x1.be51517ffc0d9p-2, +-0x1.2b667131a5f16p-56, +0x1p0, +-0x1.94133b3a66851p-4, +-0x1.bb7cf2304bd01p-2, +-0x1.9e1a5bd9269d4p-57, +0x1p0, +-0x1.8ea66c332fd01p-4, +-0x1.b8a7814fd5693p-2, +-0x1.9a9e6651cc119p-56, +0x1p0, +-0x1.894285e19c468p-4, +-0x1.b5d1009e15ccp-2, +-0x1.5b362cb974183p-57, +0x1p0, +-0x1.83e78b98dcc2bp-4, +-0x1.b2f971db31972p-2, +-0x1.fa971a4a41f2p-56, +0x1p0, +-0x1.7e9580a6a136ep-4, +-0x1.b020d6c7f4009p-2, +-0x1.414ae7e555208p-58, +0x1p0, +-0x1.794c685316a3cp-4, +-0x1.ad473125cdc09p-2, +0x1.379ede57649dap-58, +0x1p0, +-0x1.740c45e0e512p-4, +-0x1.aa6c82b6d3fcap-2, +0x1.d5f106ee5ccf7p-56, +0x1p0, +-0x1.6ed51c8d2d8fcp-4, +-0x1.a790cd3dbf31bp-2, +0x1.7f786986d9023p-57, +0x1p0, +-0x1.69a6ef8f8830ap-4, +-0x1.a4b4127dea1e5p-2, +0x1.bec6f01bc22f1p-56, +0x1p0, +-0x1.6481c21a02123p-4, +-0x1.a1d6543b50acp-2, +0x1.0246cfd8779fbp-57, +0x1p0, +-0x1.5f6597591b633p-4, +-0x1.9ef7943a8ed8ap-2, +-0x1.6da81290bdbabp-57, +0x1p0, +-0x1.5a527273c56e1p-4, +-0x1.9c17d440df9f2p-2, +-0x1.923c540a9eec4p-57, +0x1p0, +-0x1.5548568b60a7bp-4, +-0x1.993716141bdffp-2, +0x1.15e8cce261c55p-56, +0x1p0, +-0x1.504746bbbac0bp-4, +-0x1.96555b7ab948fp-2, +-0x1.7afd51eff33adp-56, +0x1p0, +-0x1.4b4f461b0cbaap-4, +-0x1.9372a63bc93d7p-2, +-0x1.684319e5ad5b1p-57, +0x1p0, +-0x1.466057b9f900ap-4, +-0x1.908ef81ef7bd1p-2, +-0x1.4c00267012357p-56, +0x1p0, +-0x1.417a7ea389835p-4, +-0x1.8daa52ec8a4bp-2, +0x1.72eb2db8c621ep-57, +0x1p0, +-0x1.3c9dbddd2dd84p-4, +-0x1.8ac4b86d5ed44p-2, +-0x1.17fa7f944ad5bp-56, +0x1p0, +-0x1.37ca1866b95cfp-4, +-0x1.87de2a6aea963p-2, +0x1.72cedd3d5a61p-57, +0x1p0, +-0x1.32ff913a615dp-4, +-0x1.84f6aaaf3903fp-2, +-0x1.6dcdc2bd47067p-57, +0x1p0, +-0x1.2e3e2b4cbb3c3p-4, +-0x1.820e3b04eaac4p-2, +0x1.92379eb01c6b6p-59, +0x1p0, +-0x1.2985e98cbaa3ap-4, +-0x1.7f24dd37341e4p-2, +-0x1.2791a1b5eb796p-57, +0x1p0, +-0x1.24d6cee3afb2ap-4, +-0x1.7c3a9311dcce7p-2, +-0x1.9a3f21ef3e8d9p-62, +0x1p0, +-0x1.2030de354532cp-4, +-0x1.794f5e613dfaep-2, +-0x1.820a4b0d21fc5p-57, +0x1p0, +-0x1.1b941a5f7ecffp-4, +-0x1.766340f2418f6p-2, +-0x1.2b2adc9041b2cp-56, +0x1p0, +-0x1.1700863ab7533p-4, +-0x1.73763c9261092p-2, +0x1.52324face3b1ap-57, +0x1p0, +-0x1.127624999ee1dp-4, +-0x1.7088530fa459fp-2, +0x1.44b19e0864c5dp-56, +0x1p0, +-0x1.0df4f849393f5p-4, +-0x1.6d998638a0cb6p-2, +0x1.1ca14532860dfp-61, +0x1p0, +-0x1.097d0410dc132p-4, +-0x1.6aa9d7dc77e17p-2, +0x1.38b470592c7b3p-56, +0x1p0, +-0x1.050e4ab22d321p-4, +-0x1.67b949cad63cbp-2, +0x1.a23369348d7efp-56, +0x1p0, +-0x1.00a8cee920eabp-4, +-0x1.64c7ddd3f27c6p-2, +-0x1.10d2b4a664121p-58, +0x1p0, +-0x1.f89926d7f0ab8p-5, +-0x1.61d595c88c202p-2, +-0x1.f6b1e333415d7p-56, +0x1p0, +-0x1.eff335d67f541p-5, +-0x1.5ee27379ea693p-2, +-0x1.634ff2fa75245p-56, +0x1p0, +-0x1.e75fd0239926cp-5, +-0x1.5bee78b9db3b6p-2, +-0x1.e734a63158dfdp-58, +0x1p0, +-0x1.dedefb09791b4p-5, +-0x1.58f9a75ab1fddp-2, +0x1.efdc0d58cf62p-62, +0x1p0, +-0x1.d670bbc6e685ep-5, +-0x1.5604012f467b4p-2, +-0x1.a0e0b2a5b25p-56, +0x1p0, +-0x1.ce15178f31db3p-5, +-0x1.530d880af3c24p-2, +0x1.fab8e2103fbd6p-56, +0x1p0, +-0x1.c5cc138a317afp-5, +-0x1.50163dc197048p-2, +0x1.ec66cb05c7ea4p-56, +0x1p0, +-0x1.bd95b4d43e819p-5, +-0x1.4d1e24278e76ap-2, +-0x1.2417218792858p-57, +0x1p0, +-0x1.b572007e31a1bp-5, +-0x1.4a253d11b82f3p-2, +0x1.2afa4d6d42a55p-58, +0x1p0, +-0x1.ad60fb8d6003ap-5, +-0x1.472b8a5571054p-2, +0x1.01ea0fe4dff23p-56, +0x1p0, +-0x1.a562aafb982cdp-5, +-0x1.44310dc8936fp-2, +-0x1.8b694e91d3125p-56, +0x1p0, +-0x1.9d7713b71eee1p-5, +-0x1.4135c94176601p-2, +-0x1.0c97c4afa2518p-56, +0x1p0, +-0x1.959e3aa2ac58dp-5, +-0x1.3e39be96ec271p-2, +-0x1.814c6de9aaaf6p-56, +0x1p0, +-0x1.8dd8249568bbbp-5, +-0x1.3b3cefa0414b7p-2, +-0x1.f36dc4a9c2294p-56, +0x1p0, +-0x1.8624d65ae9a63p-5, +-0x1.383f5e353b6abp-2, +0x1.a812a4a5c3d44p-56, +0x1p0, +-0x1.7e8454b32ef34p-5, +-0x1.35410c2e18152p-2, +0x1.3cb002f96e062p-56, +0x1p0, +-0x1.76f6a4529fdb5p-5, +-0x1.3241fb638baafp-2, +-0x1.ecee8f76f8c51p-60, +0x1p0, +-0x1.6f7bc9e2080d9p-5, +-0x1.2f422daec0387p-2, +0x1.7501ba473da6fp-56, +0x1p0, +-0x1.6813c9fe94cfbp-5, +-0x1.2c41a4e95452p-2, +-0x1.9cf0354aad2dcp-56, +0x1p0, +-0x1.60bea939d225ap-5, +-0x1.294062ed59f06p-2, +0x1.5d28da2c4612dp-56, +0x1p0, +-0x1.597c6c19a8003p-5, +-0x1.263e6995554bap-2, +-0x1.1d350ffc5ff32p-56, +0x1p0, +-0x1.524d171857726p-5, +-0x1.233bbabc3bb71p-2, +-0x1.99b04e23259efp-56, +0x1p0, +-0x1.4b30aea477eeep-5, +-0x1.2038583d727bep-2, +0x1.c69cd46300a3p-57, +0x1p0, +-0x1.44273720f48bcp-5, +-0x1.1d3443f4cdb3ep-2, +0x1.720d41c13519ep-57, +0x1p0, +-0x1.3d30b4e5094ep-5, +-0x1.1a2f7fbe8f243p-2, +-0x1.6465ac86ba7b2p-56, +0x1p0, +-0x1.364d2c3c407bep-5, +-0x1.172a0d7765177p-2, +-0x1.22575f33366bep-57, +0x1p0, +-0x1.2f7ca1666ff6fp-5, +-0x1.1423eefc69378p-2, +-0x1.22d3368ec9b62p-56, +0x1p0, +-0x1.28bf1897b69ccp-5, +-0x1.111d262b1f677p-2, +-0x1.824c20ab7aa9ap-56, +0x1p0, +-0x1.221495f879af5p-5, +-0x1.0e15b4e1749cep-2, +0x1.5b7fb156c550ap-56, +0x1p0, +-0x1.1b7d1da562443p-5, +-0x1.0b0d9cfdbdb9p-2, +-0x1.3b3a7b8d1200dp-58, +0x1p0, +-0x1.14f8b3af5abb9p-5, +-0x1.0804e05eb661ep-2, +-0x1.54e583d92d3d8p-56, +0x1p0, +-0x1.0e875c1b8c3dap-5, +-0x1.04fb80e37fdaep-2, +0x1.412cdb72583ccp-63, +0x1p0, +-0x1.08291ae35c407p-5, +-0x1.01f1806b9fdd2p-2, +0x1.448135394b8bap-56, +0x1p0, +-0x1.01ddf3f46a139p-5, +-0x1.fdcdc1adfedf9p-3, +0x1.2dba4580ed7bbp-57, +0x1p0, +-0x1.f74bd66118e8dp-6, +-0x1.f7b7480bd3802p-3, +0x1.9a96d967ee12ep-57, +0x1p0, +-0x1.eb0208db9e51bp-6, +-0x1.f19f97b215f1bp-3, +0x1.42deef11da2c4p-57, +0x1p0, +-0x1.dede86ece142ep-6, +-0x1.eb86b462de348p-3, +0x1.bfcde46f90b62p-57, +0x1p0, +-0x1.d2e15811bf462p-6, +-0x1.e56ca1e101a1bp-3, +-0x1.46ac3f9fd0227p-57, +0x1p0, +-0x1.c70a83af71ef5p-6, +-0x1.df5163f01099ap-3, +0x1.01f7d79906e86p-57, +0x1p0, +-0x1.bb5a11138a4c9p-6, +-0x1.d934fe5454311p-3, +-0x1.75b92277107adp-57, +0x1p0, +-0x1.afd00773ec64fp-6, +-0x1.d31774d2cbdeep-3, +-0x1.2fdc8e5791a0bp-57, +0x1p0, +-0x1.a46c6deecac5fp-6, +-0x1.ccf8cb312b286p-3, +-0x1.2382b0aecadf8p-58, +0x1p0, +-0x1.992f4b8aa21f8p-6, +-0x1.c6d90535d74ddp-3, +0x1.bfb2be2264962p-59, +0x1p0, +-0x1.8e18a73634ee7p-6, +-0x1.c0b826a7e4f63p-3, +0x1.af1439e521935p-62, +0x1p0, +-0x1.832887c88735dp-6, +-0x1.ba96334f15dadp-3, +0x1.75098c05dd18ap-57, +0x1p0, +-0x1.785ef400da46cp-6, +-0x1.b4732ef3d6722p-3, +-0x1.bbe5d5d75cbd8p-57, +0x1p0, +-0x1.6dbbf286a8971p-6, +-0x1.ae4f1d5f3b9abp-3, +-0x1.aa8bbcef9b68ep-57, +0x1p0, +-0x1.633f89e9a1a66p-6, +-0x1.a82a025b00451p-3, +0x1.87905ffd084adp-57, +0x1p0, +-0x1.58e9c0a1a5f21p-6, +-0x1.a203e1b1831dap-3, +-0x1.c1aadb580a1ecp-58, +0x1p0, +-0x1.4eba9d0ec2f7cp-6, +-0x1.9bdcbf2dc4366p-3, +-0x1.9632d189956fep-57, +0x1p0, +-0x1.44b225792f46bp-6, +-0x1.95b49e9b62afap-3, +0x1.100b3d1dbfeaap-59, +0x1p0, +-0x1.3ad06011469fbp-6, +-0x1.8f8b83c69a60bp-3, +0x1.26d19b9ff8d82p-57, +0x1p0, +-0x1.311552ef8623cp-6, +-0x1.8961727c41804p-3, +-0x1.3fdab4e42640ap-58, +0x1p0, +-0x1.278104148891ap-6, +-0x1.83366e89c64c6p-3, +0x1.192952df10db8p-57, +0x1p0, +-0x1.1e1379690291cp-6, +-0x1.7d0a7bbd2cb1cp-3, +0x1.cf900f27c58efp-57, +0x1p0, +-0x1.14ccb8bdbf114p-6, +-0x1.76dd9de50bf31p-3, +-0x1.1d5eeec501b2fp-57, +0x1p0, +-0x1.0bacc7cb9babap-6, +-0x1.70afd8d08c4ffp-3, +-0x1.260c3f1369484p-57, +0x1p0, +-0x1.02b3ac3385232p-6, +-0x1.6a81304f64ab2p-3, +-0x1.f0cd73fb5d8d4p-58, +0x1p0, +-0x1.f3c2d6fce7cfap-7, +-0x1.6451a831d830dp-3, +-0x1.ad16031a34d5p-58, +0x1p0, +-0x1.e26c163ad15b3p-7, +-0x1.5e214448b3fc6p-3, +-0x1.531ff779ddac6p-57, +0x1p0, +-0x1.d16320d2d221ep-7, +-0x1.57f008654cbdep-3, +-0x1.908c95c4c9118p-58, +0x1p0, +-0x1.c0a80146f894cp-7, +-0x1.51bdf8597c5f2p-3, +0x1.9f9976af04aa5p-61, +0x1p0, +-0x1.b03ac1e94fe1dp-7, +-0x1.4b8b17f79fa88p-3, +-0x1.b534fe588f0dp-57, +0x1p0, +-0x1.a01b6cdbd995ep-7, +-0x1.45576b1293e5ap-3, +0x1.285a24119f7b1p-58, +0x1p0, +-0x1.904a0c10875cep-7, +-0x1.3f22f57db4893p-3, +-0x1.bfe7ff2274956p-59, +0x1p0, +-0x1.80c6a94934dfp-7, +-0x1.38edbb0cd8d14p-3, +0x1.198c21fbf7718p-57, +0x1p0, +-0x1.71914e17a1bc6p-7, +-0x1.32b7bf94516a7p-3, +-0x1.2a24e2431ef29p-57, +0x1p0, +-0x1.62aa03dd6ba58p-7, +-0x1.2c8106e8e613ap-3, +-0x1.13000a89a11ep-58, +0x1p0, +-0x1.5410d3cc0891ep-7, +-0x1.264994dfd3409p-3, +-0x1.a744ce26f39cp-57, +0x1p0, +-0x1.45c5c6e4c114ap-7, +-0x1.20116d4ec7bcfp-3, +0x1.242c8e1053452p-57, +0x1p0, +-0x1.37c8e5f8aacep-7, +-0x1.19d8940be24e7p-3, +-0x1.e8dcdca90cc74p-58, +0x1p0, +-0x1.2a1a39a8a2fb7p-7, +-0x1.139f0cedaf577p-3, +0x1.523434d1b3cfap-57, +0x1p0, +-0x1.1cb9ca654924fp-7, +-0x1.0d64dbcb26786p-3, +0x1.713a562132055p-58, +0x1p0, +-0x1.0fa7a06ef9e81p-7, +-0x1.072a047ba831dp-3, +-0x1.19db1f70118cap-58, +0x1p0, +-0x1.02e3c3d5c9e17p-7, +-0x1.00ee8ad6fb85bp-3, +-0x1.673eac8308f11p-58, +0x1p0, +-0x1.ecdc78f30165cp-8, +-0x1.f564e56a9730ep-4, +-0x1.a2704729ae56dp-59, +0x1p0, +-0x1.d48e24132851p-8, +-0x1.e8eb7fde4aa3fp-4, +0x1.23758f2d5bb8bp-58, +0x1p0, +-0x1.bcdc980a46f5ap-8, +-0x1.dc70ecbae9fc9p-4, +-0x1.2fda2d73295eep-60, +0x1p0, +-0x1.a5c7e375e55dep-8, +-0x1.cff533b307dc1p-4, +-0x1.8feeb8f9c3334p-59, +0x1p0, +-0x1.8f501492cc296p-8, +-0x1.c3785c79ec2d5p-4, +0x1.4f39df133fb21p-61, +0x1p0, +-0x1.7975393cfbc4dp-8, +-0x1.b6fa6ec38f64cp-4, +-0x1.db5d943691f09p-58, +0x1p0, +-0x1.64375eefa3dd6p-8, +-0x1.aa7b724495c03p-4, +-0x1.e5399ba0967b8p-58, +0x1p0, +-0x1.4f9692c51b0fbp-8, +-0x1.9dfb6eb24a85cp-4, +-0x1.e96b47b8c44e6p-59, +0x1p0, +-0x1.3b92e176d6d31p-8, +-0x1.917a6bc29b42cp-4, +0x1.e2718d26ed688p-60, +0x1p0, +-0x1.282c575d639fcp-8, +-0x1.84f8712c130a1p-4, +0x1.e626ebafe374ep-58, +0x1p0, +-0x1.156300705d51bp-8, +-0x1.787586a5d5b21p-4, +-0x1.5f7589f083399p-58, +0x1p0, +-0x1.0336e84667c66p-8, +-0x1.6bf1b3e79b129p-4, +0x1.14b6da08765p-58, +0x1p0, +-0x1.e350342a4f6e6p-9, +-0x1.5f6d00a9aa419p-4, +0x1.f4022d03f6c9ap-59, +0x1p0, +-0x1.c16d4162779e5p-9, +-0x1.52e774a4d4d0ap-4, +-0x1.b2edf18c730cbp-60, +0x1p0, +-0x1.a0c50d1c6bf93p-9, +-0x1.4661179272096p-4, +0x1.4b109f2406c4cp-58, +0x1p0, +-0x1.8157ab7d29fd9p-9, +-0x1.39d9f12c5a299p-4, +-0x1.1287ff27ae554p-62, +0x1p0, +-0x1.63252fe77c5ebp-9, +-0x1.2d52092ce19f6p-4, +0x1.9a088a8bf6b2cp-59, +0x1p0, +-0x1.462dacfbef0f3p-9, +-0x1.20c9674ed444dp-4, +0x1.f9d48faba7974p-58, +0x1p0, +-0x1.2a713498c3c3dp-9, +-0x1.1440134d709b3p-4, +0x1.fec446daea6adp-58, +0x1p0, +-0x1.0fefd7d9e6ed8p-9, +-0x1.07b614e463064p-4, +0x1.384f8c3ee7605p-58, +0x1p0, +-0x1.ed534e31ca57fp-10, +-0x1.f656e79f820ep-5, +0x1.2e1ebe392bffep-61, +0x1p0, +-0x1.bd3d63d9c26efp-10, +-0x1.dd406f9808ec9p-5, +-0x1.1313a4b4068bdp-62, +0x1p0, +-0x1.8f9e0e5514865p-10, +-0x1.c428d12c0d7e3p-5, +0x1.89bc74b58c513p-60, +0x1p0, +-0x1.647569c825ae1p-10, +-0x1.ab101bd5f8317p-5, +0x1.65c6175c6dc68p-59, +0x1p0, +-0x1.3bc390d250439p-10, +-0x1.91f65f10dd814p-5, +0x1.912bd0d569a9p-61, +0x1p0, +-0x1.15889c8dd385fp-10, +-0x1.78dbaa5874686p-5, +0x1.4a0ef4035c29cp-60, +0x1p0, +-0x1.e389491f8833ap-11, +-0x1.5fc00d290cd43p-5, +-0x1.a2669a693a8e1p-59, +0x1p0, +-0x1.a0ef7dcffafabp-11, +-0x1.46a396ff86179p-5, +-0x1.136ac00fa2da9p-61, +0x1p0, +-0x1.6344004228d8bp-11, +-0x1.2d865759455cdp-5, +-0x1.686f65ba93acp-61, +0x1p0, +-0x1.2a86f68094692p-11, +-0x1.14685db42c17fp-5, +0x1.2890d277cb974p-59, +0x1p0, +-0x1.ed71071603e86p-12, +-0x1.f693731d1cf01p-6, +0x1.3fe9bc66286c7p-66, +0x1p0, +-0x1.8fb18eacc3af8p-12, +-0x1.c454f4ce53b1dp-6, +0x1.d63d7fef0e36cp-60, +0x1p0, +-0x1.3bcfbd9979a27p-12, +-0x1.92155f7a3667ep-6, +0x1.b1d63091a013p-64, +0x1p0, +-0x1.e3978f34889d9p-13, +-0x1.5fd4d21fab226p-6, +0x1.0c0a91c37851cp-61, +0x1p0, +-0x1.634bb4ae5ed49p-13, +-0x1.2d936bbe30efdp-6, +-0x1.b5f91ee371d64p-61, +0x1p0, +-0x1.ed7875885ea3ap-14, +-0x1.f6a296ab997cbp-7, +0x1.f2943d8fe7033p-61, +0x1p0, +-0x1.3bd2c8da49511p-14, +-0x1.921d1fcdec784p-7, +-0x1.9878ebe836d9dp-61, +0x1p0, +-0x1.634da1cec522dp-15, +-0x1.2d96b0e509703p-7, +0x1.1e9131ff52dc9p-63, +0x1p0, +-0x1.3bd38bab6d94cp-16, +-0x1.921f0fe670071p-8, +-0x1.ab967fe6b7a9bp-64, +0x1p0, +-0x1.3bd3bc5fc5ab4p-18, +-0x1.921f8becca4bap-9, +-0x1.2ba407bcab5b2p-63, +0x1p0, +0, +0, +0, +0x1p0, +-0x1.3bd3bc5fc5ab4p-18, +0x1.921f8becca4bap-9, +0x1.2ba407bcab5b2p-63, +0x1p0, +-0x1.3bd38bab6d94cp-16, +0x1.921f0fe670071p-8, +0x1.ab967fe6b7a9bp-64, +0x1p0, +-0x1.634da1cec522dp-15, +0x1.2d96b0e509703p-7, +-0x1.1e9131ff52dc9p-63, +0x1p0, +-0x1.3bd2c8da49511p-14, +0x1.921d1fcdec784p-7, +0x1.9878ebe836d9dp-61, +0x1p0, +-0x1.ed7875885ea3ap-14, +0x1.f6a296ab997cbp-7, +-0x1.f2943d8fe7033p-61, +0x1p0, +-0x1.634bb4ae5ed49p-13, +0x1.2d936bbe30efdp-6, +0x1.b5f91ee371d64p-61, +0x1p0, +-0x1.e3978f34889d9p-13, +0x1.5fd4d21fab226p-6, +-0x1.0c0a91c37851cp-61, +0x1p0, +-0x1.3bcfbd9979a27p-12, +0x1.92155f7a3667ep-6, +-0x1.b1d63091a013p-64, +0x1p0, +-0x1.8fb18eacc3af8p-12, +0x1.c454f4ce53b1dp-6, +-0x1.d63d7fef0e36cp-60, +0x1p0, +-0x1.ed71071603e86p-12, +0x1.f693731d1cf01p-6, +-0x1.3fe9bc66286c7p-66, +0x1p0, +-0x1.2a86f68094692p-11, +0x1.14685db42c17fp-5, +-0x1.2890d277cb974p-59, +0x1p0, +-0x1.6344004228d8bp-11, +0x1.2d865759455cdp-5, +0x1.686f65ba93acp-61, +0x1p0, +-0x1.a0ef7dcffafabp-11, +0x1.46a396ff86179p-5, +0x1.136ac00fa2da9p-61, +0x1p0, +-0x1.e389491f8833ap-11, +0x1.5fc00d290cd43p-5, +0x1.a2669a693a8e1p-59, +0x1p0, +-0x1.15889c8dd385fp-10, +0x1.78dbaa5874686p-5, +-0x1.4a0ef4035c29cp-60, +0x1p0, +-0x1.3bc390d250439p-10, +0x1.91f65f10dd814p-5, +-0x1.912bd0d569a9p-61, +0x1p0, +-0x1.647569c825ae1p-10, +0x1.ab101bd5f8317p-5, +-0x1.65c6175c6dc68p-59, +0x1p0, +-0x1.8f9e0e5514865p-10, +0x1.c428d12c0d7e3p-5, +-0x1.89bc74b58c513p-60, +0x1p0, +-0x1.bd3d63d9c26efp-10, +0x1.dd406f9808ec9p-5, +0x1.1313a4b4068bdp-62, +0x1p0, +-0x1.ed534e31ca57fp-10, +0x1.f656e79f820ep-5, +-0x1.2e1ebe392bffep-61, +0x1p0, +-0x1.0fefd7d9e6ed8p-9, +0x1.07b614e463064p-4, +-0x1.384f8c3ee7605p-58, +0x1p0, +-0x1.2a713498c3c3dp-9, +0x1.1440134d709b3p-4, +-0x1.fec446daea6adp-58, +0x1p0, +-0x1.462dacfbef0f3p-9, +0x1.20c9674ed444dp-4, +-0x1.f9d48faba7974p-58, +0x1p0, +-0x1.63252fe77c5ebp-9, +0x1.2d52092ce19f6p-4, +-0x1.9a088a8bf6b2cp-59, +0x1p0, +-0x1.8157ab7d29fd9p-9, +0x1.39d9f12c5a299p-4, +0x1.1287ff27ae554p-62, +0x1p0, +-0x1.a0c50d1c6bf93p-9, +0x1.4661179272096p-4, +-0x1.4b109f2406c4cp-58, +0x1p0, +-0x1.c16d4162779e5p-9, +0x1.52e774a4d4d0ap-4, +0x1.b2edf18c730cbp-60, +0x1p0, +-0x1.e350342a4f6e6p-9, +0x1.5f6d00a9aa419p-4, +-0x1.f4022d03f6c9ap-59, +0x1p0, +-0x1.0336e84667c66p-8, +0x1.6bf1b3e79b129p-4, +-0x1.14b6da08765p-58, +0x1p0, +-0x1.156300705d51bp-8, +0x1.787586a5d5b21p-4, +0x1.5f7589f083399p-58, +0x1p0, +-0x1.282c575d639fcp-8, +0x1.84f8712c130a1p-4, +-0x1.e626ebafe374ep-58, +0x1p0, +-0x1.3b92e176d6d31p-8, +0x1.917a6bc29b42cp-4, +-0x1.e2718d26ed688p-60, +0x1p0, +-0x1.4f9692c51b0fbp-8, +0x1.9dfb6eb24a85cp-4, +0x1.e96b47b8c44e6p-59, +0x1p0, +-0x1.64375eefa3dd6p-8, +0x1.aa7b724495c03p-4, +0x1.e5399ba0967b8p-58, +0x1p0, +-0x1.7975393cfbc4dp-8, +0x1.b6fa6ec38f64cp-4, +0x1.db5d943691f09p-58, +0x1p0, +-0x1.8f501492cc296p-8, +0x1.c3785c79ec2d5p-4, +-0x1.4f39df133fb21p-61, +0x1p0, +-0x1.a5c7e375e55dep-8, +0x1.cff533b307dc1p-4, +0x1.8feeb8f9c3334p-59, +0x1p0, +-0x1.bcdc980a46f5ap-8, +0x1.dc70ecbae9fc9p-4, +0x1.2fda2d73295eep-60, +0x1p0, +-0x1.d48e24132851p-8, +0x1.e8eb7fde4aa3fp-4, +-0x1.23758f2d5bb8bp-58, +0x1p0, +-0x1.ecdc78f30165cp-8, +0x1.f564e56a9730ep-4, +0x1.a2704729ae56dp-59, +0x1p0, +-0x1.02e3c3d5c9e17p-7, +0x1.00ee8ad6fb85bp-3, +0x1.673eac8308f11p-58, +0x1p0, +-0x1.0fa7a06ef9e81p-7, +0x1.072a047ba831dp-3, +0x1.19db1f70118cap-58, +0x1p0, +-0x1.1cb9ca654924fp-7, +0x1.0d64dbcb26786p-3, +-0x1.713a562132055p-58, +0x1p0, +-0x1.2a1a39a8a2fb7p-7, +0x1.139f0cedaf577p-3, +-0x1.523434d1b3cfap-57, +0x1p0, +-0x1.37c8e5f8aacep-7, +0x1.19d8940be24e7p-3, +0x1.e8dcdca90cc74p-58, +0x1p0, +-0x1.45c5c6e4c114ap-7, +0x1.20116d4ec7bcfp-3, +-0x1.242c8e1053452p-57, +0x1p0, +-0x1.5410d3cc0891ep-7, +0x1.264994dfd3409p-3, +0x1.a744ce26f39cp-57, +0x1p0, +-0x1.62aa03dd6ba58p-7, +0x1.2c8106e8e613ap-3, +0x1.13000a89a11ep-58, +0x1p0, +-0x1.71914e17a1bc6p-7, +0x1.32b7bf94516a7p-3, +0x1.2a24e2431ef29p-57, +0x1p0, +-0x1.80c6a94934dfp-7, +0x1.38edbb0cd8d14p-3, +-0x1.198c21fbf7718p-57, +0x1p0, +-0x1.904a0c10875cep-7, +0x1.3f22f57db4893p-3, +0x1.bfe7ff2274956p-59, +0x1p0, +-0x1.a01b6cdbd995ep-7, +0x1.45576b1293e5ap-3, +-0x1.285a24119f7b1p-58, +0x1p0, +-0x1.b03ac1e94fe1dp-7, +0x1.4b8b17f79fa88p-3, +0x1.b534fe588f0dp-57, +0x1p0, +-0x1.c0a80146f894cp-7, +0x1.51bdf8597c5f2p-3, +-0x1.9f9976af04aa5p-61, +0x1p0, +-0x1.d16320d2d221ep-7, +0x1.57f008654cbdep-3, +0x1.908c95c4c9118p-58, +0x1p0, +-0x1.e26c163ad15b3p-7, +0x1.5e214448b3fc6p-3, +0x1.531ff779ddac6p-57, +0x1p0, +-0x1.f3c2d6fce7cfap-7, +0x1.6451a831d830dp-3, +0x1.ad16031a34d5p-58, +0x1p0, +-0x1.02b3ac3385232p-6, +0x1.6a81304f64ab2p-3, +0x1.f0cd73fb5d8d4p-58, +0x1p0, +-0x1.0bacc7cb9babap-6, +0x1.70afd8d08c4ffp-3, +0x1.260c3f1369484p-57, +0x1p0, +-0x1.14ccb8bdbf114p-6, +0x1.76dd9de50bf31p-3, +0x1.1d5eeec501b2fp-57, +0x1p0, +-0x1.1e1379690291cp-6, +0x1.7d0a7bbd2cb1cp-3, +-0x1.cf900f27c58efp-57, +0x1p0, +-0x1.278104148891ap-6, +0x1.83366e89c64c6p-3, +-0x1.192952df10db8p-57, +0x1p0, +-0x1.311552ef8623cp-6, +0x1.8961727c41804p-3, +0x1.3fdab4e42640ap-58, +0x1p0, +-0x1.3ad06011469fbp-6, +0x1.8f8b83c69a60bp-3, +-0x1.26d19b9ff8d82p-57, +0x1p0, +-0x1.44b225792f46bp-6, +0x1.95b49e9b62afap-3, +-0x1.100b3d1dbfeaap-59, +0x1p0, +-0x1.4eba9d0ec2f7cp-6, +0x1.9bdcbf2dc4366p-3, +0x1.9632d189956fep-57, +0x1p0, +-0x1.58e9c0a1a5f21p-6, +0x1.a203e1b1831dap-3, +0x1.c1aadb580a1ecp-58, +0x1p0, +-0x1.633f89e9a1a66p-6, +0x1.a82a025b00451p-3, +-0x1.87905ffd084adp-57, +0x1p0, +-0x1.6dbbf286a8971p-6, +0x1.ae4f1d5f3b9abp-3, +0x1.aa8bbcef9b68ep-57, +0x1p0, +-0x1.785ef400da46cp-6, +0x1.b4732ef3d6722p-3, +0x1.bbe5d5d75cbd8p-57, +0x1p0, +-0x1.832887c88735dp-6, +0x1.ba96334f15dadp-3, +-0x1.75098c05dd18ap-57, +0x1p0, +-0x1.8e18a73634ee7p-6, +0x1.c0b826a7e4f63p-3, +-0x1.af1439e521935p-62, +0x1p0, +-0x1.992f4b8aa21f8p-6, +0x1.c6d90535d74ddp-3, +-0x1.bfb2be2264962p-59, +0x1p0, +-0x1.a46c6deecac5fp-6, +0x1.ccf8cb312b286p-3, +0x1.2382b0aecadf8p-58, +0x1p0, +-0x1.afd00773ec64fp-6, +0x1.d31774d2cbdeep-3, +0x1.2fdc8e5791a0bp-57, +0x1p0, +-0x1.bb5a11138a4c9p-6, +0x1.d934fe5454311p-3, +0x1.75b92277107adp-57, +0x1p0, +-0x1.c70a83af71ef5p-6, +0x1.df5163f01099ap-3, +-0x1.01f7d79906e86p-57, +0x1p0, +-0x1.d2e15811bf462p-6, +0x1.e56ca1e101a1bp-3, +0x1.46ac3f9fd0227p-57, +0x1p0, +-0x1.dede86ece142ep-6, +0x1.eb86b462de348p-3, +-0x1.bfcde46f90b62p-57, +0x1p0, +-0x1.eb0208db9e51bp-6, +0x1.f19f97b215f1bp-3, +-0x1.42deef11da2c4p-57, +0x1p0, +-0x1.f74bd66118e8dp-6, +0x1.f7b7480bd3802p-3, +-0x1.9a96d967ee12ep-57, +0x1p0, +-0x1.01ddf3f46a139p-5, +0x1.fdcdc1adfedf9p-3, +-0x1.2dba4580ed7bbp-57, +0x1p0, +-0x1.08291ae35c407p-5, +0x1.01f1806b9fdd2p-2, +-0x1.448135394b8bap-56, +0x1p0, +-0x1.0e875c1b8c3dap-5, +0x1.04fb80e37fdaep-2, +-0x1.412cdb72583ccp-63, +0x1p0, +-0x1.14f8b3af5abb9p-5, +0x1.0804e05eb661ep-2, +0x1.54e583d92d3d8p-56, +0x1p0, +-0x1.1b7d1da562443p-5, +0x1.0b0d9cfdbdb9p-2, +0x1.3b3a7b8d1200dp-58, +0x1p0, +-0x1.221495f879af5p-5, +0x1.0e15b4e1749cep-2, +-0x1.5b7fb156c550ap-56, +0x1p0, +-0x1.28bf1897b69ccp-5, +0x1.111d262b1f677p-2, +0x1.824c20ab7aa9ap-56, +0x1p0, +-0x1.2f7ca1666ff6fp-5, +0x1.1423eefc69378p-2, +0x1.22d3368ec9b62p-56, +0x1p0, +-0x1.364d2c3c407bep-5, +0x1.172a0d7765177p-2, +0x1.22575f33366bep-57, +0x1p0, +-0x1.3d30b4e5094ep-5, +0x1.1a2f7fbe8f243p-2, +0x1.6465ac86ba7b2p-56, +0x1p0, +-0x1.44273720f48bcp-5, +0x1.1d3443f4cdb3ep-2, +-0x1.720d41c13519ep-57, +0x1p0, +-0x1.4b30aea477eeep-5, +0x1.2038583d727bep-2, +-0x1.c69cd46300a3p-57, +0x1p0, +-0x1.524d171857726p-5, +0x1.233bbabc3bb71p-2, +0x1.99b04e23259efp-56, +0x1p0, +-0x1.597c6c19a8003p-5, +0x1.263e6995554bap-2, +0x1.1d350ffc5ff32p-56, +0x1p0, +-0x1.60bea939d225ap-5, +0x1.294062ed59f06p-2, +-0x1.5d28da2c4612dp-56, +0x1p0, +-0x1.6813c9fe94cfbp-5, +0x1.2c41a4e95452p-2, +0x1.9cf0354aad2dcp-56, +0x1p0, +-0x1.6f7bc9e2080d9p-5, +0x1.2f422daec0387p-2, +-0x1.7501ba473da6fp-56, +0x1p0, +-0x1.76f6a4529fdb5p-5, +0x1.3241fb638baafp-2, +0x1.ecee8f76f8c51p-60, +0x1p0, +-0x1.7e8454b32ef34p-5, +0x1.35410c2e18152p-2, +-0x1.3cb002f96e062p-56, +0x1p0, +-0x1.8624d65ae9a63p-5, +0x1.383f5e353b6abp-2, +-0x1.a812a4a5c3d44p-56, +0x1p0, +-0x1.8dd8249568bbbp-5, +0x1.3b3cefa0414b7p-2, +0x1.f36dc4a9c2294p-56, +0x1p0, +-0x1.959e3aa2ac58dp-5, +0x1.3e39be96ec271p-2, +0x1.814c6de9aaaf6p-56, +0x1p0, +-0x1.9d7713b71eee1p-5, +0x1.4135c94176601p-2, +0x1.0c97c4afa2518p-56, +0x1p0, +-0x1.a562aafb982cdp-5, +0x1.44310dc8936fp-2, +0x1.8b694e91d3125p-56, +0x1p0, +-0x1.ad60fb8d6003ap-5, +0x1.472b8a5571054p-2, +-0x1.01ea0fe4dff23p-56, +0x1p0, +-0x1.b572007e31a1bp-5, +0x1.4a253d11b82f3p-2, +-0x1.2afa4d6d42a55p-58, +0x1p0, +-0x1.bd95b4d43e819p-5, +0x1.4d1e24278e76ap-2, +0x1.2417218792858p-57, +0x1p0, +-0x1.c5cc138a317afp-5, +0x1.50163dc197048p-2, +-0x1.ec66cb05c7ea4p-56, +0x1p0, +-0x1.ce15178f31db3p-5, +0x1.530d880af3c24p-2, +-0x1.fab8e2103fbd6p-56, +0x1p0, +-0x1.d670bbc6e685ep-5, +0x1.5604012f467b4p-2, +0x1.a0e0b2a5b25p-56, +0x1p0, +-0x1.dedefb09791b4p-5, +0x1.58f9a75ab1fddp-2, +-0x1.efdc0d58cf62p-62, +0x1p0, +-0x1.e75fd0239926cp-5, +0x1.5bee78b9db3b6p-2, +0x1.e734a63158dfdp-58, +0x1p0, +-0x1.eff335d67f541p-5, +0x1.5ee27379ea693p-2, +0x1.634ff2fa75245p-56, +0x1p0, +-0x1.f89926d7f0ab8p-5, +0x1.61d595c88c202p-2, +0x1.f6b1e333415d7p-56, +0x1p0, +-0x1.00a8cee920eabp-4, +0x1.64c7ddd3f27c6p-2, +0x1.10d2b4a664121p-58, +0x1p0, +-0x1.050e4ab22d321p-4, +0x1.67b949cad63cbp-2, +-0x1.a23369348d7efp-56, +0x1p0, +-0x1.097d0410dc132p-4, +0x1.6aa9d7dc77e17p-2, +-0x1.38b470592c7b3p-56, +0x1p0, +-0x1.0df4f849393f5p-4, +0x1.6d998638a0cb6p-2, +-0x1.1ca14532860dfp-61, +0x1p0, +-0x1.127624999ee1dp-4, +0x1.7088530fa459fp-2, +-0x1.44b19e0864c5dp-56, +0x1p0, +-0x1.1700863ab7533p-4, +0x1.73763c9261092p-2, +-0x1.52324face3b1ap-57, +0x1p0, +-0x1.1b941a5f7ecffp-4, +0x1.766340f2418f6p-2, +0x1.2b2adc9041b2cp-56, +0x1p0, +-0x1.2030de354532cp-4, +0x1.794f5e613dfaep-2, +0x1.820a4b0d21fc5p-57, +0x1p0, +-0x1.24d6cee3afb2ap-4, +0x1.7c3a9311dcce7p-2, +0x1.9a3f21ef3e8d9p-62, +0x1p0, +-0x1.2985e98cbaa3ap-4, +0x1.7f24dd37341e4p-2, +0x1.2791a1b5eb796p-57, +0x1p0, +-0x1.2e3e2b4cbb3c3p-4, +0x1.820e3b04eaac4p-2, +-0x1.92379eb01c6b6p-59, +0x1p0, +-0x1.32ff913a615dp-4, +0x1.84f6aaaf3903fp-2, +0x1.6dcdc2bd47067p-57, +0x1p0, +-0x1.37ca1866b95cfp-4, +0x1.87de2a6aea963p-2, +-0x1.72cedd3d5a61p-57, +0x1p0, +-0x1.3c9dbddd2dd84p-4, +0x1.8ac4b86d5ed44p-2, +0x1.17fa7f944ad5bp-56, +0x1p0, +-0x1.417a7ea389835p-4, +0x1.8daa52ec8a4bp-2, +-0x1.72eb2db8c621ep-57, +0x1p0, +-0x1.466057b9f900ap-4, +0x1.908ef81ef7bd1p-2, +0x1.4c00267012357p-56, +0x1p0, +-0x1.4b4f461b0cbaap-4, +0x1.9372a63bc93d7p-2, +0x1.684319e5ad5b1p-57, +0x1p0, +-0x1.504746bbbac0bp-4, +0x1.96555b7ab948fp-2, +0x1.7afd51eff33adp-56, +0x1p0, +-0x1.5548568b60a7bp-4, +0x1.993716141bdffp-2, +-0x1.15e8cce261c55p-56, +0x1p0, +-0x1.5a527273c56e1p-4, +0x1.9c17d440df9f2p-2, +0x1.923c540a9eec4p-57, +0x1p0, +-0x1.5f6597591b633p-4, +0x1.9ef7943a8ed8ap-2, +0x1.6da81290bdbabp-57, +0x1p0, +-0x1.6481c21a02123p-4, +0x1.a1d6543b50acp-2, +-0x1.0246cfd8779fbp-57, +0x1p0, +-0x1.69a6ef8f8830ap-4, +0x1.a4b4127dea1e5p-2, +-0x1.bec6f01bc22f1p-56, +0x1p0, +-0x1.6ed51c8d2d8fcp-4, +0x1.a790cd3dbf31bp-2, +-0x1.7f786986d9023p-57, +0x1p0, +-0x1.740c45e0e512p-4, +0x1.aa6c82b6d3fcap-2, +-0x1.d5f106ee5ccf7p-56, +0x1p0, +-0x1.794c685316a3cp-4, +0x1.ad473125cdc09p-2, +-0x1.379ede57649dap-58, +0x1p0, +-0x1.7e9580a6a136ep-4, +0x1.b020d6c7f4009p-2, +0x1.414ae7e555208p-58, +0x1p0, +-0x1.83e78b98dcc2bp-4, +0x1.b2f971db31972p-2, +0x1.fa971a4a41f2p-56, +0x1p0, +-0x1.894285e19c468p-4, +0x1.b5d1009e15ccp-2, +0x1.5b362cb974183p-57, +0x1p0, +-0x1.8ea66c332fd01p-4, +0x1.b8a7814fd5693p-2, +0x1.9a9e6651cc119p-56, +0x1p0, +-0x1.94133b3a66851p-4, +0x1.bb7cf2304bd01p-2, +0x1.9e1a5bd9269d4p-57, +0x1p0, +-0x1.9988ef9e90b04p-4, +0x1.be51517ffc0d9p-2, +0x1.2b667131a5f16p-56, +0x1p0, +-0x1.9f07860181d1ep-4, +0x1.c1249d8011ee7p-2, +-0x1.813aabb515206p-56, +0x1p0, +-0x1.a48efaff92b3bp-4, +0x1.c3f6d47263129p-2, +0x1.9c7bd0fcdecddp-56, +0x1p0, +-0x1.aa1f4b2fa37fcp-4, +0x1.c6c7f4997000bp-2, +-0x1.bec2669c68e74p-56, +0x1p0, +-0x1.afb873231ddb9p-4, +0x1.c997fc3865389p-2, +-0x1.6295f8b0ca33bp-56, +0x1p0, +-0x1.b55a6f65f7058p-4, +0x1.cc66e9931c45ep-2, +0x1.6850e59c37f8fp-58, +0x1p0, +-0x1.bb053c7eb1f68p-4, +0x1.cf34baee1cd21p-2, +-0x1.118724d19d014p-56, +0x1p0, +-0x1.c0b8d6ee61867p-4, +0x1.d2016e8e9db5bp-2, +-0x1.c8bce9d93efb8p-57, +0x1p0, +-0x1.c6753b30aa949p-4, +0x1.d4cd02ba8609dp-2, +-0x1.37f33c63033d6p-57, +0x1p0, +-0x1.cc3a65bbc6327p-4, +0x1.d79775b86e389p-2, +0x1.550ec87bc0575p-56, +0x1p0, +-0x1.d208530083d3p-4, +0x1.da60c5cfa10d9p-2, +-0x1.0f38e2143c8d5p-57, +0x1p0, +-0x1.d7deff6a4b7c9p-4, +0x1.dd28f1481cc58p-2, +-0x1.e7576fa6c944ep-59, +0x1p0, +-0x1.ddbe675f1ffdfp-4, +0x1.dfeff66a941dep-2, +-0x1.a756c6e625f96p-56, +0x1p0, +-0x1.e3a6873fa1279p-4, +0x1.e2b5d3806f63bp-2, +0x1.e0d891d3c6841p-58, +0x1p0, +-0x1.e9975b670e077p-4, +0x1.e57a86d3cd825p-2, +-0x1.2c80dcd511e87p-57, +0x1p0, +-0x1.ef90e02b47283p-4, +0x1.e83e0eaf85114p-2, +-0x1.7bc380ef24ba7p-57, +0x1p0, +-0x1.f59311dcd0d44p-4, +0x1.eb00695f2562p-2, +0x1.53c9fd3083e22p-56, +0x1p0, +-0x1.fb9decc6d55b8p-4, +0x1.edc1952ef78d6p-2, +-0x1.dd0f7c33edee6p-56, +0x1p0, +-0x1.00d8b69793ae4p-3, +0x1.f081906bff7fep-2, +-0x1.4cab2d4ff6fccp-56, +0x1p0, +-0x1.03e6c7ab2208cp-3, +0x1.f3405963fd067p-2, +0x1.06846d44a238fp-56, +0x1p0, +-0x1.06f927bbaacfep-3, +0x1.f5fdee656cda3p-2, +-0x1.7bf9780816b05p-58, +0x1p0, +-0x1.0a0fd4e41ab5ap-3, +0x1.f8ba4dbf89abap-2, +-0x1.2ec1fc1b776b8p-60, +0x1p0, +-0x1.0d2acd3cb7364p-3, +0x1.fb7575c24d2dep-2, +-0x1.5bfdc883c8664p-57, +0x1p0, +-0x1.104a0edb1fc58p-3, +0x1.fe2f64be7121p-2, +-0x1.297ab1ca2d7dbp-56, +0x1p0, +-0x1.136d97d24efccp-3, +0x1.00740c82b82e1p-1, +-0x1.6d48563c60e87p-55, +0x1p0, +-0x1.169566329bcb7p-3, +0x1.01cfc874c3eb7p-1, +-0x1.34a35e7c2368cp-56, +0x1p0, +-0x1.19c17809baa87p-3, +0x1.032ae55edbd96p-1, +-0x1.bdb022b40107ap-55, +0x1p0, +-0x1.1cf1cb62bec5dp-3, +0x1.0485626ae221ap-1, +0x1.b937d9091ff7p-55, +0x1p0, +-0x1.20265e461b45ap-3, +0x1.05df3ec31b8b7p-1, +-0x1.e2dcad34d9c1dp-57, +0x1p0, +-0x1.235f2eb9a470ap-3, +0x1.073879922ffeep-1, +-0x1.a5a014347406cp-55, +0x1p0, +-0x1.269c3ac090ee4p-3, +0x1.089112032b08cp-1, +0x1.3248ddf9fe619p-57, +0x1p0, +-0x1.29dd805b7afecp-3, +0x1.09e907417c5e1p-1, +-0x1.fe573741a9bd4p-55, +0x1p0, +-0x1.2d22fd8861b6bp-3, +0x1.0b405878f85ecp-1, +-0x1.ad66c3bb80da5p-55, +0x1p0, +-0x1.306cb042aa3bap-3, +0x1.0c9704d5d898fp-1, +-0x1.8d3d7de6ee9b2p-55, +0x1p0, +-0x1.33ba968321032p-3, +0x1.0ded0b84bc4b6p-1, +-0x1.8540fa327c55cp-55, +0x1p0, +-0x1.370cae3ffb12fp-3, +0x1.0f426bb2a8e7ep-1, +-0x1.bb58fb774f8eep-55, +0x1p0, +-0x1.3a62f56cd742ep-3, +0x1.1097248d0a957p-1, +-0x1.7a58759ba80ddp-55, +0x1p0, +-0x1.3dbd69fabf802p-3, +0x1.11eb3541b4b23p-1, +-0x1.ef23b69abe4f1p-55, +0x1p0, +-0x1.411c09d82a128p-3, +0x1.133e9cfee254fp-1, +-0x1.a1377cfd5ce5p-56, +0x1p0, +-0x1.447ed2f0fae31p-3, +0x1.14915af336cebp-1, +0x1.f3660558a0213p-56, +0x1p0, +-0x1.47e5c32e84c45p-3, +0x1.15e36e4dbe2bcp-1, +0x1.3c545f7d79eaep-56, +0x1p0, +-0x1.4b50d8778abbdp-3, +0x1.1734d63dedb49p-1, +-0x1.7eef2ccc50575p-55, +0x1p0, +-0x1.4ec010b0414e1p-3, +0x1.188591f3a46e5p-1, +-0x1.bbefe5a524346p-56, +0x1p0, +-0x1.523369ba4fcaep-3, +0x1.19d5a09f2b9b8p-1, +-0x1.33656c68a1d4ap-57, +0x1p0, +-0x1.55aae174d19c8p-3, +0x1.1b250171373bfp-1, +-0x1.b210e95e1ca4cp-55, +0x1p0, +-0x1.592675bc57974p-3, +0x1.1c73b39ae68c8p-1, +0x1.b25dd267f66p-55, +0x1p0, +-0x1.5ca6246ae94b8p-3, +0x1.1dc1b64dc4872p-1, +0x1.f15e1c468be78p-57, +0x1p0, +-0x1.6029eb580658ep-3, +0x1.1f0f08bbc861bp-1, +-0x1.10d9dcafb74cbp-57, +0x1p0, +-0x1.63b1c858a7c2ep-3, +0x1.205baa17560d6p-1, +0x1.b7b144016c7a3p-56, +0x1p0, +-0x1.673db93f41479p-3, +0x1.21a799933eb59p-1, +-0x1.3a7b177c68fb2p-55, +0x1p0, +-0x1.6acdbbdbc2b73p-3, +0x1.22f2d662c13e2p-1, +-0x1.d5cc7580cb6d2p-55, +0x1p0, +-0x1.6e61cdfb994dfp-3, +0x1.243d5fb98ac1fp-1, +0x1.c533d0a284a8dp-56, +0x1p0, +-0x1.71f9ed69b10eap-3, +0x1.258734cbb711p-1, +0x1.3a3f0903ce09dp-57, +0x1p0, +-0x1.759617ee761f9p-3, +0x1.26d054cdd12dfp-1, +-0x1.5da743ef3770cp-55, +0x1p0, +-0x1.79364b4fd6288p-3, +0x1.2818bef4d3cbap-1, +-0x1.e3fffeb76568ap-56, +0x1p0, +-0x1.7cda855141b26p-3, +0x1.2960727629ca8p-1, +0x1.56d6c7af02d5cp-56, +0x1p0, +-0x1.8082c3b3ad887p-3, +0x1.2aa76e87aeb58p-1, +0x1.fd600833287a7p-59, +0x1p0, +-0x1.842f0435941afp-3, +0x1.2bedb25faf3eap-1, +-0x1.14981c796ee46p-58, +0x1p0, +-0x1.87df4492f6e38p-3, +0x1.2d333d34e9bb8p-1, +-0x1.0e2c2c5549e26p-55, +0x1p0, +-0x1.8b9382855fcaap-3, +0x1.2e780e3e8ea17p-1, +-0x1.b19fafe36587ap-55, +0x1p0, +-0x1.8f4bbbc3e28f6p-3, +0x1.2fbc24b441015p-1, +0x1.dba4875410874p-57, +0x1p0, +-0x1.9307ee031e2fdp-3, +0x1.30ff7fce17035p-1, +-0x1.efcc626f74a6fp-57, +0x1p0, +-0x1.96c816f53e539p-3, +0x1.32421ec49a61fp-1, +0x1.65e25cc951bfep-55, +0x1p0, +-0x1.9a8c3449fcb77p-3, +0x1.338400d0c8e57p-1, +-0x1.abf2a5e95e6e5p-55, +0x1p0, +-0x1.9e5443aea29b2p-3, +0x1.34c5252c14de1p-1, +0x1.583f49632ab2bp-55, +0x1p0, +-0x1.a22042ce0a2f9p-3, +0x1.36058b10659f3p-1, +-0x1.1fcb3a35857e7p-55, +0x1p0, +-0x1.a5f02f50a007cp-3, +0x1.374531b817f8dp-1, +0x1.444d2b0a747fep-55, +0x1p0, +-0x1.a9c406dc648a5p-3, +0x1.3884185dfeb22p-1, +-0x1.a038026abe6b2p-56, +0x1p0, +-0x1.ad9bc714ed64fp-3, +0x1.39c23e3d63029p-1, +-0x1.3b05b276085c1p-58, +0x1p0, +-0x1.b1776d9b67013p-3, +0x1.3affa292050b9p-1, +0x1.e3e25e3954964p-56, +0x1p0, +-0x1.b556f80e95facp-3, +0x1.3c3c44981c518p-1, +-0x1.b5e9a9644151bp-55, +0x1p0, +-0x1.b93a640ad8978p-3, +0x1.3d78238c58344p-1, +-0x1.0219f5f0f79cep-55, +0x1p0, +-0x1.bd21af2a28408p-3, +0x1.3eb33eabe068p-1, +0x1.86a2357d1a0d3p-58, +0x1p0, +-0x1.c10cd7041afccp-3, +0x1.3fed9534556d4p-1, +0x1.36916608c5061p-55, +0x1p0, +-0x1.c4fbd92de4eddp-3, +0x1.41272663d108cp-1, +0x1.1bbe7636fadf5p-55, +0x1p0, +-0x1.c8eeb33a59cdp-3, +0x1.425ff178e6bb1p-1, +0x1.7b38d675140cap-55, +0x1p0, +-0x1.cce562b9ee6aep-3, +0x1.4397f5b2a438p-1, +-0x1.7274c9e48c226p-55, +0x1p0, +-0x1.d0dfe53aba2fdp-3, +0x1.44cf325091dd6p-1, +0x1.8076a2cfdc6b3p-57, +0x1p0, +-0x1.d4de3848789e2p-3, +0x1.4605a692b32a2p-1, +0x1.21ca219b97107p-55, +0x1p0, +-0x1.d8e0596c8ad56p-3, +0x1.473b51b987347p-1, +0x1.ca1953514e41bp-57, +0x1p0, +-0x1.dce6462df917dp-3, +0x1.48703306091ffp-1, +-0x1.70813b86159fdp-57, +0x1p0, +-0x1.e0effc1174505p-3, +0x1.49a449b9b0939p-1, +-0x1.27ee16d719b94p-55, +0x1p0, +-0x1.e4fd7899579acp-3, +0x1.4ad79516722f1p-1, +-0x1.1273b163000f7p-55, +0x1p0, +-0x1.e90eb945a9ccfp-3, +0x1.4c0a145ec0004p-1, +0x1.2630cfafceaa1p-58, +0x1p0, +-0x1.ed23bb941f019p-3, +0x1.4d3bc6d589f7fp-1, +0x1.6e4d9d6b72011p-55, +0x1p0, +-0x1.f13c7d001a249p-3, +0x1.4e6cabbe3e5e9p-1, +0x1.3c293edceb327p-57, +0x1p0, +-0x1.f558fb02ae805p-3, +0x1.4f9cc25cca486p-1, +0x1.48b5951cfc2b5p-55, +0x1p0, +-0x1.f9793312a14d1p-3, +0x1.50cc09f59a09bp-1, +0x1.693463a2c2e6fp-56, +0x1p0, +-0x1.fd9d22a46b416p-3, +0x1.51fa81cd99aa6p-1, +-0x1.499f59d8560e9p-63, +0x1p0, +-0x1.00e263951d11fp-2, +0x1.5328292a35596p-1, +-0x1.a12eb89da0257p-56, +0x1p0, +-0x1.02f80f09f92f4p-2, +0x1.5454ff5159dfcp-1, +-0x1.4e247588bf256p-55, +0x1p0, +-0x1.050f92679849cp-2, +0x1.5581038975137p-1, +0x1.4570d9efe26dfp-55, +0x1p0, +-0x1.0728ec63a599ap-2, +0x1.56ac35197649fp-1, +-0x1.f7874188cb279p-55, +0x1p0, +-0x1.09441bb2aa0a2p-2, +0x1.57d69348cecap-1, +-0x1.75720992bfbb2p-55, +0x1p0, +-0x1.0b611f080d05bp-2, +0x1.59001d5f723dfp-1, +0x1.a9f86ba0dde98p-56, +0x1p0, +-0x1.0d7ff51615437p-2, +0x1.5a28d2a5d725p-1, +0x1.57a25f8b1343p-55, +0x1p0, +-0x1.0fa09c8de994bp-2, +0x1.5b50b264f7448p-1, +0x1.519d30d4cfebp-56, +0x1p0, +-0x1.11c3141f91b3ep-2, +0x1.5c77bbe65018cp-1, +0x1.069ea9c0bc32ap-55, +0x1p0, +-0x1.13e75a79f7139p-2, +0x1.5d9dee73e345cp-1, +-0x1.de1165ecdf7a3p-57, +0x1p0, +-0x1.160d6e4ae5ae6p-2, +0x1.5ec3495837074p-1, +0x1.dea89a9b8f727p-56, +0x1p0, +-0x1.18354e3f0cd7dp-2, +0x1.5fe7cbde56a1p-1, +-0x1.fcb9cc30cc01ep-55, +0x1p0, +-0x1.1a5ef902000d3p-2, +0x1.610b7551d2cdfp-1, +-0x1.251b352ff2a37p-56, +0x1p0, +-0x1.1c8a6d3e37c82p-2, +0x1.622e44fec22ffp-1, +0x1.f98d8be132d57p-56, +0x1p0, +-0x1.1eb7a99d1250cp-2, +0x1.63503a31c1be9p-1, +0x1.1248f09e6587cp-57, +0x1p0, +-0x1.20e6acc6d4916p-2, +0x1.64715437f535bp-1, +-0x1.7c399c15a17dp-55, +0x1p0, +-0x1.23177562aaea3p-2, +0x1.6591925f0783dp-1, +0x1.c3d64fbf5de23p-55, +0x1p0, +-0x1.254a0216aa067p-2, +0x1.66b0f3f52b386p-1, +0x1.1e2eb31a8848bp-55, +0x1p0, +-0x1.277e5187cfb16p-2, +0x1.67cf78491af1p-1, +0x1.750ab23477b61p-59, +0x1p0, +-0x1.29b4625a03ac9p-2, +0x1.68ed1eaa19c71p-1, +0x1.fd4a85350f69p-56, +0x1p0, +0, +0x1.6a09e667f3bcdp-1, +-0x1.bdd3413b26456p-55, +0, +0x1.a3b47aa8671c5p-3, +0x1.6b25ced2fe29cp-1, +-0x1.5ac64116beda5p-55, +0x1p-1, +0x1.9f3de1246bc4p-3, +0x1.6c40d73c18275p-1, +0x1.25d4f802be257p-57, +0x1p-1, +0x1.9ac3cfd4ace19p-3, +0x1.6d5afef4aafcdp-1, +-0x1.868a696b8835ep-55, +0x1p-1, +0x1.9646497c1e0f6p-3, +0x1.6e74454eaa8afp-1, +-0x1.dbc03c84e226ep-55, +0x1p-1, +0x1.91c550dfd4d6bp-3, +0x1.6f8ca99c95b75p-1, +0x1.f22e7a35723f4p-56, +0x1p-1, +0x1.8d40e8c706fa4p-3, +0x1.70a42b3176d7ap-1, +-0x1.d9e3fbe2e15ap-56, +0x1p-1, +0x1.88b913fb08bfdp-3, +0x1.71bac960e41bfp-1, +-0x1.b858d90b0f7d8p-56, +0x1p-1, +0x1.842dd5474b37bp-3, +0x1.72d0837efff96p-1, +0x1.0d4ef0f1d915cp-55, +0x1p-1, +0x1.7f9f2f795a83ep-3, +0x1.73e558e079942p-1, +-0x1.2663126697f5ep-55, +0x1p-1, +0x1.7b0d2560dc1d1p-3, +0x1.74f948da8d28dp-1, +0x1.19900a3b9a3a2p-63, +0x1p-1, +0x1.7677b9cf8d17p-3, +0x1.760c52c304764p-1, +-0x1.11d76f8e50f1fp-55, +0x1p-1, +0x1.71deef9940631p-3, +0x1.771e75f037261p-1, +0x1.5cfce8d84068fp-56, +0x1p-1, +0x1.6d42c993dd121p-3, +0x1.782fb1b90b35bp-1, +-0x1.3e46c1dfd001cp-55, +0x1p-1, +0x1.68a34a975c941p-3, +0x1.79400574f55e5p-1, +-0x1.0adadbdb4c65ap-55, +0x1p-1, +0x1.6400757dc8f7dp-3, +0x1.7a4f707bf97d2p-1, +0x1.3c9751b491eafp-55, +0x1p-1, +0x1.5f5a4d233b27fp-3, +0x1.7b5df226aafafp-1, +-0x1.0f537acdf0ad7p-56, +0x1p-1, +0x1.5ab0d465d927ap-3, +0x1.7c6b89ce2d333p-1, +-0x1.cfd628084982cp-56, +0x1p-1, +0x1.56040e25d44ddp-3, +0x1.7d7836cc33db2p-1, +0x1.162715ef03f85p-56, +0x1p-1, +0x1.5153fd45677efp-3, +0x1.7e83f87b03686p-1, +0x1.b61a8ccabad6p-57, +0x1p-1, +0x1.4ca0a4a8d5657p-3, +0x1.7f8ece3571771p-1, +-0x1.9c8d8ce93c917p-55, +0x1p-1, +0x1.47ea073666a98p-3, +0x1.8098b756e52fap-1, +0x1.9136e834b4707p-55, +0x1p-1, +0x1.433027d66826dp-3, +0x1.81a1b33b57accp-1, +-0x1.5dea12d66bb66p-55, +0x1p-1, +0x1.3e73097329219p-3, +0x1.82a9c13f545ffp-1, +-0x1.65e87a7a8cde9p-56, +0x1p-1, +0x1.39b2aef8f97a4p-3, +0x1.83b0e0bff976ep-1, +-0x1.6f420f8ea3475p-56, +0x1p-1, +0x1.34ef1b5627dfdp-3, +0x1.84b7111af83fap-1, +-0x1.63a47df0b21bap-55, +0x1p-1, +0x1.3028517b0001p-3, +0x1.85bc51ae958ccp-1, +0x1.45ba6478086ccp-55, +0x1p-1, +0x1.2b5e5459c8bc3p-3, +0x1.86c0a1d9aa195p-1, +0x1.84564f09c3726p-59, +0x1p-1, +0x1.269126e6c24e3p-3, +0x1.87c400fba2ebfp-1, +-0x1.2dabc0c3f64cdp-55, +0x1p-1, +0x1.21c0cc18247fcp-3, +0x1.88c66e7481ba1p-1, +-0x1.5c6228970cf35p-56, +0x1p-1, +0x1.1ced46e61cd1cp-3, +0x1.89c7e9a4dd4aap-1, +0x1.db6ea04a8678fp-55, +0x1p-1, +0x1.18169a4acca89p-3, +0x1.8ac871ede1d88p-1, +-0x1.9afaa5b7cfc55p-55, +0x1p-1, +0x1.133cc94247758p-3, +0x1.8bc806b151741p-1, +-0x1.2c5e12ed1336dp-55, +0x1p-1, +0x1.0e5fd6ca90dffp-3, +0x1.8cc6a75184655p-1, +-0x1.e18b3657e2285p-55, +0x1p-1, +0x1.097fc5e39aec5p-3, +0x1.8dc45331698ccp-1, +0x1.1d9fcd83634d7p-57, +0x1p-1, +0x1.049c998f44231p-3, +0x1.8ec109b486c49p-1, +-0x1.cb2a3eb6af617p-56, +0x1p-1, +0x1.ff6ca9a2ab6a2p-4, +0x1.8fbcca3ef940dp-1, +-0x1.6dfa99c86f2f1p-57, +0x1p-1, +0x1.f599f55f034p-4, +0x1.90b7943575efep-1, +0x1.4ecb0c5273706p-57, +0x1p-1, +0x1.ebc11c62c1a1ep-4, +0x1.91b166fd49da2p-1, +-0x1.3be953a7fe996p-57, +0x1p-1, +0x1.e1e224c0e28bdp-4, +0x1.92aa41fc5a815p-1, +-0x1.68f89e2d23db7p-57, +0x1p-1, +0x1.d7fd1490285cap-4, +0x1.93a22499263fbp-1, +0x1.3d419a920df0bp-55, +0x1p-1, +0x1.ce11f1eb18148p-4, +0x1.94990e3ac4a6cp-1, +0x1.a95328edeb3e6p-56, +0x1p-1, +0x1.c420c2eff590ep-4, +0x1.958efe48e6dd7p-1, +-0x1.561335da0f4e7p-55, +0x1p-1, +0x1.ba298dc0bfc6bp-4, +0x1.9683f42bd7fe1p-1, +-0x1.11bad933c835ep-57, +0x1p-1, +0x1.b02c58832cf96p-4, +0x1.9777ef4c7d742p-1, +-0x1.15479a240665ep-55, +0x1p-1, +0x1.a6292960a6f0bp-4, +0x1.986aef1457594p-1, +-0x1.af03e318f38fcp-55, +0x1p-1, +0x1.9c200686472b5p-4, +0x1.995cf2ed80d22p-1, +0x1.7783e907fbd7bp-56, +0x1p-1, +0x1.9210f624d30fbp-4, +0x1.9a4dfa42b06b2p-1, +-0x1.829b6b8b1c947p-56, +0x1p-1, +0x1.87fbfe70b81a7p-4, +0x1.9b3e047f38741p-1, +-0x1.30ee286712474p-55, +0x1p-1, +0x1.7de125a2080a9p-4, +0x1.9c2d110f075c2p-1, +0x1.d9c9f1c8c30dp-55, +0x1p-1, +0x1.73c071f4750b5p-4, +0x1.9d1b1f5ea80d5p-1, +0x1.c5fadd5ffb36fp-55, +0x1p-1, +0x1.6999e9a74ddbep-4, +0x1.9e082edb42472p-1, +0x1.5809a4e121e22p-57, +0x1p-1, +0x1.5f6d92fd79f5p-4, +0x1.9ef43ef29af94p-1, +0x1.b1dfcb60445c2p-56, +0x1p-1, +0x1.553b743d75acp-4, +0x1.9fdf4f13149dep-1, +0x1.1e6d79006ec09p-55, +0x1p-1, +0x1.4b0393b14e541p-4, +0x1.a0c95eabaf937p-1, +-0x1.e0ca3acbd049ap-55, +0x1p-1, +0x1.40c5f7a69e5cep-4, +0x1.a1b26d2c0a75ep-1, +0x1.30ef431d627a6p-57, +0x1p-1, +0x1.3682a66e896f5p-4, +0x1.a29a7a0462782p-1, +-0x1.128bb015df175p-56, +0x1p-1, +0x1.2c39a65db8881p-4, +0x1.a38184a593bc6p-1, +-0x1.bc92c5bd2d288p-55, +0x1p-1, +0x1.21eafdcc560fap-4, +0x1.a4678c8119ac8p-1, +0x1.1b4c0dd3f212ap-55, +0x1p-1, +0x1.1796b31609f0cp-4, +0x1.a54c91090f523p-1, +0x1.184300fd1c1cep-56, +0x1p-1, +0x1.0d3ccc99f5ac6p-4, +0x1.a63091b02fae2p-1, +-0x1.e911152248d1p-56, +0x1p-1, +0x1.02dd50bab06b2p-4, +0x1.a7138de9d60f5p-1, +-0x1.f1ab82a9c5f2dp-55, +0x1p-1, +0x1.f0f08bbc861afp-5, +0x1.a7f58529fe69dp-1, +-0x1.97a441584a179p-55, +0x1p-1, +0x1.dc1b64dc48722p-5, +0x1.a8d676e545ad2p-1, +-0x1.b11dcce2e74bdp-59, +0x1p-1, +0x1.c73b39ae68c87p-5, +0x1.a9b66290ea1a3p-1, +0x1.9f630e8b6dac8p-60, +0x1p-1, +0x1.b250171373be9p-5, +0x1.aa9547a2cb98ep-1, +0x1.87d00ae97abaap-60, +0x1p-1, +0x1.9d5a09f2b9b7fp-5, +0x1.ab7325916c0d4p-1, +0x1.a8b8c85baaa9bp-55, +0x1p-1, +0x1.88591f3a46e4dp-5, +0x1.ac4ffbd3efac8p-1, +-0x1.818504103fa16p-56, +0x1p-1, +0x1.734d63dedb48ap-5, +0x1.ad2bc9e21d511p-1, +-0x1.47fbe07bea548p-55, +0x1p-1, +0x1.5e36e4dbe2bc2p-5, +0x1.ae068f345ecefp-1, +-0x1.33934c4029a4cp-56, +0x1p-1, +0x1.4915af336ceb4p-5, +0x1.aee04b43c1474p-1, +-0x1.3a79a438bf8ccp-55, +0x1p-1, +0x1.33e9cfee254edp-5, +0x1.afb8fd89f57b6p-1, +0x1.1ced12d2899b8p-60, +0x1p-1, +0x1.1eb3541b4b228p-5, +0x1.b090a581502p-1, +-0x1.926da300ffccep-55, +0x1p-1, +0x1.097248d0a956ap-5, +0x1.b16742a4ca2f5p-1, +-0x1.ba70972b80438p-55, +0x1p-1, +0x1.e84d76551cfb2p-6, +0x1.b23cd470013b4p-1, +0x1.5a1bb35ad6d2ep-56, +0x1p-1, +0x1.bda17097896b4p-6, +0x1.b3115a5f37bf3p-1, +0x1.dde2726e34fe1p-55, +0x1p-1, +0x1.92e09abb131d4p-6, +0x1.b3e4d3ef55712p-1, +-0x1.eb6b8bf11a493p-55, +0x1p-1, +0x1.680b0f1f0bd73p-6, +0x1.b4b7409de7925p-1, +0x1.f4e257bde73d8p-56, +0x1p-1, +0x1.3d20e82f8bc1p-6, +0x1.b5889fe921405p-1, +-0x1.df49b307c8602p-57, +0x1p-1, +0x1.1222406561182p-6, +0x1.b658f14fdbc47p-1, +0x1.52b5308f397dep-57, +0x1p-1, +0x1.ce1e648bffb66p-7, +0x1.b728345196e3ep-1, +-0x1.bc69f324e6d61p-55, +0x1p-1, +0x1.77cfb0c6e2db8p-7, +0x1.b7f6686e792e9p-1, +0x1.87665bfea06aap-55, +0x1p-1, +0x1.21589ab88869cp-7, +0x1.b8c38d27504e9p-1, +-0x1.1529abff40e45p-55, +0x1p-1, +0x1.9572af6decac8p-8, +0x1.b98fa1fd9155ep-1, +0x1.5559034fe85a4p-55, +0x1p-1, +0x1.cfc874c3eb6d9p-9, +0x1.ba5aa673590d2p-1, +0x1.7ea4e370753b6p-55, +0x1p-1, +0x1.d0320ae0b8293p-11, +0x1.bb249a0b6c40dp-1, +-0x1.d6318ee919f7ap-58, +0x1p-1, +-0x1.d09b418edf04ap-10, +0x1.bbed7c49380eap-1, +0x1.beacbd88500b4p-59, +0x1p-1, +-0x1.22a28f6cb488bp-8, +0x1.bcb54cb0d2327p-1, +0x1.410923c55523ep-62, +0x1p-1, +-0x1.d16c901d95181p-8, +0x1.bd7c0ac6f952ap-1, +-0x1.825a732ac700ap-55, +0x1p-1, +-0x1.4042335264ba3p-7, +0x1.be41b611154c1p-1, +-0x1.fdcdad3a6877ep-55, +0x1p-1, +-0x1.97f4d3805f318p-7, +0x1.bf064e15377ddp-1, +0x1.2156026a1e028p-57, +0x1p-1, +-0x1.efcdf2801004ap-7, +0x1.bfc9d25a1b147p-1, +-0x1.51bf4ee01357p-61, +0x1p-1, +-0x1.23e6ad10872a7p-6, +0x1.c08c426725549p-1, +0x1.b157fd80e2946p-58, +0x1p-1, +-0x1.4ff96a0da9dfbp-6, +0x1.c14d9dc465e57p-1, +0x1.ce36b64c7f3ccp-55, +0x1p-1, +-0x1.7c1f1507aeec3p-6, +0x1.c20de3fa971bp-1, +-0x1.b4ca2bab1322cp-55, +0x1p-1, +-0x1.a85792c327db2p-6, +0x1.c2cd14931e3f1p-1, +0x1.2ce2f9d4600f5p-56, +0x1p-1, +-0x1.d4a2c7f909c4ep-6, +0x1.c38b2f180bdb1p-1, +-0x1.6e0b1757c8d07p-56, +0x1p-1, +-0x1.00804cab5f113p-5, +0x1.c44833141c004p-1, +0x1.23e0521df01a2p-56, +0x1p-1, +-0x1.16b875bf19d4p-5, +0x1.c5042012b6907p-1, +-0x1.5c058dd8eaba5p-57, +0x1p-1, +-0x1.2cf9d182f7939p-5, +0x1.c5bef59fef85ap-1, +-0x1.f0a406c8b7468p-58, +0x1p-1, +-0x1.4344523c8e3b5p-5, +0x1.c678b3488739bp-1, +0x1.d86cac7c5ff5bp-57, +0x1p-1, +-0x1.5997ea2bcfb19p-5, +0x1.c7315899eaad7p-1, +-0x1.9be5dcd047da7p-57, +0x1p-1, +-0x1.6ff48b8b1252ap-5, +0x1.c7e8e52233cf3p-1, +0x1.b2ad324aa35c1p-57, +0x1p-1, +-0x1.865a288f196fap-5, +0x1.c89f587029c13p-1, +0x1.588358ed6e78fp-58, +0x1p-1, +-0x1.9cc8b3671dd0fp-5, +0x1.c954b213411f5p-1, +-0x1.2fb761e946603p-58, +0x1p-1, +-0x1.b3401e3cd63bbp-5, +0x1.ca08f19b9c449p-1, +-0x1.431e0a5a737fdp-56, +0x1p-1, +-0x1.c9c05b347ffabp-5, +0x1.cabc169a0b9p-1, +0x1.c42d3e10851d1p-55, +0x1p-1, +-0x1.e0495c6ce76b5p-5, +0x1.cb6e20a00da99p-1, +-0x1.4fb24b5194c1bp-55, +0x1p-1, +-0x1.f6db13ff708cbp-5, +0x1.cc1f0f3fcfc5cp-1, +0x1.e57613b68f6abp-56, +0x1p-1, +-0x1.06baba000fc9bp-4, +0x1.cccee20c2deap-1, +-0x1.d3116ae0e69e4p-55, +0x1p-1, +-0x1.120c373ed0bfbp-4, +0x1.cd7d9898b32f6p-1, +-0x1.f2fa062496738p-57, +0x1p-1, +-0x1.1d61fac0aa5b2p-4, +0x1.ce2b32799a06p-1, +-0x1.631d457e46317p-56, +0x1p-1, +-0x1.28bbfd87a8cffp-4, +0x1.ced7af43cc773p-1, +-0x1.e7b6bb5ab58aep-58, +0x1p-1, +-0x1.341a389339a36p-4, +0x1.cf830e8ce467bp-1, +-0x1.7b9202780d49dp-55, +0x1p-1, +-0x1.3f7ca4e02ffdcp-4, +0x1.d02d4feb2bd92p-1, +0x1.195ff41bc55fep-55, +0x1p-1, +-0x1.4ae33b68c8fdcp-4, +0x1.d0d672f59d2b9p-1, +-0x1.c83009f0c39dep-55, +0x1p-1, +-0x1.564df524b00dap-4, +0x1.d17e7743e35dcp-1, +-0x1.101da3540130ap-58, +0x1p-1, +-0x1.61bccb0903395p-4, +0x1.d2255c6e5a4e1p-1, +-0x1.d129a71ecafc9p-55, +0x1p-1, +-0x1.6d2fb6085786ep-4, +0x1.d2cb220e0ef9fp-1, +-0x1.f07656d4e6652p-56, +0x1p-1, +-0x1.78a6af12bd501p-4, +0x1.d36fc7bcbfbdcp-1, +-0x1.ba196d95a177dp-55, +0x1p-1, +-0x1.8421af15c49d7p-4, +0x1.d4134d14dc93ap-1, +-0x1.4ef5295d25af2p-55, +0x1p-1, +-0x1.8fa0aefc81837p-4, +0x1.d4b5b1b187524p-1, +-0x1.f56be6b42b76dp-57, +0x1p-1, +-0x1.9b23a7af90805p-4, +0x1.d556f52e93eb1p-1, +-0x1.80ed9233a963p-55, +0x1p-1, +-0x1.a6aa92151adc3p-4, +0x1.d5f7172888a7fp-1, +-0x1.68663e2225755p-55, +0x1p-1, +-0x1.b2356710db0a3p-4, +0x1.d696173c9e68bp-1, +-0x1.e8c61c6393d55p-56, +0x1p-1, +-0x1.bdc41f84210bbp-4, +0x1.d733f508c0dffp-1, +-0x1.007928e770cd5p-55, +0x1p-1, +-0x1.c956b44dd6d41p-4, +0x1.d7d0b02b8ecf9p-1, +0x1.800f4ce65cd6ep-55, +0x1p-1, +-0x1.d4ed1e4a84aefp-4, +0x1.d86c48445a44fp-1, +0x1.e8813c023d71fp-55, +0x1p-1, +-0x1.e087565455a75p-4, +0x1.d906bcf328d46p-1, +0x1.457e610231ac2p-56, +0x1p-1, +-0x1.ec2555431bf03p-4, +0x1.d9a00dd8b3d46p-1, +0x1.bea0e4bac8e16p-58, +0x1p-1, +-0x1.f7c713ec554fp-4, +0x1.da383a9668988p-1, +-0x1.5811000b39d84p-55, +0x1p-1, +-0x1.01b6459197c38p-3, +0x1.dacf42ce68ab9p-1, +-0x1.fe8d76efdf896p-56, +0x1p-1, +-0x1.078ad9dc46632p-3, +0x1.db6526238a09bp-1, +-0x1.adee7eae6946p-56, +0x1p-1, +-0x1.0d61433d840a4p-3, +0x1.dbf9e4395759ap-1, +0x1.d8ff7350f75fdp-55, +0x1p-1, +-0x1.13397e1b7ce13p-3, +0x1.dc8d7cb41026p-1, +0x1.6b7872773830dp-56, +0x1p-1, +-0x1.191386db3dedcp-3, +0x1.dd1fef38a915ap-1, +-0x1.782f169e17f3bp-55, +0x1p-1, +-0x1.1eef59e0b74c3p-3, +0x1.ddb13b6ccc23cp-1, +0x1.83c37c6107db3p-55, +0x1p-1, +-0x1.24ccf38ebe694p-3, +0x1.de4160f6d8d81p-1, +0x1.9bf11cc5f8776p-55, +0x1p-1, +-0x1.2aac5047103d3p-3, +0x1.ded05f7de47dap-1, +-0x1.2cc4c1f8ba966p-55, +0x1p-1, +0x1.9ee5272b58f2ap-4, +0x1.df5e36a9ba59cp-1, +-0x1.e01f8bceb43d3p-57, +0x1p-2, +0x1.931f774fc9f18p-4, +0x1.dfeae622dbe2bp-1, +-0x1.514ea88425567p-55, +0x1p-2, +0x1.875657223080ap-4, +0x1.e0766d9280f54p-1, +0x1.f44c969cf62e3p-55, +0x1p-2, +0x1.7b89cde7a9a4dp-4, +0x1.e100cca2980acp-1, +-0x1.02d182acdf825p-57, +0x1p-2, +0x1.6fb9e2e76ced8p-4, +0x1.e18a02fdc66d9p-1, +0x1.07e272abd88cfp-55, +0x1p-2, +0x1.63e69d6ac7f74p-4, +0x1.e212104f686e5p-1, +-0x1.014c76c126527p-55, +0x1p-2, +0x1.581004bd19ed2p-4, +0x1.e298f4439197ap-1, +0x1.e84e601038eb2p-57, +0x1p-2, +0x1.4c36202bcf08ep-4, +0x1.e31eae870ce25p-1, +-0x1.bc7094538d678p-56, +0x1p-2, +0x1.4058f7065c11ep-4, +0x1.e3a33ec75ce85p-1, +0x1.45089cd46bbb8p-57, +0x1p-2, +0x1.3478909e39da9p-4, +0x1.e426a4b2bc17ep-1, +0x1.a873889744882p-55, +0x1p-2, +0x1.2894f446e0bccp-4, +0x1.e4a8dff81ce5ep-1, +0x1.43578776c0f46p-55, +0x1p-2, +0x1.1cae2955c414fp-4, +0x1.e529f04729ffcp-1, +0x1.9075d6e6dfc8bp-55, +0x1p-2, +0x1.10c437224dbc2p-4, +0x1.e5a9d550467d3p-1, +0x1.7d431be53f92fp-56, +0x1p-2, +0x1.04d72505d9805p-4, +0x1.e6288ec48e112p-1, +-0x1.16b56f2847754p-57, +0x1p-2, +0x1.f1cdf4b76138bp-5, +0x1.e6a61c55d53a7p-1, +0x1.660d981acdcf7p-56, +0x1p-2, +0x1.d9e77d020a5bcp-5, +0x1.e7227db6a9744p-1, +0x1.2128794da5a5p-55, +0x1p-2, +0x1.c1faf1a9db555p-5, +0x1.e79db29a5165ap-1, +-0x1.75e710aca58p-56, +0x1p-2, +0x1.aa086170c0a8ep-5, +0x1.e817bab4cd10dp-1, +-0x1.d0afe686b5e0ap-56, +0x1p-2, +0x1.920fdb1c5d578p-5, +0x1.e89095bad6025p-1, +-0x1.5a4cc0fcbccap-55, +0x1p-2, +0x1.7a116d7601c35p-5, +0x1.e9084361df7f2p-1, +0x1.cdfc7ce9dc3e9p-55, +0x1p-2, +0x1.620d274aa2903p-5, +0x1.e97ec36016b3p-1, +0x1.5bc48562557d3p-55, +0x1p-2, +0x1.4a03176acf82dp-5, +0x1.e9f4156c62ddap-1, +0x1.760b1e2e3f81ep-55, +0x1p-2, +0x1.31f34caaaa5d2p-5, +0x1.ea68393e658p-1, +-0x1.467259bb7b556p-56, +0x1p-2, +0x1.19ddd5e1ddb8bp-5, +0x1.eadb2e8e7a88ep-1, +-0x1.92ec52ea226a3p-55, +0x1p-2, +0x1.01c2c1eb93deep-5, +0x1.eb4cf515b8811p-1, +0x1.95da1ba97ec5ep-57, +0x1p-2, +0x1.d3443f4cdb3ddp-6, +0x1.ebbd8c8df0b74p-1, +0x1.c6c8c615e7277p-56, +0x1p-2, +0x1.a2f7fbe8f2436p-6, +0x1.ec2cf4b1af6b2p-1, +0x1.34ee3f2caa62dp-59, +0x1p-2, +0x1.72a0d77651772p-6, +0x1.ec9b2d3c3bf84p-1, +0x1.19119d358de05p-56, +0x1p-2, +0x1.423eefc693785p-6, +0x1.ed0835e999009p-1, +0x1.499d188aa32fap-57, +0x1p-2, +0x1.11d262b1f6776p-6, +0x1.ed740e7684963p-1, +0x1.e82c791f59cc2p-56, +0x1p-2, +0x1.c2b69c2e939b5p-7, +0x1.eddeb6a078651p-1, +-0x1.3b579af740a74p-55, +0x1p-2, +0x1.61b39fb7b7202p-7, +0x1.ee482e25a9dbcp-1, +-0x1.b6066ef81af2ap-56, +0x1p-2, +0x1.009c0bd6cc3cbp-7, +0x1.eeb074c50a544p-1, +0x1.d925f656c43b4p-55, +0x1p-2, +0x1.3ee038dff6b8p-8, +0x1.ef178a3e473c2p-1, +0x1.6310a67fe774fp-55, +0x1p-2, +0x1.f1806b9fdd1afp-10, +0x1.ef7d6e51ca3cp-1, +-0x1.a3c67c3d3f604p-55, +0x1p-2, +-0x1.191f2900903a6p-10, +0x1.efe220c0b95ecp-1, +0x1.c853b7bf7e0cdp-55, +0x1p-2, +-0x1.0916fe858ffcdp-8, +0x1.f045a14cf738cp-1, +-0x1.a52c44f45216cp-55, +0x1p-2, +-0x1.cc0d09bd41caap-8, +0x1.f0a7efb9230d7p-1, +0x1.52c7adc6b4989p-56, +0x1p-2, +-0x1.4794b9d21cb87p-7, +0x1.f1090bc898f5fp-1, +-0x1.baa64ab102a93p-55, +0x1p-2, +-0x1.a935e1efe5e4bp-7, +0x1.f168f53f7205dp-1, +-0x1.26a6c1f015601p-57, +0x1p-2, +-0x1.0574e07f7b332p-6, +0x1.f1c7abe284708p-1, +0x1.504b80c8a63fcp-55, +0x1p-2, +-0x1.36580d5d5e775p-6, +0x1.f2252f7763adap-1, +-0x1.20cb81c8d94abp-55, +0x1p-2, +-0x1.67445969a108ep-6, +0x1.f2817fc4609cep-1, +-0x1.dd1f8eaf65689p-55, +0x1p-2, +-0x1.9839a676a6bcfp-6, +0x1.f2dc9c9089a9dp-1, +0x1.5407460bdfc07p-59, +0x1p-2, +-0x1.c937d65145919p-6, +0x1.f33685a3aaefp-1, +0x1.eb78685d850f8p-56, +0x1p-2, +-0x1.fa3ecac0d84e8p-6, +0x1.f38f3ac64e589p-1, +-0x1.d7bafb51f72e6p-56, +0x1p-2, +-0x1.15a732c3a894dp-5, +0x1.f3e6bbc1bbc65p-1, +0x1.5774bb7e8a21ep-57, +0x1p-2, +-0x1.2e334430a6376p-5, +0x1.f43d085ff92ddp-1, +-0x1.8fde71e361c05p-55, +0x1p-2, +-0x1.46c38a8311952p-5, +0x1.f492206bcabb4p-1, +0x1.d1e921bbe3bd3p-55, +0x1p-2, +-0x1.5f57f693feebep-5, +0x1.f4e603b0b2f2dp-1, +-0x1.8ee01e695ac05p-56, +0x1p-2, +-0x1.77f07939f3897p-5, +0x1.f538b1faf2d07p-1, +-0x1.5f7cd5099519cp-59, +0x1p-2, +-0x1.908d0348ef266p-5, +0x1.f58a2b1789e84p-1, +0x1.1f4a188aa368p-56, +0x1p-2, +-0x1.a92d859275418p-5, +0x1.f5da6ed43685dp-1, +-0x1.536fc33bf9dd8p-55, +0x1p-2, +-0x1.c1d1f0e5967d5p-5, +0x1.f6297cff75cbp-1, +0x1.562172a361fd3p-56, +0x1p-2, +-0x1.da7a360ef9fefp-5, +0x1.f677556883ceep-1, +0x1.ef696a8d070f4p-57, +0x1p-2, +-0x1.f32645d8e6ce9p-5, +0x1.f6c3f7df5bbb7p-1, +0x1.8561ce9d5ef5bp-56, +0x1p-2, +-0x1.05eb0885a69c9p-4, +0x1.f70f6434b7eb7p-1, +0x1.1775df66f0ec4p-56, +0x1p-2, +-0x1.1244c435e819dp-4, +0x1.f7599a3a12077p-1, +0x1.84f31d743195cp-55, +0x1p-2, +-0x1.1ea04e5ee7601p-4, +0x1.f7a299c1a322ap-1, +0x1.6e7190c94899ep-56, +0x1p-2, +-0x1.2afd9f6136a9cp-4, +0x1.f7ea629e63d6ep-1, +0x1.ba92d57ebfeddp-55, +0x1p-2, +0x1.9146a0c760c35p-5, +0x1.f830f4a40c60cp-1, +0x1.8528676925128p-57, +0x1p-3, +0x1.78851122cff19p-5, +0x1.f8764fa714ba9p-1, +0x1.ab256778ffcb6p-56, +0x1p-3, +0x1.5fc0219532f79p-5, +0x1.f8ba737cb4b78p-1, +-0x1.da71f96d5a49cp-55, +0x1p-3, +0x1.46f7e165f17c8p-5, +0x1.f8fd5ffae41dbp-1, +-0x1.8cfd77fd970d2p-56, +0x1p-3, +0x1.2e2c5fde7ea22p-5, +0x1.f93f14f85ac08p-1, +-0x1.cfd153e9a9c1ap-55, +0x1p-3, +0x1.155dac4a4f967p-5, +0x1.f97f924c9099bp-1, +-0x1.e2ae0eea5963bp-55, +0x1p-3, +0x1.f917abeda4499p-6, +0x1.f9bed7cfbde29p-1, +-0x1.b35b1f9bcf70bp-56, +0x1p-3, +0x1.c76dd866c689ep-6, +0x1.f9fce55adb2c8p-1, +0x1.f2a06fab9f9d1p-56, +0x1p-3, +0x1.95bdfca28b53ap-6, +0x1.fa39bac7a1791p-1, +-0x1.94f388f1b4e1ep-57, +0x1p-3, +0x1.64083747309d1p-6, +0x1.fa7557f08a517p-1, +-0x1.7a0a8ca13571fp-55, +0x1p-3, +0x1.324ca6fe9a04bp-6, +0x1.faafbcb0cfddcp-1, +-0x1.e349cb4d3e866p-55, +0x1p-3, +0x1.008b6a763de76p-6, +0x1.fae8e8e46cfbbp-1, +-0x1.3a9e414732d97p-56, +0x1p-3, +0x1.9d8940be24e74p-7, +0x1.fb20dc681d54dp-1, +-0x1.ff148ec7c5fafp-55, +0x1p-3, +0x1.39f0cedaf576bp-7, +0x1.fb5797195d741p-1, +0x1.1bfac7397cc08p-56, +0x1p-3, +0x1.ac9b7964cf0bap-8, +0x1.fb8d18d66adb7p-1, +-0x1.d0b66224cce2ep-56, +0x1p-3, +0x1.ca811eea0c749p-9, +0x1.fbc1617e44186p-1, +-0x1.58ec496dc4ecbp-59, +0x1p-3, +0x1.dd15adf70b65ap-12, +0x1.fbf470f0a8d88p-1, +-0x1.6bb200d1d70b7p-55, +0x1p-3, +-0x1.536352ad19e39p-9, +0x1.fc26470e19fd3p-1, +0x1.1ec8668ecaceep-55, +0x1p-3, +-0x1.7148021b55c15p-8, +0x1.fc56e3b7d9af6p-1, +-0x1.03ff7a673d3bdp-56, +0x1p-3, +-0x1.1c789a28b01b7p-7, +0x1.fc8646cfeb721p-1, +0x1.3143dc43a9b9dp-55, +0x1p-3, +-0x1.80566267c11f6p-7, +0x1.fcb4703914354p-1, +0x1.126aa7d51b25cp-55, +0x1p-3, +-0x1.e43d1c309e958p-7, +0x1.fce15fd6da67bp-1, +-0x1.5dd6f830d4c09p-56, +0x1p-3, +-0x1.241644f1c26cep-6, +0x1.fd0d158d86087p-1, +0x1.9705a7b864883p-55, +0x1p-3, +-0x1.561236eda8ff2p-6, +0x1.fd37914220b84p-1, +0x1.52e9d7b772791p-55, +0x1p-3, +-0x1.88124536d5e8fp-6, +0x1.fd60d2da75c9ep-1, +0x1.36dedb314f0ebp-58, +0x1p-3, +-0x1.ba1650f592f5p-6, +0x1.fd88da3d12526p-1, +-0x1.87df6378811c7p-55, +0x1p-3, +-0x1.ec1e3b4fb3d7ep-6, +0x1.fdafa7514538cp-1, +0x1.d97c45ca4d398p-59, +0x1p-3, +-0x1.0f14f2b4549bdp-5, +0x1.fdd539ff1f456p-1, +-0x1.ab13cbbec1781p-56, +0x1p-3, +-0x1.281c9830c9dafp-5, +0x1.fdf9922f73307p-1, +0x1.a5e0abd3a9b65p-56, +0x1p-3, +0x1.7db402a6a9063p-6, +0x1.fe1cafcbd5b09p-1, +0x1.a23e3202a884ep-57, +0x1p-4, +0x1.4b9dd29353428p-6, +0x1.fe3e92be9d886p-1, +0x1.afeb2e264d46bp-57, +0x1p-4, +0x1.19845e49c8257p-6, +0x1.fe5f3af2e394p-1, +0x1.b213f18c9cf17p-55, +0x1p-4, +0x1.cecf8962d14c8p-7, +0x1.fe7ea85482d6p-1, +0x1.34b085c1828f7p-56, +0x1p-4, +0x1.6a9049670cfaep-7, +0x1.fe9cdad01883ap-1, +0x1.521ecd0c67e35p-57, +0x1p-4, +0x1.064b3a76a2264p-7, +0x1.feb9d2530410fp-1, +0x1.9d429eeda9bb9p-58, +0x1p-4, +0x1.440134d709b28p-8, +0x1.fed58ecb673c4p-1, +-0x1.e6e462a7ae686p-56, +0x1p-4, +0x1.ed853918c18ecp-10, +0x1.fef0102826191p-1, +0x1.3c3ea4f30addap-56, +0x1p-4, +-0x1.35230c0fbe402p-10, +0x1.ff095658e71adp-1, +0x1.01a8ce18a4b9ep-55, +0x1p-4, +-0x1.15fc833fb89b8p-8, +0x1.ff21614e131edp-1, +-0x1.de692a167353p-55, +0x1p-4, +-0x1.deb9769f940eap-8, +0x1.ff3830f8d575cp-1, +-0x1.95e1e79d335f7p-56, +0x1p-4, +-0x1.53bf90a81f3a5p-7, +0x1.ff4dc54b1bed3p-1, +-0x1.c1169ccd1e92ep-55, +0x1p-4, +-0x1.b82683bc89fbp-7, +0x1.ff621e3796d7ep-1, +-0x1.c57bc2e24aa15p-57, +0x1p-4, +-0x1.0e48ab4f172f4p-6, +0x1.ff753bb1b9164p-1, +-0x1.7c330129f56efp-56, +0x1p-4, +0x1.7f0034a43350ep-7, +0x1.ff871dadb81dfp-1, +0x1.8b1c676208aa4p-56, +0x1p-5, +0x1.1a8e5bfe185e4p-7, +0x1.ff97c4208c014p-1, +0x1.52ab2b947e843p-57, +0x1p-5, +0x1.6c32baca2ae69p-8, +0x1.ffa72effef75dp-1, +-0x1.8b4cdcdb25956p-55, +0x1p-5, +0x1.4685db42c17ebp-9, +0x1.ffb55e425fdaep-1, +0x1.6da7ec781c225p-55, +0x1p-5, +-0x1.2d919c5c61fep-11, +0x1.ffc251df1d3f8p-1, +0x1.7a7d209f32d43p-56, +0x1p-5, +-0x1.dd58598d6271cp-9, +0x1.ffce09ce2a679p-1, +-0x1.7bd62ab5ee228p-55, +0x1p-5, +-0x1.b7aa821726608p-8, +0x1.ffd886084cd0dp-1, +-0x1.1354d4556e4cbp-55, +0x1p-5, +0x1.7f53487eac897p-8, +0x1.ffe1c6870cb77p-1, +0x1.89aa14768323ep-55, +0x1p-6, +0x1.6c9b5df1877eap-9, +0x1.ffe9cb44b51a1p-1, +0x1.5b43366df667p-56, +0x1p-6, +-0x1.2bad2a8cd06bp-12, +0x1.fff0943c53bd1p-1, +-0x1.47399f361d158p-55, +0x1p-6, +-0x1.b78b80c84e1eep-9, +0x1.fff62169b92dbp-1, +0x1.5dda3c81fbd0dp-55, +0x1p-6, +0x1.6cb587284b817p-10, +0x1.fffa72c978c4fp-1, +-0x1.22cb000328f91p-55, +0x1p-7, +-0x1.b783c0663fe3cp-10, +0x1.fffd8858e8a92p-1, +0x1.359c71883bcf7p-55, +0x1p-7, +-0x1.b781d04cd6d17p-11, +0x1.ffff621621d02p-1, +-0x1.6acfcebc82813p-56, +0x1p-8 +}; + +} // namespace npsr::HWY_NAMESPACE::sincos +HWY_AFTER_NAMESPACE(); +#endif // NPSR_TRIG_LUT_INL_H_ + diff --git a/npsr/trig/lut-inl.h.py b/npsr/trig/lut-inl.h.py new file mode 100644 index 0000000..3f1e524 --- /dev/null +++ b/npsr/trig/lut-inl.h.py @@ -0,0 +1,224 @@ +import subprocess +import textwrap +import tempfile +import os +import re + + +def sollya(expr, as_int=None): + """Sollya wrapper with comprehensive message filtering using temp file""" + expr = textwrap.dedent(expr).strip() + # Create temporary file + with tempfile.NamedTemporaryFile(mode="w", suffix=".sollya", delete=False) as f: + f.write(expr + "\nquit;\n") + temp_file = f.name + + try: + # Execute Sollya with temp file + result = subprocess.run(["sollya", temp_file], capture_output=True, text=True) + + # Define patterns to filter out + ignore_patterns = [ + r"^Warning", # Warnings + r"^The precision has been set", # Precision messages + r"^Display mode is ", # Default precision messages + r"^\s*$", # Empty lines + ] + + lines = result.stdout.strip().split("\n") + filtered = [] + + for line in lines: + line = line.strip() + if line: + # Check if line matches any ignore pattern + should_ignore = any( + re.match(pattern, line) for pattern in ignore_patterns + ) + if not should_ignore: + filtered.append(line) + if as_int: + return [int(l, base=as_int) for l in filtered] + return filtered + + finally: + # Clean up temp file + os.unlink(temp_file) + + +def gen_reduction(float_size=64): + """ + Precompute int(2^exp × 4/π) with ~96-bit precision (f32) or ~192-bit precision (f64) + and split them into three chunks: 32-bit chunks for single precision, 64-bit chunks for double precision. + + This generates a lookup table for large range reduction in trigonometric functions. + The table is used to compute mantissa × (2^exp × 4/π) using wider integer multiplications for precision: + - f32: 16×16 → 32-bit multiplications + - f64: 32×32 → 64-bit multiplications + + For input x = mantissa × 2^exp, the algorithm becomes: + x × 4/π = mantissa × table_lookup[exp], providing high precision without floating-point errors. + + Args: + float_size: 32 for f32 or 64 for f64 + """ + exp = (1 << (8 if float_size == 32 else 11)) - 1 + offset, usfx = (70, "U") if float_size == 32 else (137, "ULL") + bias = exp >> 1 + ints = sollya( + f""" + prec = {float_size * 3 * 3}; + four_over_pi = 4 / pi; + for e from 0 to {exp} do {{ + e_shift = e - {bias} + {offset}; + floor(four_over_pi * (2^e_shift)); + }}; + """, + as_int=10, + ) + chunk_mask = (1 << float_size) - 1 + chunks = [ + hex((i >> shift) & chunk_mask) + usfx + for i in ints + for shift in [float_size * 2, float_size, 0] + ] + return chunks + + +def gen_approx(float_size=64, func="sin", func_driv="cos"): + n = 1 << (8 if float_size == 32 else 11) + cast = "single" if float_size == 32 else "double" + return sollya( + f""" + prec = {float_size*3}; + display = hexadecimal; + cast = {cast}(x); + func = {func}(x); + scale = 2.0 * pi / {n}; + for e from 0 to {n - 1} do {{ + theta = e * scale; + p1 = cast(func(theta)); + p2 = cast(func(theta) - p1); + deriv = {func_driv}(theta); + k = nearestint(log2(abs(deriv))); + if (deriv < 0) then sign = -1 else sign = 1; + p3 = sign * 2.0^k; + p0 = cast(deriv - p3); + p0;p1;p2;p3; + }}; + """ + ) + + +def gen_kpi16(float_size=64, func="sin"): + cast = "single" if float_size == 32 else "double" + return sollya( + f""" + prec = {float_size*3}; + display = hexadecimal; + cast = {cast}(x); + func = {func}(x); + pi16 = pi / 16; + for k from 0 to 15 do {{ + cast(func(k * pi16)); + }}; + """ + ) + + +def gen_pack_func(clo, slo): + combined = (clo & 0xFFFFFFFF00000000) | ((slo >> 32) & 0xFFFFFFFF) + return f"0x{combined:016x}" + + +def gen_kpi16_low_pack(): + ints = sollya( + f""" + prec = {64*3}; + display = hexadecimal; + pi16 = pi / 16; + for k from 0 to 15 do {{ + shi = double(sin(k * pi16)); + chi = double(cos(k * pi16)); + slo = double(sin(k * pi16) - shi); + clo = double(cos(k * pi16) - chi); + printdouble(clo); + printdouble(slo); + }}; + """, + as_int=0x10, + ) + packed = [gen_pack_func(clo, slo) for clo, slo in zip(ints[::2], ints[1::2])] + ints = sollya( + f""" + prec = {64*3}; + display = hexadecimal; + packed = [|{','.join(packed)}|]; + for k from 0 to 15 do {{ + double(packed[k]); + }}; + """ + ) + return ints + + +nl = ",\n" +print( + """\ +// auto generated by npsr/sincos/lut-inl.h.py +#include +#if defined(NPSR_TRIG_LUT_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TRIG_LUT_INL_H_ +#undef NPSR_TRIG_LUT_INL_H_ +#else +#define NPSR_TRIG_LUT_INL_H_ +#endif + +HWY_BEFORE_NAMESPACE(); + +namespace npsr::HWY_NAMESPACE::sincos { +HWY_API void DummySupressUnusedTargetWarn(); + + +template constexpr T kLargeReductionTable[] = {}; +template constexpr T kSinApproxTable[] = {}; +template constexpr T kCosApproxTable[] = {}; +template constexpr T kHiSinKPi16Table[] = {}; +template constexpr T kHiCosKPi16Table[] = {}; +template constexpr T kPackedLowSinCosKPi16Table[] = {}; +""" +) +print( + f"""\ +template <> HWY_ALIGN constexpr double kHiSinKPi16Table[] = {{ +{nl.join(gen_kpi16(func="sin"))} +}}; +template <> HWY_ALIGN constexpr double kHiCosKPi16Table[] = {{ +{nl.join(gen_kpi16(func="cos"))} +}}; +template <> HWY_ALIGN constexpr double kPackedLowSinCosKPi16Table[] = {{ +{nl.join(gen_kpi16_low_pack())} +}};\ +""" +) +for fsize, T in ((32, "float"), (64, "double")): + print( + f"""\ +template <> HWY_ALIGN constexpr uint{fsize}_t kLargeReductionTable<{T}>[] = {{ +{nl.join(gen_reduction(fsize))} +}}; +template <> HWY_ALIGN constexpr {T} kSinApproxTable<{T}>[] = {{ +{nl.join(gen_approx(fsize, "sin", "cos"))} +}}; +template <> HWY_ALIGN constexpr {T} kCosApproxTable<{T}>[] = {{ +{nl.join(gen_approx(fsize, "cos", "-sin"))} +}};\ + """ + ) +print( + """ +} // namespace npsr::HWY_NAMESPACE::sincos +HWY_AFTER_NAMESPACE(); +#endif // NPSR_TRIG_LUT_INL_H_ +""" +) diff --git a/npsr/trig/small-inl.h b/npsr/trig/small-inl.h new file mode 100644 index 0000000..145d6e0 --- /dev/null +++ b/npsr/trig/small-inl.h @@ -0,0 +1,352 @@ +#include "npsr/common.h" +#include "npsr/trig/lut-inl.h" +#include "npsr/utils-inl.h" + +#if defined(NPSR_TRIG_SMALL_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TRIG_SMALL_INL_H_ +#undef NPSR_TRIG_SMALL_INL_H_ +#else +#define NPSR_TRIG_SMALL_INL_H_ +#endif + +HWY_BEFORE_NAMESPACE(); + +namespace npsr::HWY_NAMESPACE::sincos { + +using namespace hwy; +using namespace hwy::HWY_NAMESPACE; + +template )> +HWY_API V SmallPolyLow(V r, V r2) { + const DFromV d; + const V c9 = Set(d, IS_COS ? 0x1.5d866ap-19f : 0x1.5dbdfp-19f); + const V c7 = Set(d, IS_COS ? -0x1.9f6d9ep-13 : -0x1.9f6ffep-13f); + const V c5 = Set(d, IS_COS ? 0x1.110ec8p-7 : 0x1.110eccp-7f); + const V c3 = Set(d, -0x1.55554cp-3f); + V poly = MulAdd(c9, r2, c7); + poly = MulAdd(r2, poly, c5); + poly = MulAdd(r2, poly, c3); + if constexpr (IS_COS) { + // Although this path handles cosine, we have already transformed the + // input using the identity: cos(x) = sin(x + π/2) This means we're no + // longer directly evaluating a cosine Taylor series; instead, we evaluate + // the sine approximation polynomial at (x + π/2). + // + // The sine approximation has the general form: + // sin(r) ≈ r + r³ · P(r²) + // + // So, we compute: + // r³ = r · r² + // sin(r) ≈ r + r³ · poly + // + // This formulation preserves accuracy by computing the highest order + // terms last, which benefits from FMA to reduce rounding error. + V r3 = Mul(r2, r); + poly = MulAdd(r3, poly, r); + } else { + poly = Mul(poly, r2); + poly = MulAdd(r, poly, r); + } + return poly; +} + +template )> +HWY_API V SmallPolyLow(V r, V r2) { + const DFromV d; + const V c15 = Set(d, -0x1.9f1517e9f65fp-41); + const V c13 = Set(d, 0x1.60e6bee01d83ep-33); + const V c11 = Set(d, -0x1.ae6355aaa4a53p-26); + const V c9 = Set(d, 0x1.71de3806add1ap-19); + const V c7 = Set(d, -0x1.a01a019a659ddp-13); + const V c5 = Set(d, 0x1.111111110a573p-7); + const V c3 = Set(d, -0x1.55555555554a8p-3); + + V poly = MulAdd(c15, r2, c13); + poly = MulAdd(r2, poly, c11); + poly = MulAdd(r2, poly, c9); + poly = MulAdd(r2, poly, c7); + poly = MulAdd(r2, poly, c5); + poly = MulAdd(r2, poly, c3); + V r3 = Mul(r2, r); + poly = MulAdd(r3, poly, r); + return poly; +} + +template HWY_API V SmallArgLow(V x) { + const DFromV d; + const RebindToUnsigned du; + using U = VFromD; + using T = TFromV; + // Load frequently used constants as vector registers + const V abs_mask = BitCast(d, Set(du, SignMask() - 1)); + const V x_abs = And(abs_mask, x); + const V x_sign = AndNot(abs_mask, x); + + constexpr bool IsSingle = std::is_same_v; + + // Transform cosine to sine using identity: cos(x) = sin(x + π/2) + const V half_pi = Set(d, 0x1.921fb6p0f); + V x_trans = x_abs; + if constexpr (IS_COS) { + x_trans = Add(x_abs, half_pi); + } + // check zero input/subnormal for cosine (cos(~0) = 1) + const auto is_cos_near_zero = Eq(x_trans, half_pi); + + // Compute N = round(x/π) using "magic number" technique + // and stores integer part in mantissa + const V inv_pi = Set(d, IsSingle ? 0x1.45f306p-2f : 0x1.45f306dc9c883p-2); + const V magic_round = Set(d, IsSingle ? 0x1.8p23f : 0x1.8p52); + V n_biased = MulAdd(x_trans, inv_pi, magic_round); + V n = Sub(n_biased, magic_round); + + // Adjust quotient for cosine (accounts for π/2 phase shift) + if constexpr (IS_COS) { + // For cosine, we computed N = round((x + π/2)/π) but need N' for x: + // N = round((x + π/2)/π) = round(x/π + 0.5) + // This is often 1 more than round(x/π), so we subtract 0.5: + // N' = N - 0.5 + n = Sub(n, Set(d, static_cast(0.5))); + } + // Use Cody-Waite method with triple-precision PI + const V pi_hi = Set(d, IsSingle ? 0x1.921fb6p1f : 0x1.921fb54442d18p+1); + const V pi_med = Set(d, -0x1.777a5cp-24f); + const V pi_lo = Set(d, IsSingle ? -0x1.ee59dap-49f : 0x1.1a62633145c06p-53); + V r = NegMulAdd(n, pi_hi, x_abs); // x - N*π_hi + if constexpr (IsSingle) { + r = NegMulAdd(n, pi_med, r); // - N*π_medium + } + r = NegMulAdd(n, pi_lo, r); // - N*π_low + V r2 = Mul(r, r); + // Extract octant sign information from quotient + // to determines sign flip in final result + r = Xor(r, BitCast(d, ShiftLeft(BitCast(du, n_biased)))); + + V poly = SmallPolyLow(r, r2); + if constexpr (IS_COS) { + poly = IfThenElse(is_cos_near_zero, Set(d, static_cast(1.0)), poly); + } else { + // Restore original sign for sine (odd function) + poly = Xor(poly, x_sign); + } + return poly; +} + +template )> +HWY_INLINE V SmallArg(V x) { + using T = TFromV; + using D = DFromV; + using DU = RebindToUnsigned; + using DH = Half; + using DW = RepartitionToWide; + using VU = Vec; + using VW = Vec; + + const D d; + const DU du; + const DH dh; + const DW dw; + + // Load frequently used constants as vector registers + const V abs_mask = BitCast(d, Set(du, 0x7FFFFFFF)); + const V x_abs = And(abs_mask, x); + const V x_sign = AndNot(abs_mask, x); + + // Transform cosine to sine using identity: cos(x) = sin(x + π/2) + const V half_pi = Set(d, 0x1.921fb6p0f); + V x_trans = x_abs; + if constexpr (IS_COS) { + x_trans = Add(x_abs, half_pi); + } + // check zero input/subnormal for cosine (cos(~0) = 1) + const auto is_cos_near_zero = Eq(x_trans, half_pi); + + // Compute N = round(input/π) using "magic number" technique + // Adding 2^23 forces rounding and stores integer part in mantissa + const V inv_pi = Set(d, 0x1.45f306p-2f); + const V magic_round = Set(d, 0x1.8p23f); + V n_biased = MulAdd(x_trans, inv_pi, magic_round); + V n = Sub(n_biased, magic_round); + + // Adjust quotient for cosine (accounts for π/2 phase shift) + if constexpr (IS_COS) { + // For cosine, we computed N = round((x + π/2)/π) but need N' for x: + // N = round((x + π/2)/π) = round(x/π + 0.5) + // This is often 1 more than round(x/π), so we subtract 0.5: + // N' = N - 0.5 + n = Sub(n, Set(d, 0.5f)); + } + auto WideCal = [](VW nh, VW xh_abs) -> VW { + const DFromV dw; + const VW pi_hi = Set(dw, 0x1.921fb5444p1); + const VW pi_lo = Set(dw, 0x1.68c234c4c6629p-38); + + VW r = NegMulAdd(nh, pi_lo, NegMulAdd(nh, pi_hi, xh_abs)); + VW r2 = Mul(r, r); + + // Polynomial coefficients for sin(r) approximation on [-π/2, π/2] + const VW c9 = Set(dw, 0x1.5dbdf0e4c7deep-19); + const VW c7 = Set(dw, -0x1.9f6ffeea73463p-13); + const VW c5 = Set(dw, 0x1.110ed3804ca96p-7); + const VW c3 = Set(dw, -0x1.55554bc836587p-3); + + VW poly = MulAdd(c9, r2, c7); + poly = MulAdd(r2, poly, c5); + poly = MulAdd(r2, poly, c3); + poly = Mul(poly, r2); + poly = MulAdd(r, poly, r); + return poly; + }; + + VW poly_lo = WideCal(PromoteLowerTo(dw, n), PromoteLowerTo(dw, x_abs)); + VW poly_up = WideCal(PromoteUpperTo(dw, n), PromoteUpperTo(dw, x_abs)); + V poly = Combine(d, DemoteTo(dh, poly_up), DemoteTo(dh, poly_lo)); + // Extract octant sign information from quotient and flip the sign bit + poly = Xor(poly, + BitCast(d, ShiftLeft(BitCast(du, n_biased)))); + if constexpr (IS_COS) { + poly = IfThenElse(is_cos_near_zero, Set(d, 1.0f), poly); + } else { + // Restore original sign for sine (odd function) + poly = Xor(poly, x_sign); + } + return poly; +} +/** + * This function computes sin(x) or cos(x) for |x| < 2^24 using the Cody-Waite + * reduction algorithm combined with table lookup and polynomial approximation, + * achieves < 1 ULP error for |x| < 2^24. + * + * Algorithm Overview: + * 1. Range Reduction: Reduces input x to r where |r| < π/16 + * - Computes n = round(x * 16/π) and r = x - n*π/16 + * - Uses multi-precision arithmetic (3 parts of π/16) for accuracy + * + * 2. Table Lookup: Retrieves precomputed sin(n*π/16) and cos(n*π/16) + * - Includes high and low precision parts for cos values + * + * 3. Polynomial Approximation: Computes sin(r) and cos(r) + * - sin(r) ≈ r * (1 + r²*P_sin(r²)) where P_sin is a minimax polynomial + * - cos(r) ≈ 1 + r²*P_cos(r²) where P_cos is a minimax polynomial + * + * 4. Reconstruction: Applies angle addition formulas + * - sin(x) = sin(n*π/16 + r) = sin(n*π/16)*cos(r) + cos(n*π/16)*sin(r) + * - cos(x) = cos(n*π/16 + r) = cos(n*π/16)*cos(r) - sin(n*π/16)*sin(r) + * + */ +template )> +HWY_INLINE V SmallArg(V x) { + using T = TFromV; + using D = DFromV; + using DU = RebindToUnsigned; + using VU = Vec; + + const D d; + const DU du; + + // Constants for range reduction + constexpr T kInvPi = 0x1.45f306dc9c883p2; // 16/π for range reduction + constexpr T kPi16High = 0x1.921fb54442d18p-3; // π/16 high precision part + constexpr T kPi16Low = 0x1.1a62633p-57; // π/16 low precision part + constexpr T kPi16Tiny = 0x1.45c06e0e68948p-89; // π/16 tiny precision part + + // Step 1: Range reduction - find n such that x = n*(π/16) + r, where |r| < + // π/16 + V magic = Set(d, 0x1.8p52); + V n_biased = MulAdd(x, Set(d, kInvPi), magic); + V n = Sub(n_biased, magic); + + // Extract integer index for table lookup (n mod 16) + VU n_int = BitCast(du, n_biased); + + // Step 2: Load precomputed sine/cosine values for n mod 16 + V sin_hi = LutX2(kHiSinKPi16Table, n_int); + V cos_hi = LutX2(kHiCosKPi16Table, n_int); + V cos_lo = LutX2(kPackedLowSinCosKPi16Table, n_int); + + // Step 3: Multi-precision computation of remainder r + V r_hi = NegMulAdd(n, Set(d, kPi16High), x); // r = x - n*(π/16)_high + V r_mid = NegMulAdd(n, Set(d, kPi16Low), r_hi); // Subtract low part + V r = NegMulAdd(n, Set(d, kPi16Tiny), r_mid); // Subtract tiny part + + // Compute low precision part of r for extra accuracy + V delta = Sub(r, r_mid); + V term = NegMulAdd(Set(d, kPi16Low), n, Sub(r_hi, delta)); + V r_lo = MulAdd(Set(d, kPi16Tiny), n, delta); + r_lo = Sub(term, r_lo); + + // Step 4: Polynomial approximation + V r2 = Mul(r, r); + + // Minimax polynomial for (sin(r)/r - 1) + // sin(r)/r = 1 - r²/3! + r⁴/5! - r⁶/7! + ... + // This polynomial computes the terms after 1 + V sin_poly = Set(d, 0x1.71c97d22a73ddp-19); + sin_poly = MulAdd(sin_poly, r2, Set(d, -0x1.a01a00ed01edep-13)); + sin_poly = MulAdd(sin_poly, r2, Set(d, 0x1.111111110e99dp-7)); + sin_poly = MulAdd(sin_poly, r2, Set(d, -0x1.5555555555555p-3)); + + // Minimax polynomial for (cos(r) - 1)/r² + // cos(r) = 1 - r²/2! + r⁴/4! - r⁶/6! + ... + // This polynomial computes (cos(r) - 1)/r² + V cos_poly = Set(d, 0x1.9ffd7d9d749bcp-16); + cos_poly = MulAdd(cos_poly, r2, Set(d, -0x1.6c16c075d73f8p-10)); + cos_poly = MulAdd(cos_poly, r2, Set(d, 0x1.555555554e8d6p-5)); + cos_poly = MulAdd(cos_poly, r2, Set(d, -0x1.ffffffffffffcp-2)); + + // Step 5: Reconstruction using angle addition formulas + // sin(n*π/16 + r) = sin(n*π/16)*cos(r) + cos(n*π/16)*sin(r) + // cos(n*π/16 + r) = cos(n*π/16)*cos(r) - sin(n*π/16)*sin(r) + // + // Where: + // sin(r) = r * (1 + sin_poly) + // cos(r) = 1 + r² * cos_poly + + // Apply angle addition with multi-precision arithmetic + // Main term: sin(n*π/16) + r*cos(n*π/16) + V res_hi = MulAdd(r, cos_hi, sin_hi); + + // Compute error from r*cos_hi multiplication + V r_cos = Sub(res_hi, sin_hi); + V mul_err = MulSub(r, cos_hi, r_cos); + + // Compute cos(n*π/16) - r*sin(n*π/16) for intermediate calculations + V cos_r_sin = NegMulAdd(r, sin_hi, cos_hi); + + // Extract sin_low from packed format (upper 32 bits) + V sin_lo = BitCast(d, ShiftLeft<32>(BitCast(du, cos_lo))); + V lo_corr = MulAdd(r_lo, cos_r_sin, sin_lo); + + // Apply polynomial corrections + V r_cos_hi = Mul(cos_hi, r); + V sin_corr = Mul(sin_hi, cos_poly); // sin(n*π/16) * (cos(r)-1)/r² + + // Extract cos_low from packed format (lower 32 bits used directly) + V cos_corr = MulAdd(r, cos_lo, mul_err); + V total_corr = Add(cos_corr, lo_corr); + + // Combine all terms: sin(n*π/16 + r) ≈ sin(n*π/16) + r*cos(n*π/16) + + // corrections + V result = MulAdd(r_cos_hi, sin_poly, sin_corr); + result = MulAdd(r2, result, total_corr); + result = Add(res_hi, result); + + // Handle sign for negative zero edge case + if constexpr (IS_COS) { + // For cosine, we need to adjust the phase by π/2 + // This would require additional logic not shown in the original + // TODO: Implement cosine-specific adjustments + } + + // Apply final sign correction based on quadrant + VU sign_bits = ShiftRight<4>(n_int); + sign_bits = ShiftLeft<63>(sign_bits); + result = Xor(result, BitCast(d, sign_bits)); + return result; +} +// NOLINTNEXTLINE(google-readability-namespace-comments) +} // namespace npsr::HWY_NAMESPACE::sincos + +HWY_AFTER_NAMESPACE(); + +#endif // NPSR_TRIG_SMALL_INL_H_ diff --git a/npsr/utils-inl.h b/npsr/utils-inl.h new file mode 100644 index 0000000..919b3bd --- /dev/null +++ b/npsr/utils-inl.h @@ -0,0 +1,97 @@ +#include "npsr/common.h" + +// clang-format off +#if defined(NPSR_UTILS_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_UTILS_INL_H_ +#undef NPSR_UTILS_INL_H_ +#else +#define NPSR_UTILS_INL_H_ +#endif + +HWY_BEFORE_NAMESPACE(); + +namespace npsr::HWY_NAMESPACE { +using namespace hwy; +using namespace hwy::HWY_NAMESPACE; + +template >, typename V = Vec> +HWY_API V LutX2(const T *lut, VU idx) { + D d; + return GatherIndex(d, lut, BitCast(RebindToSigned(), idx)); +#if 0 + D d; + if constexpr(MaxLanes(d) == sizeof(T)) { + const V lut0 = Load(d, lut); + const V lut1 = Load(d, lut + sizeof(T)); + return TwoTablesLookupLanes(d, lut0, lut1, IndicesFromVec(d, idx)); + } + else if constexpr (MaxLanes(d) == 4){ + const V lut0 = Load(d, lut); + const V lut1 = Load(d, lut + 4); + const V lut2 = Load(d, lut + sizeof(T)); + const V lut3 = Load(d, lut + 12); + + const auto high_mask = Ne(ShiftRight<3>(idx), Zero(u64)); + const auto load_mask = And(idx, Set(u64, 0b111)); + + const V lut_low = TwoTablesLookupLanes(d, lut0, lut1, IndicesFromVec(d, load_mask)); + const V lut_high = TwoTablesLookupLanes(d, lut2, lut3, IndicesFromVec(d, load_mask)); + + return IfThenElse(RebindMask(d, high_mask), lut_high, lut_low); + } + else{ + return GatherIndex(d, lut, BitCast(s64, idx)); + } +#endif +} +#if 0 +template +class Lut { +public: + using T = std::tuple_element_t<0, std::tuple>; + constexpr static size_t kSize = sizeof...(Args); + + const T *Data() const { + return array; + } + +#if 1 || HWY_MAX_BYTES == 16 + // Calculate square root if it's a perfect square + constexpr static size_t kDim = []() { + for (size_t i = 1; i * i <= kSize; ++i) { + if (i * i == kSize) return i; + } + return size_t(0); + }(); + + static_assert(kDim > 0, "Must provide a perfect square number of array"); + constexpr static size_t kRows = kDim; + constexpr static size_t kCols = kDim; + + constexpr Lut(Args... args) + : Lut(std::make_tuple(args...), std::make_index_sequence{}) { + static_assert(kDim > 0, "Must provide a perfect square number of array"); + } + +private: + template + constexpr Lut(std::tuple arg_tuple, std::index_sequence) + : array{static_cast(std::get<(Is % kRows) * kCols + (Is / kRows)>(arg_tuple))...} { + } + +#else +public: + constexpr Lut(Args... args) + : array{static_cast(args)...} { + } +#endif + +private: + HWY_ALIGN T array[kSize]; +}; + +#endif +} // namespace npsr::HWY_NAMESPACE +HWY_AFTER_NAMESPACE(); + +#endif // NPSR_UTILS_INL_H_ From e23f065a3bbbbe71f4f979943f1154a670f29c6d Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Wed, 4 Jun 2025 21:31:25 +0300 Subject: [PATCH 02/20] BUG: Fix Precise options and doc comment for it --- npsr/common.h | 35 ++++++++++++++++++++++++++++++++++- 1 file changed, 34 insertions(+), 1 deletion(-) diff --git a/npsr/common.h b/npsr/common.h index 2837c4b..90204fe 100644 --- a/npsr/common.h +++ b/npsr/common.h @@ -51,9 +51,42 @@ struct FPExceptions { static constexpr auto kUnderflow = FE_UNDERFLOW; }; +/** + * @brief RAII floating-point precision control class + * + * The Precise class provides automatic management of floating-point environment + * settings during its lifetime. It uses RAII principles to save the current + * floating-point state on construction and restore it on destruction. + * + * The class is configured using variadic template arguments that specify + * the desired floating-point behavior through tag types. + * + * **IMPORTANT PERFORMANCE NOTE**: Create the Precise object BEFORE loops, + * not inside them. The constructor and destructor have overhead from saving + * and restoring floating-point state, so it should be done once per + * computational scope, not per iteration. + * + * @tparam Args Variadic template arguments for configuration flags + * + * @example + * ```cpp + * using namespace hwy::HWY_NAMESPACE; + * using namespace npsr; + * using namespace npsr::HWY_NAMESPACE; + * + * Precise precise = {kLowAccuracy, kNoSpecialCases, kNoLargeArgument}; + * const ScalableTag d; + * typename V = Vec>; + * for (size_t i = 0; i < n; i += Lanes(d)) { + * V input = LoadU(d, &input[i]); + * V result = Sin(precise, input); + * StoreU(result, d, &output[i]); + * } + * ``` + */ template class Precise { public: - Precise() { + Precise(Args...) { if constexpr (!kNoExceptions) { fegetexceptflag(&_exceptions, FE_ALL_EXCEPT); } From 885b3ba1ab1905f0808919966d3a7ab1305fc4b8 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:15:29 +0300 Subject: [PATCH 03/20] Add code generation tool for SIMD routines - Add Python-based generator tool for creating C++ headers and Python templates - Include sollya wrapper for mathematical computations - Add utilities for formatting C/Python arrays and header generation - Include comprehensive .gitignore for Python/C++ development --- .gitignore | 120 ++++++++++++++++++++++++++++++ tools/__init__.py | 0 tools/generator.py | 181 +++++++++++++++++++++++++++++++++++++++++++++ 3 files changed, 301 insertions(+) create mode 100644 .gitignore create mode 100644 tools/__init__.py create mode 100644 tools/generator.py diff --git a/.gitignore b/.gitignore new file mode 100644 index 0000000..6d69f9e --- /dev/null +++ b/.gitignore @@ -0,0 +1,120 @@ +# Editor temporary/working/backup files # +######################################### +.#* +[#]*# +*~ +*$ +*.bak +*.diff +.idea/ +*.iml +*.ipr +*.iws +*.org +.project +pmip +*.rej +.settings/ +.*.sw[nop] +.sw[nop] +*.tmp +*.vim +.vscode +tags +cscope.out +# gnu global +GPATH +GRTAGS +GSYMS +GTAGS +.cache +.mypy_cache/ + +# Compiled source # +################### +*.a +*.com +*.class +*.dll +*.exe +*.o +*.o.d +*.py[ocd] +*.so +*.mod + +# Packages # +############ +# it's better to unpack these files and commit the raw source +# git has its own built in compression methods +*.7z +*.bz2 +*.bzip2 +*.dmg +*.gz +*.iso +*.jar +*.rar +*.tar +*.tbz2 +*.tgz +*.zip + +# Python files # +################ +# meson build/installation directories +build +build-install +# meson python output +.mesonpy-native-file.ini +# sphinx build directory +_build +# dist directory is where sdist/wheel end up +dist +doc/build +doc/docenv +doc/cdoc/build +# Egg metadata +*.egg-info +# The shelf plugin uses this dir +./.shelf +.cache +pip-wheel-metadata +.python-version +# virtual envs +numpy-dev/ +venv/ + +# Paver generated files # +######################### +/release + +# Logs and databases # +###################### +*.log +*.sql +*.sqlite + +# Patches # +########### +*.patch +*.diff + +# Do not ignore the following patches: # +######################################## +!tools/ci/emscripten/0001-do-not-set-meson-environment-variable-pyodide-gh-4502.patch + +# OS generated files # +###################### +.DS_Store* +.VolumeIcon.icns +.fseventsd +Icon? +.gdb_history +ehthumbs.db +Thumbs.db +.directory + +# pytest generated files # +########################## +/.pytest_cache diff --git a/tools/__init__.py b/tools/__init__.py new file mode 100644 index 0000000..e69de29 diff --git a/tools/generator.py b/tools/generator.py new file mode 100644 index 0000000..c5aac49 --- /dev/null +++ b/tools/generator.py @@ -0,0 +1,181 @@ +#!/usr/bin/env python3 + +import subprocess +import textwrap +import tempfile +import os +import re +import pathlib +import glob +import runpy +import sys +import inspect +from itertools import chain + +curdir = pathlib.Path(__file__).parent +rootdir = curdir.parent +sys.path.insert(0, str(curdir)) + + +def sollya(expr, as_int=None, from_path=None, dump=False, encoding="utf-8"): + """Sollya wrapper with comprehensive message filtering using temp file""" + expr = textwrap.dedent(expr).strip() + # Create temporary file + with tempfile.NamedTemporaryFile( + mode="w", suffix=".sollya", delete=False, encoding=encoding + ) as f: + f.write(expr + "\n") + if from_path: + with open(from_path, "r", encoding=encoding) as rf: + f.write(rf.read().strip()) + f.write("\n") + temp_file = f.name + + try: + # Execute Sollya with temp file + result = subprocess.run(["sollya", temp_file], capture_output=True, text=True) + if dump: + with open(temp_file, "r") as f: + raise TypeError(f.read() + "-" * 20 + result.stdout.strip()) + # Define patterns to filter out + ignore_patterns = [ + r"^Warning", # Warnings + r"^The precision has been set", # Precision messages + r"^Display mode is ", # Default precision messages + r"^\s*$", # Empty lines + ] + + lines = result.stdout.strip().split("\n") + filtered = [] + + for line in lines: + line = line.strip() + if line: + # Check if line matches any ignore pattern + should_ignore = any( + re.match(pattern, line) for pattern in ignore_patterns + ) + if not should_ignore: + filtered.append(line) + if as_int: + return [int(num, base=as_int) for num in filtered] + return filtered + + finally: + # Clean up temp file + os.unlink(temp_file) + + +def c_header(*lines, namespace, inspect_idx=1): + """Generate C++ header with optional namespace""" + caller_frame = inspect.stack()[inspect_idx] + caller_filepath = caller_frame.filename + file = pathlib.Path(caller_filepath).resolve() + rfile = str(file.relative_to(rootdir)) + guard_name = rfile.upper().replace("/", "_").replace(".", "_").replace("-", "_") + header = [ + f"// Do not edit this file, it is generated by {rfile}", + "// use `spin generate -f` to force regeneration", + f"#ifndef {guard_name}", + f"#define {guard_name}", + ] + header.extend([f"namespace {namespace} {{ namespace {{"]) + header.extend(lines) + header.append("}} // namespace {namespace}") + header.append(f"#endif // {guard_name}") + return "\n".join(header) + + +def array(data, col, sfx, indent, start, end): + """Generate a nicely aligned C-style array.""" + # Convert all values to strings with suffix + str_data = [f"{x}{sfx}," for x in data] + str_data = ["0.0f," if s == "0f," else s for s in str_data] + # Determine the max width for each value (for alignment) + width = max(len(s) for s in str_data) + pad = " " * indent + lines = [] + for i in range(0, len(str_data), col): + chunk = str_data[i : i + col] + line = " ".join(s.ljust(width) for s in chunk) + lines.append(pad + line) + + return start + "\n" + "\n".join(lines) + "\n" + end + + +def py_array(data, col=8, sfx="", indent=4): + return array(data, col, sfx, indent, "[", "]") + + +def c_array(data, col=8, sfx="", indent=4): + return array(data, col, sfx, indent, "{", "};") + + +def main(force): + path = rootdir / "npsr" + patterns = (f"{path}/**/data/*.h.py", f"{path}/**/data/*.py.py") + files = list(chain.from_iterable(glob.glob(p, recursive=True) for p in patterns)) + + for f in files: + out = f.replace(".h.py", ".h").replace(".py.py", ".py") + + # check if the file exists + if not force and pathlib.Path(out).exists(): + print(f"Skipping {out}, file already exists") + continue + + print(f"Generating {out} from {f}") + with open(out, "w") as fd: + old_stdout = sys.stdout + sys.stdout = fd + try: + runpy.run_path(f) + finally: + sys.stdout = old_stdout + + +def pad_list(data, pad_length=512): + """ + Pad a list to make its length a multiple of pad_length by repeating elements from the list itself. + + Required because the C++ testing unit validates: + - Array size must be >= lane count + - Array size must be divisible by lane count + + Without padding, arrays get rejected with: + "each array size must be aligned and >= its lane count" + + Args: + data (list): Input list to be padded + pad_length (int): Required alignment boundary (default: 512) + + Returns: + list: Padded list that passes C++ validation + """ + if not data: + return data + + length = len(data) + remainder = length % pad_length + if remainder != 0: + padding_needed = pad_length - remainder + # Repeat the list cyclically + padding = (data * ((padding_needed // length) + 1))[:padding_needed] + data.extend(padding) + return data + + +if __name__ == "__main__": + import argparse + + parser = argparse.ArgumentParser( + description="Generate C++ headers/python templates from Python scripts." + ) + parser.add_argument( + "-f", + "--force", + action="store_true", + help="Force regenerate all files, even if they already exist.", + ) + args = parser.parse_args() + main(force=args.force) From 973f3a2ff11269a9f2561cb85f19f51656d9687f Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:16:04 +0300 Subject: [PATCH 04/20] Add spin build system configuration - Configure spin commands for building, testing, and development - Add custom generate command for sollya-based file generation - Set up IPython integration with pre-imported numpy_sr module - Configure project metadata and build requirements --- .spin/cmds.py | 97 ++++++++++++++++++++++++++++++++++++++++++++++++++ pyproject.toml | 58 ++++++++++++++++++++++++++++++ 2 files changed, 155 insertions(+) create mode 100644 .spin/cmds.py create mode 100644 pyproject.toml diff --git a/.spin/cmds.py b/.spin/cmds.py new file mode 100644 index 0000000..ac53a56 --- /dev/null +++ b/.spin/cmds.py @@ -0,0 +1,97 @@ +import os +import pathlib +import sys +import click +import spin +from spin.cmds import meson + +curdir = pathlib.Path(__file__).parent +rootdir = curdir.parent + + +@click.command(help="Generate sollya python based files") +@click.option("-f", "--force", is_flag=True, help="Force regenerate all files") +@click.option("-s", "--sollya-path", help="Path to sollya") +def generate(*, force, sollya_path): + spin.util.run( + ["python", str(rootdir / "tools" / "generator.py")] + + (["--force"] if force else []), + ) + + +@spin.util.extend_command(spin.cmds.meson.build) +def build(*, parent_callback, **kwargs): + parent_callback(**kwargs) + + +@click.option( + "-m", + "markexpr", + metavar="MARKEXPR", + default="", + help="Run tests with the given markers", +) +@click.option( + "-m", + "markexpr", + metavar="MARKEXPR", + default="", + help="Run tests with the given markers", +) +@spin.util.extend_command(spin.cmds.meson.test) +def test(*, parent_callback, pytest_args, tests, markexpr, **kwargs): + """ + By default, spin will run `-m 'not slow'`. To run the full test suite, use + `spin test -m full` + """ # noqa: E501 + if (not pytest_args) and (not tests): + pytest_args = ( + "--pyargs", + "numpy_sr", + ) + + if "-m" not in pytest_args: + if markexpr != "full": + pytest_args = ("-m", markexpr) + pytest_args + + kwargs["pytest_args"] = pytest_args + parent_callback(**{"pytest_args": pytest_args, "tests": tests, **kwargs}) + + +@spin.util.extend_command(meson.python) +def python(*, parent_callback, **kwargs): + env = os.environ + env["PYTHONWARNINGS"] = env.get("PYTHONWARNINGS", "all") + + parent_callback(**kwargs) + + +@click.command(context_settings={"ignore_unknown_options": True}) +@click.argument("ipython_args", metavar="", nargs=-1) +@meson.build_dir_option +def ipython(*, ipython_args, build_dir): + """💻 Launch IPython shell with PYTHONPATH set + + OPTIONS are passed through directly to IPython, e.g.: + + spin ipython -i myscript.py + """ + env = os.environ + env["PYTHONWARNINGS"] = env.get("PYTHONWARNINGS", "all") + + ctx = click.get_current_context() + ctx.invoke(spin.cmds.meson.build) + + ppath = meson._set_pythonpath(build_dir) + + print(f'💻 Launching IPython with PYTHONPATH="{ppath}"') + + # In spin >= 0.13.1, can replace with extended command, setting `pre_import` + preimport = ( + r"import numpy_sr as sr; " + r"print(f'\nPreimported NumPy SIMD Routines Tests {sr.__version__} as sr')" + ) + spin.util.run( + ["ipython", "--ignore-cwd", f"--TerminalIPythonApp.exec_lines={preimport}"] + + list(ipython_args) + ) diff --git a/pyproject.toml b/pyproject.toml new file mode 100644 index 0000000..a80cbdb --- /dev/null +++ b/pyproject.toml @@ -0,0 +1,58 @@ +[build-system] +build-backend = "mesonpy" +requires = [ + "meson-python>=0.15.0", +] + +[project] +name = "numpy-simd-routines-test" +version = "1.0.0.dev0" +# TODO: add `license-files` once PEP 639 is accepted (see meson-python#88) +license = {file = "LICENSE.txt"} + +description = "Fundamental package for array computing in Python" +authors = [{name = "NumPy Developers."}] +maintainers = [ + {name = "NumPy Developers", email="numpy-discussion@python.org"}, +] +requires-python = ">=3.11" +readme = "README.md" +classifiers = [ + 'Intended Audience :: Science/Research', +] + +[project.urls] +homepage = "https://numpy.org" +documentation = "https://numpy.org/doc/" +source = "https://github.com/numpy/numpy" +download = "https://pypi.org/project/numpy/#files" +tracker = "https://github.com/numpy/numpy/issues" +"release notes" = "https://numpy.org/doc/stable/release" + +#[tool.meson-python.args] +#install = ['--tags=runtime,python-runtime,tests,devel'] + +[tool.spin] +package = 'numpy_sr' + +[tool.spin.commands] +"Build" = [ + ".spin/cmds.py:test", + ".spin/cmds.py:build", + ".spin/cmds.py:generate", +] +"Environments" = [ + "spin.cmds.meson.run", + ".spin/cmds.py:ipython", + ".spin/cmds.py:python", + "spin.cmds.meson.gdb", + "spin.cmds.meson.lldb" +] +# "Documentation" = [ +# ".spin/cmds.py:docs", +# ".spin/cmds.py:changelog", +# ".spin/cmds.py:notes", +# ".spin/cmds.py:check_docs", +# ".spin/cmds.py:check_tutorials", +# ] +# "Metrics" = [".spin/cmds.py:bench"] From 2bf9b0389ea2d94fe5fddb8eb0444577b863b1f9 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:16:27 +0300 Subject: [PATCH 05/20] Add SIMD intrinsics testing framework - Implement Python bindings for Highway SIMD intrinsics - Add type system for scalar/vector data with proper conversions - Create dynamic dispatch system for multiple SIMD targets - Include helper functions for ULP distance calculations - Set up pytest infrastructure for comprehensive testing --- meson.build | 18 ++ test/__init__.py | 173 +++++++++++++++++ test/conftest.py | 10 + test/datatypes.py | 226 ++++++++++++++++++++++ test/meson.build | 32 +++ test/src/bind-inl.h | 48 +++++ test/src/helper-intrins-inl.h | 71 +++++++ test/src/intrins-inl.h | 311 ++++++++++++++++++++++++++++++ test/src/module.cpp | 178 +++++++++++++++++ test/src/prec-bind-inl.h | 25 +++ test/test/__init__.py | 0 test/test/tests/__init__.py | 0 test/test/tests/test_datatypes.py | 1 + test/utils.py | 6 + 14 files changed, 1099 insertions(+) create mode 100644 meson.build create mode 100644 test/__init__.py create mode 100644 test/conftest.py create mode 100644 test/datatypes.py create mode 100644 test/meson.build create mode 100644 test/src/bind-inl.h create mode 100644 test/src/helper-intrins-inl.h create mode 100644 test/src/intrins-inl.h create mode 100644 test/src/module.cpp create mode 100644 test/src/prec-bind-inl.h create mode 100644 test/test/__init__.py create mode 100644 test/test/tests/__init__.py create mode 100644 test/test/tests/test_datatypes.py create mode 100644 test/utils.py diff --git a/meson.build b/meson.build new file mode 100644 index 0000000..19bab5a --- /dev/null +++ b/meson.build @@ -0,0 +1,18 @@ +project( + 'NumPy SIMD routines tests', + 'cpp', + version: '0.01', + license: 'BSD-3', + meson_version: '>=1.5.2', + default_options: [ + 'buildtype=debugoptimized', + 'b_ndebug=if-release', + 'cpp_std=c++17', + ], +) + +py = import('python').find_installation(pure: false) +npsr_dir = py.get_install_dir() / 'numpy_sr' + +subdir('test') +subdir('npsr') diff --git a/test/__init__.py b/test/__init__.py new file mode 100644 index 0000000..05271de --- /dev/null +++ b/test/__init__.py @@ -0,0 +1,173 @@ +from .datatypes import ( + uint16_t, + int16_t, + uint32_t, + int32_t, + uint64_t, + int64_t, + float32_t, + float64_t, + Vec, + Precise, + SRType, +) +from .utils import bitcast + + +from ._intrins import __targets__ as targets + + +def _get_type_from_overload_arg(probs): + scalar_map = { + (2, 0, 1): uint16_t, + (2, 0, 0): int16_t, + (4, 0, 1): uint32_t, + (4, 0, 0): int32_t, + (8, 0, 1): uint64_t, + (8, 0, 0): int64_t, + (4, 1, 0): float32_t, + (8, 1, 0): float64_t, + } + scalar_type = scalar_map.get( + (probs["kTypeSize"], probs["kIsFloat"], probs["kIsUnsigned"]) + ) + if scalar_type is None: + raise ValueError( + f"Unsupported scalar type: kTypeSize={probs['kTypeSize']}, " + f"kIsFloat={probs['kIsFloat']}, kIsUnsigned={probs['kIsUnsigned']}" + ) + nlanes = probs.get("kLanes", 1) + if nlanes == 1: + return scalar_type + else: + return Vec(scalar_type) + + +class WrapIntrinsic: + def __init__(self, name, overloads): + self.name = name + self.overloads = {} + for cfunc, info in overloads: + args_types = [] + ret_type = None + for dct in info: + if dct is None: + continue + if dct.pop("kIsPrecise", False): + args_types.append(Precise(**dct)) + elif dct.pop("kIsRet", False): + ret_type = _get_type_from_overload_arg(dct) + elif dct: + args_types += [_get_type_from_overload_arg(dct)] + self.overloads[hash(tuple(args_types))] = (cfunc, ret_type, args_types) + + def signatures(self): + args = self.overloads.values() + return "\n".join( + [ + f"{ret_type.__name__} {self.name}( {', '.join([str(a) for a in args_types])} )" + for _, ret_type, args_types in args + ] + ) + + def __call__(self, *args): + # Check if the first argument is a Precise instance + # hash of Precise based on the value of its attributes + args_prec = [a if isinstance(a, Precise) else type(a) for a in args] + args_only = [a for a in args if not isinstance(a, Precise)] + try: + h = hash(tuple(args_prec)) + cfunc, ret_type, _ = self.overloads.get(h, [None] * 3) + # incase of mismatch unhashable types + except TypeError: + cfunc, ret_type = None, None + if not cfunc: + args_str = ", ".join([str(a) for a in args_prec]) + raise TypeError( + f"no matching signature to call {self.name}( {args_str} )\n" + f"only the following signatures are supported:\n" + self.signatures() + ) + ret_bytes = cfunc(*[a.to_bytearray() for a in args_only]) + if not isinstance(ret_bytes, bytearray): + raise TypeError( + f"expected bytearray return type from {self.name}, got {type(ret_bytes).__name__}" + ) + if ret_type is not None: + return ret_type.from_bytes(ret_bytes) + return ret_type + + +class SimdExtention: + def __init__(self, name, mod_ext): + self.__name__ = name + self.intrinsics = {} + for name, val in mod_ext.__dict__.items(): + if name.startswith("_"): + setattr(self, name, val) + continue + func = WrapIntrinsic(name, val) + self.intrinsics[name] = func + setattr(self, name, func) + + for extra_intrin in ["Lanes", "Set", "BitCast", "assert_ulp"]: + self.intrinsics[extra_intrin] = getattr(self, extra_intrin) + + def __repr__(self): + return "numpy_sr." + self.__name__ + + def __str__(self): + return self.__name__ + + def Lanes(self, element_type): + return self._REGISTER_WIDTH // element_type.element_size + + def Set(self, element_type, val): + return Vec(element_type)([val] * self.Lanes(element_type)) + + def BitCast(self, eltype, value): + return bitcast(eltype, value) + + def assert_ulp(self, actual, expected, input, max_ulp=1, per_line=4): + __tracebackhide__ = True # Hide traceback for py.test + ulp = self.UlpDistance(actual, expected) + actual, expected, input, ulp = ( + arg.to_list() for arg in [actual, expected, input, ulp] + ) + if any([i > max_ulp for i in ulp]): + vals = [] + for i, ul in enumerate(ulp): + if int(ul) <= max_ulp: + continue + vals.append( + str(tuple(x for x in (input[i], actual[i], expected[i], ul))) + ) + raise AssertionError( + f"Expected ULP distance {max_ulp}, worst {max(ulp)}, interleaved(input, actual, expected, ulp) as follow:" + + "\n " + + "\n ".join(vals) + + "\n", + ) + + +wrap_targets = {} +for name, simd_ext in targets.items(): + wrap_targets[name] = SimdExtention(name, simd_ext) + globals()[name] = wrap_targets[name] +targets = wrap_targets + +__version__ = "1.0.0" + +__all__ = [ + "uint16_t", + "int16_t", + "uint32_t", + "int32_t", + "uint64_t", + "int64_t", + "float32_t", + "float64_t", + "Vec", + "Precise", + "targets", + "bitcast", +] diff --git a/test/conftest.py b/test/conftest.py new file mode 100644 index 0000000..3587e19 --- /dev/null +++ b/test/conftest.py @@ -0,0 +1,10 @@ +import pytest +import numpy_sr as sr + + +@pytest.fixture(params=list(sr.targets.values()), autouse=True, scope="function") +def setup_target(request): + target = request.param + _globals = request.function.__globals__ + _globals.update(target.intrinsics) + yield target diff --git a/test/datatypes.py b/test/datatypes.py new file mode 100644 index 0000000..e3f46f6 --- /dev/null +++ b/test/datatypes.py @@ -0,0 +1,226 @@ +import operator +import ctypes +from dataclasses import dataclass +from enum import IntEnum, auto + + +@dataclass(frozen=True) +class Precise: + kNoExceptions: bool = False + kLowAccuracy: bool = False + kNoLargeArgument: bool = False + kNoSpecialCases: bool = False + kDAZ: bool = False + kFTZ: bool = False + kIEEE754: bool = True + kRoundForce: bool = False + kRoundNearest: bool = True + kRoundDown: bool = False + kRoundUp: bool = False + kRoundZero: bool = False + + +class _ContainerID(IntEnum): + SCALAR = 1 + VEC = auto() + + +class _ElementID(IntEnum): + VOID = 0 + UINT16 = auto() + INT16 = auto() + UINT32 = auto() + INT32 = auto() + UINT64 = auto() + INT64 = auto() + FLOAT32 = auto() + FLOAT64 = auto() + + +def _float_cvt(val): + if isinstance(val, float): + return val + elif isinstance(val, int): + return float(val) + elif isinstance(val, str): + return float.fromhex(val) + else: + raise TypeError(f"Cannot convert {type(val)} to float") + + +class _Sequence: + def __init__(self, vals): + data_type = self.element_ctype * len(vals) + cvt = _float_cvt if self.element_id > _ElementID.INT64 else int + data = data_type(*[cvt(v) for v in vals]) + self._bytearray = bytearray(bytes(data)) + + def data(self): + data_type = self.element_ctype * len(self) + return data_type.from_buffer(self._bytearray) + + def __getitem__(self, index): + data = self.data() + try: + data = data[index] + except IndexError: + raise IndexError(type(self).__name__ + " index out of range") + if isinstance(index, int): + tp = SRType.byid(_ContainerID.SCALAR, self.element_id) + return tp(data) + return type(self)(*data) + + def __setitem__(self, index, value): + data = self.data() + data[index] = value + + def __len__(self): + return len(self._bytearray) // self.element_size + + def __iter__(self): + yield from self._iterate_items() + + def _iterate_items(self): + tp = SRType.byid(_ContainerID.SCALAR, self.element_id) + data = self.data() + for d in data: + yield tp(d) + + def __str__(self): + return str(tuple(self.data())) + + def __repr__(self): + return type(self).__name__ + str(self) + + def to_list(self): + return [v for v in self.data()] + + def to_bytearray(self): + return self._bytearray + + @classmethod + def from_bytes(cls, raw): + self = super().__new__(cls) + self._bytearray = bytearray(bytes(raw)) + return self + + +class _Scalar: + def __init__(self, val): + cvt = _float_cvt if self.element_id > _ElementID.INT64 else int + data = self.element_ctype(cvt(val)) + self._bytearray = bytearray(bytes(data)) + + def data(self): + return self.element_ctype.from_buffer(self._bytearray) + + def __str__(self): + return str(self.data().value) + + def __repr__(self): + return type(self).__name__ + f"({str(self)})" + + def __int__(self): + return int(self.data().value) + + def __float__(self): + return float(self.data().value) + + def __bool__(self): + return bool(self.data().value) + + def to_bytearray(self): + return self._bytearray + + @classmethod + def from_bytes(cls, raw): + self = super().__new__(cls) + self._bytearray = bytearray(bytes(raw)) + return self + + +class SRType(type): + _insta_cache = {} + _prop_by_eid = { + _ElementID.UINT16: ("uint16_t", ctypes.c_uint16), + _ElementID.INT16: ("int16_t", ctypes.c_int16), + _ElementID.UINT32: ("uint32_t", ctypes.c_uint32), + _ElementID.INT32: ("int32_t", ctypes.c_int32), + _ElementID.UINT64: ("uint64_t", ctypes.c_uint64), + _ElementID.INT64: ("int64_t", ctypes.c_int64), + _ElementID.FLOAT32: ("float32_t", ctypes.c_float), + _ElementID.FLOAT64: ("float64_t", ctypes.c_double), + } + + _prop_by_cid = { + _ContainerID.SCALAR: ("{}", _Scalar), + _ContainerID.VEC: ("Vec({})", _Sequence), + } + + def __new__(cls, _, bases, attrs): + container_id = attrs["container_id"] + element_id = attrs["element_id"] + cache_key = (container_id, element_id) + instance = cls._insta_cache.get(cache_key) + if instance: + return instance + element_name, element_ctype = cls._prop_by_eid[element_id] + container_name, container_base = cls._prop_by_cid[container_id] + bases += (container_base,) + name = container_name.format(element_name) + attrs.update( + dict(element_ctype=element_ctype, element_size=ctypes.sizeof(element_ctype)) + ) + instance = super().__new__(cls, name, bases, attrs) + SRType._insta_cache[cache_key] = instance + return instance + + @classmethod + def byid(cls, container_id, element_id): + return SRType(cls, (), dict(container_id=container_id, element_id=element_id)) + + +class uint16_t(metaclass=SRType): + container_id = _ContainerID.SCALAR + element_id = _ElementID.UINT16 + + +class int16_t(metaclass=SRType): + container_id = _ContainerID.SCALAR + element_id = _ElementID.INT16 + + +class uint32_t(metaclass=SRType): + container_id = _ContainerID.SCALAR + element_id = _ElementID.UINT32 + + +class int32_t(metaclass=SRType): + container_id = _ContainerID.SCALAR + element_id = _ElementID.INT32 + + +class uint64_t(metaclass=SRType): + container_id = _ContainerID.SCALAR + element_id = _ElementID.UINT64 + + +class int64_t(metaclass=SRType): + container_id = _ContainerID.SCALAR + element_id = _ElementID.INT64 + + +class float32_t(metaclass=SRType): + container_id = _ContainerID.SCALAR + element_id = _ElementID.FLOAT32 + + +class float64_t(metaclass=SRType): + container_id = _ContainerID.SCALAR + element_id = _ElementID.FLOAT64 + + +class Vec(SRType): + def __new__(cls, element_type): + s = cls.byid(_ContainerID.VEC, element_type.element_id) + return s diff --git a/test/meson.build b/test/meson.build new file mode 100644 index 0000000..68f7233 --- /dev/null +++ b/test/meson.build @@ -0,0 +1,32 @@ +highway_lib = static_library('highway', + [ + 'highway/hwy/abort.cc', + 'highway/hwy/aligned_allocator.cc', + 'highway/hwy/nanobenchmark.cc', + 'highway/hwy/per_target.cc', + 'highway/hwy/perf_counters.cc', + 'highway/hwy/print.cc', + 'highway/hwy/targets.cc', + 'highway/hwy/timer.cc', + ], + cpp_args: '-DTOOLCHAIN_MISS_ASM_HWCAP_H', + include_directories: ['highway'], + install: false, + gnu_symbol_visibility: 'hidden', +) + +py.extension_module('_intrins', + ['src/module.cpp'], + link_with: [ + highway_lib, + ], + include_directories: ['highway', '../'], + install: true, + install_dir: npsr_dir, +) +py.install_sources( + ['__init__.py', 'datatypes.py', 'conftest.py', 'utils.py'], + subdir: npsr_dir, +) + +install_subdir('test', install_dir: npsr_dir/'test') diff --git a/test/src/bind-inl.h b/test/src/bind-inl.h new file mode 100644 index 0000000..4ed2a91 --- /dev/null +++ b/test/src/bind-inl.h @@ -0,0 +1,48 @@ +#if defined(NPSR_TEST_SRC_BIND_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TEST_SRC_BIND_INL_H_ +#undef NPSR_TEST_SRC_BIND_INL_H_ +#else +#define NPSR_TEST_SRC_BIND_INL_H_ +#endif + +#include "intrins-inl.h" +#include "npsr/npsr.h" + +HWY_BEFORE_NAMESPACE(); +namespace npsr::HWY_NAMESPACE::test { + +template +HWY_API TVec And(const TVec a, const TVec b) { + return hn::And(a, b); +} +template +HWY_API TVec Or(const TVec a, const TVec b) { + return hn::Or(a, b); +} +template +HWY_API TVec Xor(const TVec a, const TVec b) { + return hn::Xor(a, b); +} +template +HWY_API TVec Not(const TVec a) { + return hn::Not(a); +} +template +HWY_API TVec Neg(const TVec a) { + return hn::Neg(a); +} + +template +HWY_ATTR bool Bind(PyObject *m) { + bool r = true; + r &= AttachIntrinsic...>(m, "And"); + r &= AttachIntrinsic...>(m, "Xor"); + r &= AttachIntrinsic...>(m, "Or"); + r &= AttachIntrinsic...>(m, "Not"); + r &= AttachIntrinsic...>(m, "Neg"); + return r; +} + +} // namespace npsr::HWY_NAMESPACE::test +HWY_AFTER_NAMESPACE(); +#endif // NPSR_TEST_SRC_BIND_INL_H_ diff --git a/test/src/helper-intrins-inl.h b/test/src/helper-intrins-inl.h new file mode 100644 index 0000000..74e7c83 --- /dev/null +++ b/test/src/helper-intrins-inl.h @@ -0,0 +1,71 @@ +#include "hwy/base.h" +#if defined(NPSR_TEST_HELPER_INTRINS_INL_H_) == \ + defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TEST_HELPER_INTRINS_INL_H_ +#undef NPSR_TEST_HELPER_INTRINS_INL_H_ +#else +#define NPSR_TEST_HELPER_INTRINS_INL_H_ +#endif + +#include "intrins-inl.h" + +HWY_BEFORE_NAMESPACE(); +namespace npsr::HWY_NAMESPACE::test { + +namespace hn = hwy::HWY_NAMESPACE; +using hn::DFromV; +using hn::RebindToUnsigned; +using hn::TFromV; + +template , typename D = DFromV, + typename DU = RebindToUnsigned, typename VU = hn::Vec> +HWY_API VU UlpDistance(const V& a, const V& b) { + using namespace hn; + using DI = RebindToSigned; + using VI = Vec; + using MU = Mask; + using TU = MakeUnsigned; + const DU du; + const DI di; + + // Early exit for exact equality + const MU equal = RebindMask(du, Eq(a, b)); + + // Handle special values + const MU a_special = RebindMask(du, Or(IsNaN(a), IsInf(a))); + const MU b_special = RebindMask(du, Or(IsNaN(b), IsInf(b))); + const MU any_special = Or(a_special, b_special); + + const VU a_bits = BitCast(du, a); + const VU b_bits = BitCast(du, b); + + // IEEE 754 to signed integer conversion for ULP arithmetic + const VU sign_bit = Set(du, TU(1) << (sizeof(T) * 8 - 1)); + + auto ieee_to_signed = [&](const VU& bits) -> VU { + const MU is_negative = Ne(And(bits, sign_bit), Zero(du)); + return IfThenElse(is_negative, Not(bits), Xor(bits, sign_bit)); + }; + + const VI a_signed = BitCast(di, ieee_to_signed(a_bits)); + const VI b_signed = BitCast(di, ieee_to_signed(b_bits)); + const VU ulp_diff = BitCast(du, Abs(Sub(a_signed, b_signed))); + + // Return results + const VU max_dist = Set(du, ~TU(0)); + return IfThenElse(equal, Zero(du), + + IfThenElse(any_special, max_dist, ulp_diff)); +} + +template +HWY_ATTR bool BindHelpers(PyObject* m) { + namespace hn = hwy::HWY_NAMESPACE; + bool r = true; + r &= AttachIntrinsic...>(m, "UlpDistance"); + return r; +} +} // namespace npsr::HWY_NAMESPACE::test + +HWY_AFTER_NAMESPACE(); +#endif // NPSR_TEST_HELPER_INTRINS_INL_H_ diff --git a/test/src/intrins-inl.h b/test/src/intrins-inl.h new file mode 100644 index 0000000..fcc7170 --- /dev/null +++ b/test/src/intrins-inl.h @@ -0,0 +1,311 @@ +#if defined(NPSR_TEST_SRC_INTRINS_INL_H_) == \ + defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TEST_SRC_INTRINS_INL_H_ +#undef NPSR_TEST_SRC_INTRINS_INL_H_ +#else +#define NPSR_TEST_SRC_INTRINS_INL_H_ +#endif + +#include +#include + +#include +#include +#include +#include + +#include "npsr/npsr.h" + +HWY_BEFORE_NAMESPACE(); +namespace npsr::HWY_NAMESPACE::test { +namespace hn = hwy::HWY_NAMESPACE; + +// Helper to detect if type is instantiation of Precise +template +struct IsPrecise : std::false_type {}; + +template +struct IsPrecise> : std::true_type {}; + +template +static constexpr bool kHasPrecise = IsPrecise::value; + +template +struct FilterPrecise { + using TPrecise = hn::DFromV<_TPrecise>; + using Tags = + std::tuple>...>; +}; +template +struct FilterPrecise { + using Tags = std::tuple>...>; + using TPrecise = _TPrecise; +}; + +// Helper to extract function signature from intrinsic pointer +template +struct IntrinsicOverload; + +// Specialization for function pointers +template +struct IntrinsicOverload { + using _TPrecise = std::remove_reference_t<__TPrecise>; + using Filter = FilterPrecise, _TPrecise, Args...>; + using Tags = typename Filter::Tags; + using TPrecise = typename Filter::TPrecise; + + static constexpr size_t kNumArgs = std::tuple_size_v; + static constexpr bool kEscapePrecise = !kHasPrecise; + + static PyObject *Call(PyObject *self, PyObject *args) { + return CallIs(self, args, std::make_index_sequence{}, Tags{}); + } + + template + static PyObject *CallIs(PyObject *self, PyObject *args, + std::index_sequence, std::tuple) { + Py_ssize_t length = PySequence_Fast_GET_SIZE(args); + if (length != kNumArgs) { + PyErr_Format(PyExc_TypeError, "expected %zu arguments, got %zd", kNumArgs, + length); + return nullptr; + } + using TagsU8 = std::tuple...>; + + PyObject **items = PySequence_Fast_ITEMS(args); + if (!(PyByteArray_Check(items[Is]) && ...)) { + PyErr_Format(PyExc_TypeError, "all arguments must be bytearray"); + return nullptr; + } + + PyByteArrayObject *arrays[] = { + reinterpret_cast(items[Is])...}; + Py_ssize_t sizes[] = {PyByteArray_Size(items[Is])...}; + Py_ssize_t lanes[] = {static_cast( + hn::Lanes(std::tuple_element_t{}))...}; + + // Validate each array individually + if (((sizes[Is] < lanes[Is] || sizes[Is] % lanes[Is] != 0) || ...)) { + PyErr_Format(PyExc_ValueError, + "each array size must be aligned and >= its lane count, %d"); + return nullptr; + } + const hn::Repartition> uddst; + Py_ssize_t dst_lanes = hn::Lanes(uddst); + Py_ssize_t result_size = sizes[0]; + PyObject *dst_obj = PyByteArray_FromStringAndSize(NULL, 0); + if (dst_obj == nullptr) { + return nullptr; + } + if (PyByteArray_Resize(dst_obj, result_size) < 0) { + Py_DECREF(dst_obj); + return nullptr; + } + + uint8_t *src[] = { + reinterpret_cast(PyByteArray_AS_STRING(arrays[Is]))...}; + uint8_t *dst = reinterpret_cast(PyByteArray_AS_STRING(dst_obj)); + + // Track offsets for each source array using parameter pack + // std::array src_offsets{}; + // Py_ssize_t dst_offset = 0; + + TPrecise precise{}; + // Process min_iterations worth of data + for (Py_ssize_t iter = 0; iter < result_size; iter += dst_lanes) { + // Load from each source at its current offset + // clang-format off + VRet ret; + if constexpr (kHasPrecise) { + ret = IntrinPtr( + precise, + hn::BitCast( + std::tuple_element_t{}, + hn::LoadU( + std::tuple_element_t{}, + src[Is] + iter + ) + ) + ...); + } + else { + ret = IntrinPtr( + hn::BitCast( + std::tuple_element_t{}, + hn::LoadU( + std::tuple_element_t{}, + src[Is] + iter + ) + ) + ...); + } + // clang-format on + hn::StoreU(hn::BitCast(uddst, ret), uddst, dst + iter); + } + return dst_obj; + } + + static PyObject *OverloadInfo() { return OverloadInfo_(Tags{}); } + + template + static PyObject *OverloadInfo_(std::tuple) { + constexpr size_t kNumItems = 2 + kNumArgs; + return PyTuple_Pack(kNumItems, GetTagTypeInfo, true>(), + GetPrecise(), GetTagTypeInfo()...); + } + + template + static PyObject *GetTagTypeInfo() { + using T = hn::TFromD; + constexpr std::pair kInfo[] = { + {"kIsRet", static_cast(IS_RET)}, + {"kLanes", hn::Lanes(Tag{})}, + {"kTypeSize", static_cast(sizeof(T))}, + {"kIsUnsigned", std::is_unsigned_v ? 1 : 0}, + {"kIsSigned", std::is_signed_v ? 1 : 0}, + {"kIsFloat", std::is_floating_point_v ? 1 : 0}, + {"kIsInteger", std::is_integral_v ? 1 : 0}, + }; + PyObject *info = PyDict_New(); + if (info == nullptr) { + return nullptr; + } + for (const auto &[key_name, key_val] : kInfo) { + PyObject *py_key = PyUnicode_FromString(key_name); + PyObject *py_val = PyLong_FromLong(key_val); + if (py_key == nullptr || py_val == nullptr || + PyDict_SetItem(info, py_key, py_val) < 0) { + Py_XDECREF(py_key); + Py_XDECREF(py_val); + Py_DECREF(info); + return nullptr; + } + Py_DECREF(py_key); + Py_DECREF(py_val); + } + return info; + } + template + static std::enable_if_t, PyObject *> GetPrecise() { + constexpr std::pair kPreciseOptions[] = { + {true, "kIsPrecise"}, + {TPrec::kLowAccuracy, "kLowAccuracy"}, + {TPrec::kNoLargeArgument, "kNoLargeArgument"}, + {TPrec::kNoSpecialCases, "kNoSpecialCases"}, + {TPrec::kNoExceptions, "kNoExceptions"}, + {TPrec::kRoundForce, "kRoundForce"}, + {TPrec::kRoundNearest, "kRoundNearest"}, + {TPrec::kRoundZero, "kRoundZero"}, + {TPrec::kRoundDown, "kRoundDown"}, + {TPrec::kRoundUp, "kRoundUp"}, + {TPrec::kDAZ, "kDAZ"}, + {TPrec::kFTZ, "kFTZ"}, + {TPrec::kIEEE754, "kIEEE754"}, + }; + PyObject *preciseOptions = PyDict_New(); + if (preciseOptions == nullptr) { + return nullptr; + } + for (const auto &[is_enabled, option_name] : kPreciseOptions) { + PyObject *py_name = PyUnicode_FromString(option_name); + PyObject *py_value = is_enabled ? Py_True : Py_False; + Py_INCREF(py_value); // Increment ref count for Py_True/Py_False + + if (py_name == nullptr || + PyDict_SetItem(preciseOptions, py_name, py_value) < 0) { + Py_XDECREF(py_name); + Py_XDECREF(py_value); + Py_DECREF(preciseOptions); + return nullptr; + } + Py_DECREF(py_name); + Py_DECREF(py_value); + } + return preciseOptions; + } + template + static std::enable_if_t, PyObject *> GetPrecise() { + return Py_None; + } +}; + +template +inline bool AttachIntrinsic(PyObject *m, const char *name) { + // Create static method definitions that persist + static std::string name_storage(name); + static PyMethodDef methods[] = { + {name_storage.c_str(), + static_cast(IntrinsicOverload::Call), + METH_VARARGS, "Intrinsic function overload"}..., + {nullptr, nullptr, 0, nullptr} // Sentinel + }; + + // Check if attribute already exists + PyObject *existing_list = nullptr; + bool is_new_list = true; + + if (PyObject_HasAttrString(m, name)) { + existing_list = PyObject_GetAttrString(m, name); + if (existing_list && PyList_Check(existing_list)) { + is_new_list = false; + } else { + Py_XDECREF(existing_list); + existing_list = nullptr; + } + } + + PyObject *overload_list; + if (is_new_list) { + overload_list = PyList_New(0); + if (!overload_list) { + return false; + } + } else { + overload_list = existing_list; + } + // Create overload info array + PyObject *overloads_info[] = { + IntrinsicOverload::OverloadInfo()..., nullptr}; + // Create functions and tuples + for (size_t i = 0; i < sizeof...(IntrinPtrs); ++i) { + PyObject *func = PyCFunction_New(&methods[i], nullptr); + if (!func) { + goto cleanup_fail; + } + PyObject *tuple = PyTuple_Pack(2, func, overloads_info[i]); + if (!tuple) { + Py_DECREF(func); + goto cleanup_fail; + } + + if (PyList_Append(overload_list, tuple) < 0) { + Py_DECREF(tuple); + goto cleanup_fail; + } + Py_DECREF(tuple); // PyList_Append increments ref count + } + + // Set attribute only for new lists + if (is_new_list) { + if (PyObject_SetAttrString(m, name, overload_list) < 0) { + Py_DECREF(overload_list); + return false; + } + Py_DECREF(overload_list); // Module holds the reference now + } + return true; + +cleanup_fail: + // Clean up any allocated overload info objects + for (size_t i = 0; i < sizeof...(IntrinPtrs); ++i) { + Py_XDECREF(overloads_info[i]); + } + if (is_new_list) { + Py_DECREF(overload_list); + } + return false; +} +} // namespace npsr::HWY_NAMESPACE::test +HWY_AFTER_NAMESPACE(); +#endif // NPSR_TEST_SRC_INTRINS_INL_H_ diff --git a/test/src/module.cpp b/test/src/module.cpp new file mode 100644 index 0000000..04835e9 --- /dev/null +++ b/test/src/module.cpp @@ -0,0 +1,178 @@ +#undef HWY_TARGET_INCLUDE +#define HWY_TARGET_INCLUDE "src/module.cpp" + +#include +#include + +#include + +#include "bind-inl.h" +#include "helper-intrins-inl.h" +#include "prec-bind-inl.h" + +HWY_BEFORE_NAMESPACE(); +namespace npsr::HWY_NAMESPACE { +using namespace test; +namespace hn = hwy::HWY_NAMESPACE; + +template +struct TagByWidthHelper { + using type = hn::FixedTag; // Only instantiated when WIDTH != 0 +}; + +template +struct TagByWidthHelper<0, TLane> { + using type = hn::ScalableTag; // Only instantiated when WIDTH == 0 +}; + +template +using TagByWidth = typename TagByWidthHelper::type; +template +using VecsByWidth = std::tuple>...>; + +template +HWY_ATTR bool LoadPreciseIntrinsics(PyObject *m, PreciseTuple, VecTuple); + +template +HWY_ATTR bool LoadPreciseIntrinsics(PyObject *m, std::tuple, + std::tuple) { + bool r = true; + ((r &= PreciseBind(m)), ...); + return r; +} + +template +HWY_ATTR bool LoadIntrinsics(PyObject *m, std::tuple) { + bool r = true; + ((r &= Bind(m)), ...); + return r; +} + +template +HWY_ATTR bool LoadHelpersIntrinsics(PyObject *m, std::tuple) { + bool r = true; + ((r &= BindHelpers(m)), ...); + return r; +} + +template +HWY_ATTR PyObject *Target(bool &escape) { +#if HWY_NATIVE_FMA +#define STRINGIFY(x) #x +#define TOSTRING(x) STRINGIFY(x) + static std::string module_name = "npsr." TOSTRING(HWY_NAMESPACE) + []() { + if constexpr (WIDTH == 0) + return std::string(""); + else + return "_force" + std::to_string(WIDTH); + }(); + + static PyModuleDef defs = { + PyModuleDef_HEAD_INIT, module_name.c_str(), "", -1, nullptr, + }; + + PyObject *m = PyModule_Create(&defs); + if (m == nullptr) { + return nullptr; + } + constexpr std::pair constants[] = { + {"_HAVE_FLOAT16", HWY_HAVE_FLOAT16}, + {"_HAVE_FLOAT64", HWY_HAVE_FLOAT64}, + {"_REGISTER_WIDTH", hn::Lanes(TagByWidth{})}, + }; + for (const auto &[name, value] : constants) { + PyObject *py_value = PyLong_FromLong(value); + if (py_value == nullptr || PyModule_AddObject(m, name, py_value) < 0) { + Py_XDECREF(py_value); + Py_DECREF(m); + return nullptr; + } + } + + using PreciseTypes = + std::tuple; + + // clang-format off + using VecTypes = VecsByWidth; + // clang-format on + + if (!LoadPreciseIntrinsics(m, PreciseTypes{}, VecTypes{})) { + Py_DECREF(m); + return nullptr; + } + if (!LoadIntrinsics(m, VecTypes{})) { + Py_DECREF(m); + return nullptr; + } + if (!LoadHelpersIntrinsics(m, VecTypes{})) { + Py_DECREF(m); + return nullptr; + } + return m; +#else + escape = true; + return nullptr; +#endif +} + +template PyObject *Target<0>(bool &); + +} // namespace npsr::HWY_NAMESPACE +HWY_AFTER_NAMESPACE(); + +#if HWY_ONCE +namespace npsr { + +HWY_EXPORT_T(Target0, Target<0>); + +extern "C" { +PyMODINIT_FUNC PyInit__intrins(void) { + static PyMethodDef methods[] = { + {NULL, NULL, 0, NULL}, + }; + static struct PyModuleDef defs = {PyModuleDef_HEAD_INIT, "npsr", + "NPsr testing framework", -1, methods}; + + PyObject *m = PyModule_Create(&defs); + if (m == NULL) { + return NULL; + } + PyObject *targets = PyDict_New(); + if (targets == NULL) { + goto err; + } + if (PyModule_AddObject(m, "__targets__", targets) < 0) { + Py_DECREF(targets); + goto err; + } + for (uint64_t target : hwy::SupportedAndGeneratedTargets()) { + hwy::SetSupportedTargetsForTest(target); + hwy::GetChosenTarget().Update(hwy::SupportedTargets()); + bool escape = false; + PyObject *target_mod = HWY_DYNAMIC_DISPATCH(Target0)(escape); + if (target_mod == nullptr) { + if (escape) { + // due to fma not being supported + continue; + } + goto err; + } + if (PyDict_SetItemString(targets, hwy::TargetName(target), target_mod) < + 0) { + Py_DECREF(target_mod); + goto err; + } + } + return m; +err: + Py_DECREF(m); + return nullptr; +} +} // namespace npsr +} // namespace npsr +#endif // HWY_ONCE diff --git a/test/src/prec-bind-inl.h b/test/src/prec-bind-inl.h new file mode 100644 index 0000000..f5a3ec6 --- /dev/null +++ b/test/src/prec-bind-inl.h @@ -0,0 +1,25 @@ +#if defined(NPSR_TEST_SRC_PREC_BIND_INL_H_) == \ + defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TEST_SRC_PREC_BIND_INL_H_ +#undef NPSR_TEST_SRC_PREC_BIND_INL_H_ +#else +#define NPSR_TEST_SRC_PREC_BIND_INL_H_ +#endif + +#include "intrins-inl.h" +#include "npsr/npsr.h" + +HWY_BEFORE_NAMESPACE(); +namespace npsr::HWY_NAMESPACE::test { + +template +HWY_ATTR bool PreciseBind(PyObject *m) { + bool r = true; + r &= AttachIntrinsic...>(m, "Sin"); + r &= AttachIntrinsic...>(m, "Cos"); + return r; +} + +} // namespace npsr::HWY_NAMESPACE::test +HWY_AFTER_NAMESPACE(); +#endif // NPSR_TEST_SRC_PREC_BIND_INL_H_ diff --git a/test/test/__init__.py b/test/test/__init__.py new file mode 100644 index 0000000..e69de29 diff --git a/test/test/tests/__init__.py b/test/test/tests/__init__.py new file mode 100644 index 0000000..e69de29 diff --git a/test/test/tests/test_datatypes.py b/test/test/tests/test_datatypes.py new file mode 100644 index 0000000..4640904 --- /dev/null +++ b/test/test/tests/test_datatypes.py @@ -0,0 +1 @@ +# TODO diff --git a/test/utils.py b/test/utils.py new file mode 100644 index 0000000..4c7cef7 --- /dev/null +++ b/test/utils.py @@ -0,0 +1,6 @@ +from .datatypes import SRType + + +def bitcast(eltype, value): + tp = SRType.byid(value.container_id, eltype.element_id) + return tp.from_bytes(value.to_bytearray()) From 390fcb8a224e88e07bd4a910f5255f30717ebaf1 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:20:01 +0300 Subject: [PATCH 06/20] replace sin/cos lut with the new generators --- npsr/trig/data/large-aprox.h | 1553 ++ npsr/trig/data/large-aprox.h.py | 52 + npsr/trig/data/large-reduction.h | 2316 +++ npsr/trig/data/large-reduction.h.py | 51 + npsr/trig/data/small.h | 25 + npsr/trig/data/small.h.py | 64 + npsr/trig/lut-inl.h | 25437 -------------------------- npsr/trig/lut-inl.h.py | 224 - 8 files changed, 4061 insertions(+), 25661 deletions(-) create mode 100644 npsr/trig/data/large-aprox.h create mode 100644 npsr/trig/data/large-aprox.h.py create mode 100644 npsr/trig/data/large-reduction.h create mode 100644 npsr/trig/data/large-reduction.h.py create mode 100644 npsr/trig/data/small.h create mode 100644 npsr/trig/data/small.h.py delete mode 100644 npsr/trig/lut-inl.h delete mode 100644 npsr/trig/lut-inl.h.py diff --git a/npsr/trig/data/large-aprox.h b/npsr/trig/data/large-aprox.h new file mode 100644 index 0000000..eab5a45 --- /dev/null +++ b/npsr/trig/data/large-aprox.h @@ -0,0 +1,1553 @@ +// Do not edit this file, it is generated by npsr/trig/data/large-aprox.h.py +// use `spin generate -f` to force regeneration +#ifndef NPSR_TRIG_DATA_LARGE_APROX_H_PY +#define NPSR_TRIG_DATA_LARGE_APROX_H_PY +namespace npsr::trig::data { namespace { +template constexpr T kSinApproxTable[] = {}; +template constexpr T kCosApproxTable[] = {}; +template <> constexpr float kSinApproxTable[] = { + 0.0f, 0x1p0f, 0.0f, 0.0f, + -0x1.3bcfbep-12f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, + -0x1.3bc39p-10f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, + -0x1.63253p-9f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, + -0x1.3b92e2p-8f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, + -0x1.ecdc78p-8f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, + -0x1.62aa04p-7f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, + -0x1.e26c16p-7f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, + -0x1.3ad06p-6f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, + -0x1.8e18a8p-6f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, + -0x1.eb0208p-6f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, + -0x1.28bf18p-5f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, + -0x1.60beaap-5f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, + -0x1.9d7714p-5f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, + -0x1.dedefcp-5f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, + -0x1.127624p-4f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, + -0x1.37ca18p-4f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, + -0x1.5f6598p-4f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, + -0x1.894286p-4f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, + -0x1.b55a7p-4f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, + -0x1.e3a688p-4f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, + -0x1.0a0fd4p-3f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, + -0x1.235f2ep-3f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, + -0x1.3dbd6ap-3f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, + -0x1.592676p-3f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, + -0x1.759618p-3f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, + -0x1.9307eep-3f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, + -0x1.b1776ep-3f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, + -0x1.d0dfe6p-3f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, + -0x1.f13c7ep-3f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, + -0x1.09441cp-2f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, + -0x1.1a5efap-2f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, + -0x1.2bec34p-2f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, + -0x1.3de916p-2f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, + -0x1.5052dap-2f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, + -0x1.6326a8p-2f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, + -0x1.76619cp-2f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, + -0x1.8a00bap-2f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, + -0x1.9e01p-2f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, + -0x1.b25f56p-2f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, + -0x1.c71898p-2f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, + -0x1.dc2996p-2f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, + -0x1.f18f0cp-2f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, + -0x1.d16c9p-8f, 0x1p-1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, + -0x1.d4a2c8p-6f, 0x1p-1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, + -0x1.9cc8b4p-5f, 0x1p-1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, + -0x1.28bbfep-4f, 0x1p-1f, 0x1.ced7bp-1f, -0x1.786712p-26f, + -0x1.8421bp-4f, 0x1p-1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, + -0x1.e08756p-4f, 0x1p-1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, + -0x1.1eef5ap-3f, 0x1p-1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, + -0x1.4e0cb2p-3f, 0x1p-1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, + -0x1.7d946ep-3f, 0x1p-1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, + -0x1.ad7f3ap-3f, 0x1p-1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, + -0x1.ddc5b4p-3f, 0x1p-1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, + -0x1.cc0d0ap-8f, 0x1p-2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, + -0x1.fa3ecap-6f, 0x1p-2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, + -0x1.c1d1fp-5f, 0x1p-2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, + -0x1.43bd78p-4f, 0x1p-2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, + -0x1.a6fdf2p-4f, 0x1p-2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, + -0x1.536352p-9f, 0x1p-3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, + -0x1.ba165p-6f, 0x1p-3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, + -0x1.a55beep-5f, 0x1p-3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, + -0x1.b82684p-7f, 0x1p-4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, + -0x1.b7aa82p-8f, 0x1p-5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, + 0.0f, 0.0f, 0x1p0f, 0.0f, + -0x1.003242p5f, 0x1p5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, + -0x1.00c8fcp4f, 0x1p4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, + -0x1.025aa4p3f, 0x1p3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, + -0x1.0322f4p3f, 0x1p3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, + -0x1.03eacap3f, 0x1p3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, + -0x1.096408p2f, 0x1p2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, + -0x1.0af10ap2f, 0x1p2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, + -0x1.0c7c5cp2f, 0x1p2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, + -0x1.0e05c2p2f, 0x1p2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, + -0x1.0f8cfcp2f, 0x1p2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, + -0x1.2223a4p1f, 0x1p1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, + -0x1.25280cp1f, 0x1p1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, + -0x1.2826bap1f, 0x1p1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, + -0x1.2b1f34p1f, 0x1p1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, + -0x1.2e110ap1f, 0x1p1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, + -0x1.30fbc6p1f, 0x1p1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, + -0x1.33def2p1f, 0x1p1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, + -0x1.36ba2p1f, 0x1p1f, 0x1.ced7bp-1f, -0x1.786712p-26f, + -0x1.398cdep1f, 0x1p1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, + -0x1.3c56bap1f, 0x1p1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, + -0x1.3f174ap1f, 0x1p1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, + -0x1.839c3cp0f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, + -0x1.88f59ap0f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, + -0x1.8e39dap0f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, + -0x1.93682ap0f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, + -0x1.987fcp0f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, + -0x1.9d7fd2p0f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, + -0x1.a2679ap0f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, + -0x1.a73656p0f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, + -0x1.abeb4ap0f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, + -0x1.b085bap0f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, + -0x1.b504f4p0f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, + -0x1.b96842p0f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, + -0x1.bdaefap0f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, + -0x1.c1d87p0f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, + -0x1.c5e404p0f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, + -0x1.c9d112p0f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, + -0x1.cd9f02p0f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, + -0x1.d14d3ep0f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, + -0x1.d4db32p0f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, + -0x1.d84852p0f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, + -0x1.db941ap0f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, + -0x1.debe06p0f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, + -0x1.e1c598p0f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, + -0x1.e4aa5ap0f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, + -0x1.e76bd8p0f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, + -0x1.ea09a6p0f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, + -0x1.ec835ep0f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, + -0x1.eed89ep0f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, + -0x1.f10908p0f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, + -0x1.f31448p0f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, + -0x1.f4fa0ap0f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, + -0x1.f6ba08p0f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, + -0x1.f853f8p0f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, + -0x1.f9c79ep0f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, + -0x1.fb14bep0f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, + -0x1.fc3b28p0f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, + -0x1.fd3aacp0f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, + -0x1.fe1324p0f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, + -0x1.fec46ep0f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, + -0x1.ff4e6ep0f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, + -0x1.ffb11p0f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, + -0x1.ffec44p0f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, + -0x1p1f, 0x1p0f, 0.0f, 0.0f, + -0x1.ffec44p0f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, + -0x1.ffb11p0f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, + -0x1.ff4e6ep0f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, + -0x1.fec46ep0f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, + -0x1.fe1324p0f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, + -0x1.fd3aacp0f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, + -0x1.fc3b28p0f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, + -0x1.fb14bep0f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, + -0x1.f9c79ep0f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, + -0x1.f853f8p0f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, + -0x1.f6ba08p0f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, + -0x1.f4fa0ap0f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, + -0x1.f31448p0f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, + -0x1.f10908p0f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, + -0x1.eed89ep0f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, + -0x1.ec835ep0f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, + -0x1.ea09a6p0f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, + -0x1.e76bd8p0f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, + -0x1.e4aa5ap0f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, + -0x1.e1c598p0f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, + -0x1.debe06p0f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, + -0x1.db941ap0f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, + -0x1.d84852p0f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, + -0x1.d4db32p0f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, + -0x1.d14d3ep0f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, + -0x1.cd9f02p0f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, + -0x1.c9d112p0f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, + -0x1.c5e404p0f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, + -0x1.c1d87p0f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, + -0x1.bdaefap0f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, + -0x1.b96842p0f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, + -0x1.b504f4p0f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, + -0x1.b085bap0f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, + -0x1.abeb4ap0f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, + -0x1.a73656p0f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, + -0x1.a2679ap0f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, + -0x1.9d7fd2p0f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, + -0x1.987fcp0f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, + -0x1.93682ap0f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, + -0x1.8e39dap0f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, + -0x1.88f59ap0f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, + -0x1.839c3cp0f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, + -0x1.3f174ap1f, 0x1p1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, + -0x1.3c56bap1f, 0x1p1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, + -0x1.398cdep1f, 0x1p1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, + -0x1.36ba2p1f, 0x1p1f, -0x1.ced7bp-1f, 0x1.786712p-26f, + -0x1.33def2p1f, 0x1p1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, + -0x1.30fbc6p1f, 0x1p1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, + -0x1.2e110ap1f, 0x1p1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, + -0x1.2b1f34p1f, 0x1p1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, + -0x1.2826bap1f, 0x1p1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, + -0x1.25280cp1f, 0x1p1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, + -0x1.2223a4p1f, 0x1p1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, + -0x1.0f8cfcp2f, 0x1p2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, + -0x1.0e05c2p2f, 0x1p2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, + -0x1.0c7c5cp2f, 0x1p2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, + -0x1.0af10ap2f, 0x1p2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, + -0x1.096408p2f, 0x1p2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, + -0x1.03eacap3f, 0x1p3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, + -0x1.0322f4p3f, 0x1p3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, + -0x1.025aa4p3f, 0x1p3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, + -0x1.00c8fcp4f, 0x1p4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, + -0x1.003242p5f, 0x1p5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, + 0.0f, 0.0f, -0x1p0f, 0.0f, + -0x1.b7aa82p-8f, 0x1p-5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, + -0x1.b82684p-7f, 0x1p-4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, + -0x1.a55beep-5f, 0x1p-3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, + -0x1.ba165p-6f, 0x1p-3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, + -0x1.536352p-9f, 0x1p-3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, + -0x1.a6fdf2p-4f, 0x1p-2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, + -0x1.43bd78p-4f, 0x1p-2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, + -0x1.c1d1fp-5f, 0x1p-2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, + -0x1.fa3ecap-6f, 0x1p-2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, + -0x1.cc0d0ap-8f, 0x1p-2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, + -0x1.ddc5b4p-3f, 0x1p-1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, + -0x1.ad7f3ap-3f, 0x1p-1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, + -0x1.7d946ep-3f, 0x1p-1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, + -0x1.4e0cb2p-3f, 0x1p-1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, + -0x1.1eef5ap-3f, 0x1p-1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, + -0x1.e08756p-4f, 0x1p-1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, + -0x1.8421bp-4f, 0x1p-1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, + -0x1.28bbfep-4f, 0x1p-1f, -0x1.ced7bp-1f, 0x1.786712p-26f, + -0x1.9cc8b4p-5f, 0x1p-1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, + -0x1.d4a2c8p-6f, 0x1p-1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, + -0x1.d16c9p-8f, 0x1p-1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, + -0x1.f18f0cp-2f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, + -0x1.dc2996p-2f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, + -0x1.c71898p-2f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, + -0x1.b25f56p-2f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, + -0x1.9e01p-2f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, + -0x1.8a00bap-2f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, + -0x1.76619cp-2f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, + -0x1.6326a8p-2f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, + -0x1.5052dap-2f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, + -0x1.3de916p-2f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, + -0x1.2bec34p-2f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, + -0x1.1a5efap-2f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, + -0x1.09441cp-2f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, + -0x1.f13c7ep-3f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, + -0x1.d0dfe6p-3f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, + -0x1.b1776ep-3f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, + -0x1.9307eep-3f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, + -0x1.759618p-3f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, + -0x1.592676p-3f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, + -0x1.3dbd6ap-3f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, + -0x1.235f2ep-3f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, + -0x1.0a0fd4p-3f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, + -0x1.e3a688p-4f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, + -0x1.b55a7p-4f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, + -0x1.894286p-4f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, + -0x1.5f6598p-4f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, + -0x1.37ca18p-4f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, + -0x1.127624p-4f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, + -0x1.dedefcp-5f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, + -0x1.9d7714p-5f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, + -0x1.60beaap-5f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, + -0x1.28bf18p-5f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, + -0x1.eb0208p-6f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, + -0x1.8e18a8p-6f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, + -0x1.3ad06p-6f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, + -0x1.e26c16p-7f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, + -0x1.62aa04p-7f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, + -0x1.ecdc78p-8f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, + -0x1.3b92e2p-8f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, + -0x1.63253p-9f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, + -0x1.3bc39p-10f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, + -0x1.3bcfbep-12f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, +}; +template <> constexpr float kCosApproxTable[] = { + 0.0f, 0.0f, 0x1p0f, 0.0f, + -0x1.003242p5f, 0x1p5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, + -0x1.00c8fcp4f, 0x1p4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, + -0x1.025aa4p3f, 0x1p3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, + -0x1.0322f4p3f, 0x1p3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, + -0x1.03eacap3f, 0x1p3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, + -0x1.096408p2f, 0x1p2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, + -0x1.0af10ap2f, 0x1p2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, + -0x1.0c7c5cp2f, 0x1p2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, + -0x1.0e05c2p2f, 0x1p2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, + -0x1.0f8cfcp2f, 0x1p2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, + -0x1.2223a4p1f, 0x1p1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, + -0x1.25280cp1f, 0x1p1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, + -0x1.2826bap1f, 0x1p1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, + -0x1.2b1f34p1f, 0x1p1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, + -0x1.2e110ap1f, 0x1p1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, + -0x1.30fbc6p1f, 0x1p1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, + -0x1.33def2p1f, 0x1p1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, + -0x1.36ba2p1f, 0x1p1f, 0x1.ced7bp-1f, -0x1.786712p-26f, + -0x1.398cdep1f, 0x1p1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, + -0x1.3c56bap1f, 0x1p1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, + -0x1.3f174ap1f, 0x1p1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, + -0x1.839c3cp0f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, + -0x1.88f59ap0f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, + -0x1.8e39dap0f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, + -0x1.93682ap0f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, + -0x1.987fcp0f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, + -0x1.9d7fd2p0f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, + -0x1.a2679ap0f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, + -0x1.a73656p0f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, + -0x1.abeb4ap0f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, + -0x1.b085bap0f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, + -0x1.b504f4p0f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, + -0x1.b96842p0f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, + -0x1.bdaefap0f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, + -0x1.c1d87p0f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, + -0x1.c5e404p0f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, + -0x1.c9d112p0f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, + -0x1.cd9f02p0f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, + -0x1.d14d3ep0f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, + -0x1.d4db32p0f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, + -0x1.d84852p0f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, + -0x1.db941ap0f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, + -0x1.debe06p0f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, + -0x1.e1c598p0f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, + -0x1.e4aa5ap0f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, + -0x1.e76bd8p0f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, + -0x1.ea09a6p0f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, + -0x1.ec835ep0f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, + -0x1.eed89ep0f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, + -0x1.f10908p0f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, + -0x1.f31448p0f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, + -0x1.f4fa0ap0f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, + -0x1.f6ba08p0f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, + -0x1.f853f8p0f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, + -0x1.f9c79ep0f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, + -0x1.fb14bep0f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, + -0x1.fc3b28p0f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, + -0x1.fd3aacp0f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, + -0x1.fe1324p0f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, + -0x1.fec46ep0f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, + -0x1.ff4e6ep0f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, + -0x1.ffb11p0f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, + -0x1.ffec44p0f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, + -0x1p1f, 0x1p0f, 0.0f, 0.0f, + -0x1.ffec44p0f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, + -0x1.ffb11p0f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, + -0x1.ff4e6ep0f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, + -0x1.fec46ep0f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, + -0x1.fe1324p0f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, + -0x1.fd3aacp0f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, + -0x1.fc3b28p0f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, + -0x1.fb14bep0f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, + -0x1.f9c79ep0f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, + -0x1.f853f8p0f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, + -0x1.f6ba08p0f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, + -0x1.f4fa0ap0f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, + -0x1.f31448p0f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, + -0x1.f10908p0f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, + -0x1.eed89ep0f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, + -0x1.ec835ep0f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, + -0x1.ea09a6p0f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, + -0x1.e76bd8p0f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, + -0x1.e4aa5ap0f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, + -0x1.e1c598p0f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, + -0x1.debe06p0f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, + -0x1.db941ap0f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, + -0x1.d84852p0f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, + -0x1.d4db32p0f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, + -0x1.d14d3ep0f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, + -0x1.cd9f02p0f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, + -0x1.c9d112p0f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, + -0x1.c5e404p0f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, + -0x1.c1d87p0f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, + -0x1.bdaefap0f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, + -0x1.b96842p0f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, + -0x1.b504f4p0f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, + -0x1.b085bap0f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, + -0x1.abeb4ap0f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, + -0x1.a73656p0f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, + -0x1.a2679ap0f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, + -0x1.9d7fd2p0f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, + -0x1.987fcp0f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, + -0x1.93682ap0f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, + -0x1.8e39dap0f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, + -0x1.88f59ap0f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, + -0x1.839c3cp0f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, + -0x1.3f174ap1f, 0x1p1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, + -0x1.3c56bap1f, 0x1p1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, + -0x1.398cdep1f, 0x1p1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, + -0x1.36ba2p1f, 0x1p1f, -0x1.ced7bp-1f, 0x1.786712p-26f, + -0x1.33def2p1f, 0x1p1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, + -0x1.30fbc6p1f, 0x1p1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, + -0x1.2e110ap1f, 0x1p1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, + -0x1.2b1f34p1f, 0x1p1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, + -0x1.2826bap1f, 0x1p1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, + -0x1.25280cp1f, 0x1p1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, + -0x1.2223a4p1f, 0x1p1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, + -0x1.0f8cfcp2f, 0x1p2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, + -0x1.0e05c2p2f, 0x1p2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, + -0x1.0c7c5cp2f, 0x1p2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, + -0x1.0af10ap2f, 0x1p2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, + -0x1.096408p2f, 0x1p2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, + -0x1.03eacap3f, 0x1p3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, + -0x1.0322f4p3f, 0x1p3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, + -0x1.025aa4p3f, 0x1p3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, + -0x1.00c8fcp4f, 0x1p4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, + -0x1.003242p5f, 0x1p5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, + 0.0f, 0.0f, -0x1p0f, 0.0f, + -0x1.b7aa82p-8f, 0x1p-5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, + -0x1.b82684p-7f, 0x1p-4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, + -0x1.a55beep-5f, 0x1p-3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, + -0x1.ba165p-6f, 0x1p-3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, + -0x1.536352p-9f, 0x1p-3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, + -0x1.a6fdf2p-4f, 0x1p-2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, + -0x1.43bd78p-4f, 0x1p-2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, + -0x1.c1d1fp-5f, 0x1p-2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, + -0x1.fa3ecap-6f, 0x1p-2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, + -0x1.cc0d0ap-8f, 0x1p-2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, + -0x1.ddc5b4p-3f, 0x1p-1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, + -0x1.ad7f3ap-3f, 0x1p-1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, + -0x1.7d946ep-3f, 0x1p-1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, + -0x1.4e0cb2p-3f, 0x1p-1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, + -0x1.1eef5ap-3f, 0x1p-1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, + -0x1.e08756p-4f, 0x1p-1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, + -0x1.8421bp-4f, 0x1p-1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, + -0x1.28bbfep-4f, 0x1p-1f, -0x1.ced7bp-1f, 0x1.786712p-26f, + -0x1.9cc8b4p-5f, 0x1p-1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, + -0x1.d4a2c8p-6f, 0x1p-1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, + -0x1.d16c9p-8f, 0x1p-1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, + -0x1.f18f0cp-2f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, + -0x1.dc2996p-2f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, + -0x1.c71898p-2f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, + -0x1.b25f56p-2f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, + -0x1.9e01p-2f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, + -0x1.8a00bap-2f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, + -0x1.76619cp-2f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, + -0x1.6326a8p-2f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, + -0x1.5052dap-2f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, + -0x1.3de916p-2f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, + -0x1.2bec34p-2f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, + -0x1.1a5efap-2f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, + -0x1.09441cp-2f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, + -0x1.f13c7ep-3f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, + -0x1.d0dfe6p-3f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, + -0x1.b1776ep-3f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, + -0x1.9307eep-3f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, + -0x1.759618p-3f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, + -0x1.592676p-3f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, + -0x1.3dbd6ap-3f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, + -0x1.235f2ep-3f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, + -0x1.0a0fd4p-3f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, + -0x1.e3a688p-4f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, + -0x1.b55a7p-4f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, + -0x1.894286p-4f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, + -0x1.5f6598p-4f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, + -0x1.37ca18p-4f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, + -0x1.127624p-4f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, + -0x1.dedefcp-5f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, + -0x1.9d7714p-5f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, + -0x1.60beaap-5f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, + -0x1.28bf18p-5f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, + -0x1.eb0208p-6f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, + -0x1.8e18a8p-6f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, + -0x1.3ad06p-6f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, + -0x1.e26c16p-7f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, + -0x1.62aa04p-7f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, + -0x1.ecdc78p-8f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, + -0x1.3b92e2p-8f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, + -0x1.63253p-9f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, + -0x1.3bc39p-10f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, + -0x1.3bcfbep-12f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, + 0.0f, 0x1p0f, 0.0f, 0.0f, + -0x1.3bcfbep-12f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, + -0x1.3bc39p-10f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, + -0x1.63253p-9f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, + -0x1.3b92e2p-8f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, + -0x1.ecdc78p-8f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, + -0x1.62aa04p-7f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, + -0x1.e26c16p-7f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, + -0x1.3ad06p-6f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, + -0x1.8e18a8p-6f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, + -0x1.eb0208p-6f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, + -0x1.28bf18p-5f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, + -0x1.60beaap-5f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, + -0x1.9d7714p-5f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, + -0x1.dedefcp-5f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, + -0x1.127624p-4f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, + -0x1.37ca18p-4f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, + -0x1.5f6598p-4f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, + -0x1.894286p-4f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, + -0x1.b55a7p-4f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, + -0x1.e3a688p-4f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, + -0x1.0a0fd4p-3f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, + -0x1.235f2ep-3f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, + -0x1.3dbd6ap-3f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, + -0x1.592676p-3f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, + -0x1.759618p-3f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, + -0x1.9307eep-3f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, + -0x1.b1776ep-3f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, + -0x1.d0dfe6p-3f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, + -0x1.f13c7ep-3f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, + -0x1.09441cp-2f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, + -0x1.1a5efap-2f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, + -0x1.2bec34p-2f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, + -0x1.3de916p-2f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, + -0x1.5052dap-2f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, + -0x1.6326a8p-2f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, + -0x1.76619cp-2f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, + -0x1.8a00bap-2f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, + -0x1.9e01p-2f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, + -0x1.b25f56p-2f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, + -0x1.c71898p-2f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, + -0x1.dc2996p-2f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, + -0x1.f18f0cp-2f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, + -0x1.d16c9p-8f, 0x1p-1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, + -0x1.d4a2c8p-6f, 0x1p-1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, + -0x1.9cc8b4p-5f, 0x1p-1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, + -0x1.28bbfep-4f, 0x1p-1f, 0x1.ced7bp-1f, -0x1.786712p-26f, + -0x1.8421bp-4f, 0x1p-1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, + -0x1.e08756p-4f, 0x1p-1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, + -0x1.1eef5ap-3f, 0x1p-1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, + -0x1.4e0cb2p-3f, 0x1p-1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, + -0x1.7d946ep-3f, 0x1p-1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, + -0x1.ad7f3ap-3f, 0x1p-1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, + -0x1.ddc5b4p-3f, 0x1p-1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, + -0x1.cc0d0ap-8f, 0x1p-2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, + -0x1.fa3ecap-6f, 0x1p-2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, + -0x1.c1d1fp-5f, 0x1p-2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, + -0x1.43bd78p-4f, 0x1p-2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, + -0x1.a6fdf2p-4f, 0x1p-2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, + -0x1.536352p-9f, 0x1p-3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, + -0x1.ba165p-6f, 0x1p-3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, + -0x1.a55beep-5f, 0x1p-3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, + -0x1.b82684p-7f, 0x1p-4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, + -0x1.b7aa82p-8f, 0x1p-5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, +}; +template <> constexpr double kSinApproxTable[] = { + 0, 0x1p0, 0, 0, + -0x1.3bd2c8da49511p-14, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, + -0x1.3bcfbd9979a27p-12, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, + -0x1.6344004228d8bp-11, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, + -0x1.3bc390d250439p-10, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, + -0x1.ed534e31ca57fp-10, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, + -0x1.63252fe77c5ebp-9, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, + -0x1.e350342a4f6e6p-9, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, + -0x1.3b92e176d6d31p-8, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, + -0x1.8f501492cc296p-8, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, + -0x1.ecdc78f30165cp-8, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, + -0x1.2a1a39a8a2fb7p-7, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, + -0x1.62aa03dd6ba58p-7, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, + -0x1.a01b6cdbd995ep-7, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, + -0x1.e26c163ad15b3p-7, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, + -0x1.14ccb8bdbf114p-6, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, + -0x1.3ad06011469fbp-6, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, + -0x1.633f89e9a1a66p-6, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, + -0x1.8e18a73634ee7p-6, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, + -0x1.bb5a11138a4c9p-6, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, + -0x1.eb0208db9e51bp-6, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, + -0x1.0e875c1b8c3dap-5, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, + -0x1.28bf1897b69ccp-5, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, + -0x1.44273720f48bcp-5, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, + -0x1.60bea939d225ap-5, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, + -0x1.7e8454b32ef34p-5, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, + -0x1.9d7713b71eee1p-5, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, + -0x1.bd95b4d43e819p-5, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, + -0x1.dedefb09791b4p-5, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, + -0x1.00a8cee920eabp-4, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, + -0x1.127624999ee1dp-4, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, + -0x1.24d6cee3afb2ap-4, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, + -0x1.37ca1866b95cfp-4, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, + -0x1.4b4f461b0cbaap-4, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, + -0x1.5f6597591b633p-4, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, + -0x1.740c45e0e512p-4, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, + -0x1.894285e19c468p-4, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, + -0x1.9f07860181d1ep-4, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, + -0x1.b55a6f65f7058p-4, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, + -0x1.cc3a65bbc6327p-4, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, + -0x1.e3a6873fa1279p-4, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, + -0x1.fb9decc6d55b8p-4, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, + -0x1.0a0fd4e41ab5ap-3, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, + -0x1.169566329bcb7p-3, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, + -0x1.235f2eb9a470ap-3, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, + -0x1.306cb042aa3bap-3, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, + -0x1.3dbd69fabf802p-3, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, + -0x1.4b50d8778abbdp-3, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, + -0x1.592675bc57974p-3, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, + -0x1.673db93f41479p-3, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, + -0x1.759617ee761f9p-3, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, + -0x1.842f0435941afp-3, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, + -0x1.9307ee031e2fdp-3, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, + -0x1.a22042ce0a2f9p-3, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, + -0x1.b1776d9b67013p-3, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, + -0x1.c10cd7041afccp-3, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, + -0x1.d0dfe53aba2fdp-3, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, + -0x1.e0effc1174505p-3, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, + -0x1.f13c7d001a249p-3, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, + -0x1.00e263951d11fp-2, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, + -0x1.09441bb2aa0a2p-2, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, + -0x1.11c3141f91b3ep-2, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, + -0x1.1a5ef902000d3p-2, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, + -0x1.23177562aaea3p-2, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, + -0x1.2bec333018867p-2, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, + -0x1.34dcdb41f0f85p-2, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, + -0x1.3de9155c5a642p-2, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, + -0x1.471088335fce7p-2, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, + -0x1.5052d96e626c1p-2, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, + -0x1.59afadab954d4p-2, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, + -0x1.6326a8838342ep-2, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, + -0x1.6cb76c8c9ed8fp-2, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, + -0x1.76619b5edc454p-2, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, + -0x1.8024d59755257p-2, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, + -0x1.8a00badbf5e8ep-2, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, + -0x1.93f4e9df34c1bp-2, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, + -0x1.9e010063d1f96p-2, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, + -0x1.a8249b40a182cp-2, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, + -0x1.b25f56645da43p-2, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, + -0x1.bcb0ccd98294fp-2, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, + -0x1.c71898ca32e6fp-2, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, + -0x1.d19653842496fp-2, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, + -0x1.dc29957c969bbp-2, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, + -0x1.e6d1f6544ece3p-2, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, + -0x1.f18f0cdba0025p-2, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, + -0x1.fc606f1678292p-2, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, + -0x1.d16c901d95181p-8, 0x1p-1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, + -0x1.23e6ad10872a7p-6, 0x1p-1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, + -0x1.d4a2c7f909c4ep-6, 0x1p-1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, + -0x1.4344523c8e3b5p-5, 0x1p-1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, + -0x1.9cc8b3671dd0fp-5, 0x1p-1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, + -0x1.f6db13ff708cbp-5, 0x1p-1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, + -0x1.28bbfd87a8cffp-4, 0x1p-1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, + -0x1.564df524b00dap-4, 0x1p-1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, + -0x1.8421af15c49d7p-4, 0x1p-1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, + -0x1.b2356710db0a3p-4, 0x1p-1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, + -0x1.e087565455a75p-4, 0x1p-1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, + -0x1.078ad9dc46632p-3, 0x1p-1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, + -0x1.1eef59e0b74c3p-3, 0x1p-1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, + -0x1.367044581b074p-3, 0x1p-1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, + -0x1.4e0cb14a9c046p-3, 0x1p-1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, + -0x1.65c3b7b0e312cp-3, 0x1p-1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, + -0x1.7d946d7d133fdp-3, 0x1p-1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, + -0x1.957de7a3cfd5dp-3, 0x1p-1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, + -0x1.ad7f3a254c1f5p-3, 0x1p-1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, + -0x1.c597781664984p-3, 0x1p-1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, + -0x1.ddc5b3a9c1311p-3, 0x1p-1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, + -0x1.f608fe39004a4p-3, 0x1p-1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, + -0x1.cc0d09bd41caap-8, 0x1p-2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, + -0x1.36580d5d5e775p-6, 0x1p-2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, + -0x1.fa3ecac0d84e8p-6, 0x1p-2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, + -0x1.5f57f693feebep-5, 0x1p-2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, + -0x1.c1d1f0e5967d5p-5, 0x1p-2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, + -0x1.1244c435e819dp-4, 0x1p-2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, + -0x1.43bd776e98073p-4, 0x1p-2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, + -0x1.755129dad834cp-4, 0x1p-2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, + -0x1.a6fdf22e33d8cp-4, 0x1p-2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, + -0x1.d8c1e624a1513p-4, 0x1p-2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, + -0x1.536352ad19e39p-9, 0x1p-3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, + -0x1.e43d1c309e958p-7, 0x1p-3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, + -0x1.ba1650f592f5p-6, 0x1p-3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, + -0x1.4125feacab7cep-5, 0x1p-3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, + -0x1.a55beda63cc14p-5, 0x1p-3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, + -0x1.35230c0fbe402p-10, 0x1p-4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, + -0x1.b82683bc89fbp-7, 0x1p-4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, + -0x1.a4f3514d75466p-6, 0x1p-4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, + -0x1.b7aa821726608p-8, 0x1p-5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, + -0x1.b78b80c84e1eep-9, 0x1p-6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, + 0, 0, 0x1p0, 0, + -0x1.000c90e8fe6f6p6, 0x1p6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, + -0x1.003242abef46dp5, 0x1p5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, + -0x1.0096c32baca2bp4, 0x1p4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, + -0x1.00c8fb2f886ecp4, 0x1p4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, + -0x1.00fb2b73cfc1p4, 0x1p4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, + -0x1.025aa41259c34p3, 0x1p3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, + -0x1.02beda0153548p3, 0x1p3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, + -0x1.0322f4d785368p3, 0x1p3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, + -0x1.0386f0b8f3d86p3, 0x1p3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, + -0x1.03eac9cad52e6p3, 0x1p3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, + -0x1.089cf8676d7acp2, 0x1p2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, + -0x1.096408374730ap2, 0x1p2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, + -0x1.0a2abb58949f3p2, 0x1p2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, + -0x1.0af10a22459fep2, 0x1p2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, + -0x1.0bb6ecef285fap2, 0x1p2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, + -0x1.0c7c5c1e34d3p2, 0x1p2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, + -0x1.0d415012d8023p2, 0x1p2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, + -0x1.0e05c1353f27bp2, 0x1p2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, + -0x1.0ec9a7f2a2a19p2, 0x1p2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, + -0x1.0f8cfcbd90af9p2, 0x1p2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, + -0x1.209f701c6ffb6p1, 0x1p1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, + -0x1.2223a4c563ecfp1, 0x1p1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, + -0x1.23a6887e99b68p1, 0x1p1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, + -0x1.25280c5dab3e1p1, 0x1p1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, + -0x1.26a82185c302ap1, 0x1p1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, + -0x1.2826b9282eccp1, 0x1p1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, + -0x1.29a3c484f1cedp1, 0x1p1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, + -0x1.2b1f34eb563fcp1, 0x1p1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, + -0x1.2c98fbba7e4f9p1, 0x1p1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, + -0x1.2e110a61f48b4p1, 0x1p1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, + -0x1.2f8752623b99dp1, 0x1p1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, + -0x1.30fbc54d5d52cp1, 0x1p1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, + -0x1.326e54c77927bp1, 0x1p1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, + -0x1.33def28751db1p1, 0x1p1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, + -0x1.354d9056da7f9p1, 0x1p1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, + -0x1.36ba2013c2b98p1, 0x1p1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, + -0x1.382493b0023ddp1, 0x1p1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, + -0x1.398cdd326388cp1, 0x1p1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, + -0x1.3af2eeb70dc71p1, 0x1p1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, + -0x1.3c56ba700dec7p1, 0x1p1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, + -0x1.3db832a5def1bp1, 0x1p1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, + -0x1.3f1749b7f1357p1, 0x1p1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, + -0x1.80e7e43a61f5bp0, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, + -0x1.839c3cc917ff7p0, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, + -0x1.864b826aec4c7p0, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, + -0x1.88f59aa0da591p0, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, + -0x1.8b9a6b1ef6da4p0, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, + -0x1.8e39d9cd73464p0, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, + -0x1.90d3ccc99f5acp0, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, + -0x1.93682a66e896fp0, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, + -0x1.95f6d92fd79f5p0, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, + -0x1.987fbfe70b81ap0, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, + -0x1.9b02c58832cf9p0, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, + -0x1.9d7fd1490285dp0, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, + -0x1.9ff6ca9a2ab6ap0, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, + -0x1.a267992848eebp0, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, + -0x1.a4d224dcd849cp0, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, + -0x1.a73655df1f2f5p0, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, + -0x1.a99414951aacbp0, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, + -0x1.abeb49a46765p0, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, + -0x1.ae3bddf3280c6p0, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, + -0x1.b085baa8e966fp0, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, + -0x1.b2c8c92f83c1fp0, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, + -0x1.b504f333f9de6p0, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, + -0x1.b73a22a755457p0, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, + -0x1.b96841bf7ffcbp0, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, + -0x1.bb8f3af81b931p0, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, + -0x1.bdaef913557d7p0, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, + -0x1.bfc7671ab8bb8p0, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, + -0x1.c1d8705ffcbb7p0, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, + -0x1.c3e2007dd175fp0, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, + -0x1.c5e40358a8bap0, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, + -0x1.c7de651f7ca06p0, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, + -0x1.c9d1124c931fep0, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, + -0x1.cbbbf7a63eba1p0, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, + -0x1.cd9f023f9c3ap0, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, + -0x1.cf7a1f794d7cap0, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, + -0x1.d14d3d02313c1p0, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, + -0x1.d31848d817d71p0, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, + -0x1.d4db3148750d2p0, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, + -0x1.d695e4f10ea88p0, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, + -0x1.d84852c0a81p0, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, + -0x1.d9f269f7aab89p0, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, + -0x1.db941a28cb71fp0, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, + -0x1.dd2d5339ac869p0, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, + -0x1.debe05637ca95p0, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, + -0x1.e046213392aa5p0, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, + -0x1.e1c5978c05ed8p0, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, + -0x1.e33c59a4439cep0, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, + -0x1.e4aa5909a08fap0, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, + -0x1.e60f879fe7e2ep0, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, + -0x1.e76bd7a1e63b9p0, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, + -0x1.e8bf3ba1f1aeep0, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, + -0x1.ea09a68a6e49dp0, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, + -0x1.eb4b0b9e4f345p0, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, + -0x1.ec835e79946a3p0, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, + -0x1.edb29311c504dp0, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, + -0x1.eed89db66611ep0, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, + -0x1.eff573116df15p0, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, + -0x1.f1090827b4372p0, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, + -0x1.f21352595e0bfp0, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, + -0x1.f314476247089p0, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, + -0x1.f40bdd5a66886p0, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, + -0x1.f4fa0ab6316edp0, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, + -0x1.f5dec646f85bap0, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, + -0x1.f6ba073b424b2p0, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, + -0x1.f78bc51f239e1p0, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, + -0x1.f853f7dc9186cp0, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, + -0x1.f91297bbb1d6dp0, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, + -0x1.f9c79d63272c4p0, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, + -0x1.fa7301d859796p0, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, + -0x1.fb14be7fbae58p0, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, + -0x1.fbaccd1d0903cp0, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, + -0x1.fc3b27d38a5d5p0, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, + -0x1.fcbfc926484cdp0, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, + -0x1.fd3aabf84528bp0, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, + -0x1.fdabcb8caeba1p0, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, + -0x1.fe1323870cfeap0, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, + -0x1.fe70afeb6d33dp0, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, + -0x1.fec46d1e89293p0, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, + -0x1.ff0e57e5ead85p0, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, + -0x1.ff4e6d680c41dp0, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, + -0x1.ff84ab2c738d7p0, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, + -0x1.ffb10f1bcb6bfp0, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, + -0x1.ffd3977ff7baep0, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, + -0x1.ffec430426686p0, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, + -0x1.fffb10b4dc96ep0, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, + -0x1p1, 0x1p0, 0, 0, + -0x1.fffb10b4dc96ep0, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, + -0x1.ffec430426686p0, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, + -0x1.ffd3977ff7baep0, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, + -0x1.ffb10f1bcb6bfp0, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, + -0x1.ff84ab2c738d7p0, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, + -0x1.ff4e6d680c41dp0, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, + -0x1.ff0e57e5ead85p0, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, + -0x1.fec46d1e89293p0, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, + -0x1.fe70afeb6d33dp0, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, + -0x1.fe1323870cfeap0, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, + -0x1.fdabcb8caeba1p0, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, + -0x1.fd3aabf84528bp0, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, + -0x1.fcbfc926484cdp0, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, + -0x1.fc3b27d38a5d5p0, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, + -0x1.fbaccd1d0903cp0, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, + -0x1.fb14be7fbae58p0, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, + -0x1.fa7301d859796p0, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, + -0x1.f9c79d63272c4p0, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, + -0x1.f91297bbb1d6dp0, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, + -0x1.f853f7dc9186cp0, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, + -0x1.f78bc51f239e1p0, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, + -0x1.f6ba073b424b2p0, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, + -0x1.f5dec646f85bap0, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, + -0x1.f4fa0ab6316edp0, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, + -0x1.f40bdd5a66886p0, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, + -0x1.f314476247089p0, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, + -0x1.f21352595e0bfp0, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, + -0x1.f1090827b4372p0, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, + -0x1.eff573116df15p0, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, + -0x1.eed89db66611ep0, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, + -0x1.edb29311c504dp0, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, + -0x1.ec835e79946a3p0, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, + -0x1.eb4b0b9e4f345p0, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, + -0x1.ea09a68a6e49dp0, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, + -0x1.e8bf3ba1f1aeep0, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, + -0x1.e76bd7a1e63b9p0, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, + -0x1.e60f879fe7e2ep0, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, + -0x1.e4aa5909a08fap0, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, + -0x1.e33c59a4439cep0, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, + -0x1.e1c5978c05ed8p0, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, + -0x1.e046213392aa5p0, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, + -0x1.debe05637ca95p0, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, + -0x1.dd2d5339ac869p0, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, + -0x1.db941a28cb71fp0, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, + -0x1.d9f269f7aab89p0, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, + -0x1.d84852c0a81p0, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, + -0x1.d695e4f10ea88p0, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, + -0x1.d4db3148750d2p0, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, + -0x1.d31848d817d71p0, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, + -0x1.d14d3d02313c1p0, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, + -0x1.cf7a1f794d7cap0, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, + -0x1.cd9f023f9c3ap0, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, + -0x1.cbbbf7a63eba1p0, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, + -0x1.c9d1124c931fep0, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, + -0x1.c7de651f7ca06p0, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, + -0x1.c5e40358a8bap0, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, + -0x1.c3e2007dd175fp0, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, + -0x1.c1d8705ffcbb7p0, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, + -0x1.bfc7671ab8bb8p0, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, + -0x1.bdaef913557d7p0, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, + -0x1.bb8f3af81b931p0, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, + -0x1.b96841bf7ffcbp0, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, + -0x1.b73a22a755457p0, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, + -0x1.b504f333f9de6p0, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, + -0x1.b2c8c92f83c1fp0, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, + -0x1.b085baa8e966fp0, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, + -0x1.ae3bddf3280c6p0, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, + -0x1.abeb49a46765p0, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, + -0x1.a99414951aacbp0, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, + -0x1.a73655df1f2f5p0, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, + -0x1.a4d224dcd849cp0, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, + -0x1.a267992848eebp0, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, + -0x1.9ff6ca9a2ab6ap0, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, + -0x1.9d7fd1490285dp0, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, + -0x1.9b02c58832cf9p0, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, + -0x1.987fbfe70b81ap0, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, + -0x1.95f6d92fd79f5p0, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, + -0x1.93682a66e896fp0, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, + -0x1.90d3ccc99f5acp0, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, + -0x1.8e39d9cd73464p0, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, + -0x1.8b9a6b1ef6da4p0, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, + -0x1.88f59aa0da591p0, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, + -0x1.864b826aec4c7p0, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, + -0x1.839c3cc917ff7p0, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, + -0x1.80e7e43a61f5bp0, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, + -0x1.3f1749b7f1357p1, 0x1p1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, + -0x1.3db832a5def1bp1, 0x1p1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, + -0x1.3c56ba700dec7p1, 0x1p1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, + -0x1.3af2eeb70dc71p1, 0x1p1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, + -0x1.398cdd326388cp1, 0x1p1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, + -0x1.382493b0023ddp1, 0x1p1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, + -0x1.36ba2013c2b98p1, 0x1p1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, + -0x1.354d9056da7f9p1, 0x1p1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, + -0x1.33def28751db1p1, 0x1p1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, + -0x1.326e54c77927bp1, 0x1p1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, + -0x1.30fbc54d5d52cp1, 0x1p1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, + -0x1.2f8752623b99dp1, 0x1p1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, + -0x1.2e110a61f48b4p1, 0x1p1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, + -0x1.2c98fbba7e4f9p1, 0x1p1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, + -0x1.2b1f34eb563fcp1, 0x1p1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, + -0x1.29a3c484f1cedp1, 0x1p1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, + -0x1.2826b9282eccp1, 0x1p1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, + -0x1.26a82185c302ap1, 0x1p1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, + -0x1.25280c5dab3e1p1, 0x1p1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, + -0x1.23a6887e99b68p1, 0x1p1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, + -0x1.2223a4c563ecfp1, 0x1p1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, + -0x1.209f701c6ffb6p1, 0x1p1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, + -0x1.0f8cfcbd90af9p2, 0x1p2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, + -0x1.0ec9a7f2a2a19p2, 0x1p2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, + -0x1.0e05c1353f27bp2, 0x1p2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, + -0x1.0d415012d8023p2, 0x1p2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, + -0x1.0c7c5c1e34d3p2, 0x1p2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, + -0x1.0bb6ecef285fap2, 0x1p2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, + -0x1.0af10a22459fep2, 0x1p2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, + -0x1.0a2abb58949f3p2, 0x1p2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, + -0x1.096408374730ap2, 0x1p2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, + -0x1.089cf8676d7acp2, 0x1p2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, + -0x1.03eac9cad52e6p3, 0x1p3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, + -0x1.0386f0b8f3d86p3, 0x1p3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, + -0x1.0322f4d785368p3, 0x1p3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, + -0x1.02beda0153548p3, 0x1p3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, + -0x1.025aa41259c34p3, 0x1p3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, + -0x1.00fb2b73cfc1p4, 0x1p4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, + -0x1.00c8fb2f886ecp4, 0x1p4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, + -0x1.0096c32baca2bp4, 0x1p4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, + -0x1.003242abef46dp5, 0x1p5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, + -0x1.000c90e8fe6f6p6, 0x1p6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, + 0, 0, -0x1p0, 0, + -0x1.b78b80c84e1eep-9, 0x1p-6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, + -0x1.b7aa821726608p-8, 0x1p-5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, + -0x1.a4f3514d75466p-6, 0x1p-4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, + -0x1.b82683bc89fbp-7, 0x1p-4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, + -0x1.35230c0fbe402p-10, 0x1p-4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, + -0x1.a55beda63cc14p-5, 0x1p-3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, + -0x1.4125feacab7cep-5, 0x1p-3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, + -0x1.ba1650f592f5p-6, 0x1p-3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, + -0x1.e43d1c309e958p-7, 0x1p-3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, + -0x1.536352ad19e39p-9, 0x1p-3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, + -0x1.d8c1e624a1513p-4, 0x1p-2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, + -0x1.a6fdf22e33d8cp-4, 0x1p-2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, + -0x1.755129dad834cp-4, 0x1p-2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, + -0x1.43bd776e98073p-4, 0x1p-2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, + -0x1.1244c435e819dp-4, 0x1p-2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, + -0x1.c1d1f0e5967d5p-5, 0x1p-2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, + -0x1.5f57f693feebep-5, 0x1p-2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, + -0x1.fa3ecac0d84e8p-6, 0x1p-2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, + -0x1.36580d5d5e775p-6, 0x1p-2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, + -0x1.cc0d09bd41caap-8, 0x1p-2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, + -0x1.f608fe39004a4p-3, 0x1p-1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, + -0x1.ddc5b3a9c1311p-3, 0x1p-1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, + -0x1.c597781664984p-3, 0x1p-1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, + -0x1.ad7f3a254c1f5p-3, 0x1p-1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, + -0x1.957de7a3cfd5dp-3, 0x1p-1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, + -0x1.7d946d7d133fdp-3, 0x1p-1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, + -0x1.65c3b7b0e312cp-3, 0x1p-1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, + -0x1.4e0cb14a9c046p-3, 0x1p-1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, + -0x1.367044581b074p-3, 0x1p-1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, + -0x1.1eef59e0b74c3p-3, 0x1p-1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, + -0x1.078ad9dc46632p-3, 0x1p-1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, + -0x1.e087565455a75p-4, 0x1p-1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, + -0x1.b2356710db0a3p-4, 0x1p-1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, + -0x1.8421af15c49d7p-4, 0x1p-1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, + -0x1.564df524b00dap-4, 0x1p-1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, + -0x1.28bbfd87a8cffp-4, 0x1p-1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, + -0x1.f6db13ff708cbp-5, 0x1p-1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, + -0x1.9cc8b3671dd0fp-5, 0x1p-1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, + -0x1.4344523c8e3b5p-5, 0x1p-1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, + -0x1.d4a2c7f909c4ep-6, 0x1p-1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, + -0x1.23e6ad10872a7p-6, 0x1p-1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, + -0x1.d16c901d95181p-8, 0x1p-1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, + -0x1.fc606f1678292p-2, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, + -0x1.f18f0cdba0025p-2, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, + -0x1.e6d1f6544ece3p-2, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, + -0x1.dc29957c969bbp-2, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, + -0x1.d19653842496fp-2, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, + -0x1.c71898ca32e6fp-2, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, + -0x1.bcb0ccd98294fp-2, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, + -0x1.b25f56645da43p-2, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, + -0x1.a8249b40a182cp-2, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, + -0x1.9e010063d1f96p-2, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, + -0x1.93f4e9df34c1bp-2, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, + -0x1.8a00badbf5e8ep-2, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, + -0x1.8024d59755257p-2, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, + -0x1.76619b5edc454p-2, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, + -0x1.6cb76c8c9ed8fp-2, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, + -0x1.6326a8838342ep-2, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, + -0x1.59afadab954d4p-2, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, + -0x1.5052d96e626c1p-2, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, + -0x1.471088335fce7p-2, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, + -0x1.3de9155c5a642p-2, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, + -0x1.34dcdb41f0f85p-2, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, + -0x1.2bec333018867p-2, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, + -0x1.23177562aaea3p-2, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, + -0x1.1a5ef902000d3p-2, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, + -0x1.11c3141f91b3ep-2, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, + -0x1.09441bb2aa0a2p-2, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, + -0x1.00e263951d11fp-2, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, + -0x1.f13c7d001a249p-3, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, + -0x1.e0effc1174505p-3, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, + -0x1.d0dfe53aba2fdp-3, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, + -0x1.c10cd7041afccp-3, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, + -0x1.b1776d9b67013p-3, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, + -0x1.a22042ce0a2f9p-3, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, + -0x1.9307ee031e2fdp-3, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, + -0x1.842f0435941afp-3, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, + -0x1.759617ee761f9p-3, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, + -0x1.673db93f41479p-3, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, + -0x1.592675bc57974p-3, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, + -0x1.4b50d8778abbdp-3, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, + -0x1.3dbd69fabf802p-3, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, + -0x1.306cb042aa3bap-3, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, + -0x1.235f2eb9a470ap-3, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, + -0x1.169566329bcb7p-3, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, + -0x1.0a0fd4e41ab5ap-3, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, + -0x1.fb9decc6d55b8p-4, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, + -0x1.e3a6873fa1279p-4, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, + -0x1.cc3a65bbc6327p-4, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, + -0x1.b55a6f65f7058p-4, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, + -0x1.9f07860181d1ep-4, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, + -0x1.894285e19c468p-4, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, + -0x1.740c45e0e512p-4, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, + -0x1.5f6597591b633p-4, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, + -0x1.4b4f461b0cbaap-4, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, + -0x1.37ca1866b95cfp-4, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, + -0x1.24d6cee3afb2ap-4, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, + -0x1.127624999ee1dp-4, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, + -0x1.00a8cee920eabp-4, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, + -0x1.dedefb09791b4p-5, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, + -0x1.bd95b4d43e819p-5, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, + -0x1.9d7713b71eee1p-5, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, + -0x1.7e8454b32ef34p-5, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, + -0x1.60bea939d225ap-5, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, + -0x1.44273720f48bcp-5, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, + -0x1.28bf1897b69ccp-5, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, + -0x1.0e875c1b8c3dap-5, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, + -0x1.eb0208db9e51bp-6, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, + -0x1.bb5a11138a4c9p-6, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, + -0x1.8e18a73634ee7p-6, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, + -0x1.633f89e9a1a66p-6, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, + -0x1.3ad06011469fbp-6, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, + -0x1.14ccb8bdbf114p-6, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, + -0x1.e26c163ad15b3p-7, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, + -0x1.a01b6cdbd995ep-7, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, + -0x1.62aa03dd6ba58p-7, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, + -0x1.2a1a39a8a2fb7p-7, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, + -0x1.ecdc78f30165cp-8, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, + -0x1.8f501492cc296p-8, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, + -0x1.3b92e176d6d31p-8, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, + -0x1.e350342a4f6e6p-9, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, + -0x1.63252fe77c5ebp-9, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, + -0x1.ed534e31ca57fp-10, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, + -0x1.3bc390d250439p-10, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, + -0x1.6344004228d8bp-11, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, + -0x1.3bcfbd9979a27p-12, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, + -0x1.3bd2c8da49511p-14, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, +}; +template <> constexpr double kCosApproxTable[] = { + 0, 0, 0x1p0, 0, + -0x1.000c90e8fe6f6p6, 0x1p6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, + -0x1.003242abef46dp5, 0x1p5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, + -0x1.0096c32baca2bp4, 0x1p4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, + -0x1.00c8fb2f886ecp4, 0x1p4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, + -0x1.00fb2b73cfc1p4, 0x1p4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, + -0x1.025aa41259c34p3, 0x1p3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, + -0x1.02beda0153548p3, 0x1p3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, + -0x1.0322f4d785368p3, 0x1p3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, + -0x1.0386f0b8f3d86p3, 0x1p3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, + -0x1.03eac9cad52e6p3, 0x1p3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, + -0x1.089cf8676d7acp2, 0x1p2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, + -0x1.096408374730ap2, 0x1p2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, + -0x1.0a2abb58949f3p2, 0x1p2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, + -0x1.0af10a22459fep2, 0x1p2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, + -0x1.0bb6ecef285fap2, 0x1p2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, + -0x1.0c7c5c1e34d3p2, 0x1p2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, + -0x1.0d415012d8023p2, 0x1p2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, + -0x1.0e05c1353f27bp2, 0x1p2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, + -0x1.0ec9a7f2a2a19p2, 0x1p2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, + -0x1.0f8cfcbd90af9p2, 0x1p2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, + -0x1.209f701c6ffb6p1, 0x1p1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, + -0x1.2223a4c563ecfp1, 0x1p1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, + -0x1.23a6887e99b68p1, 0x1p1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, + -0x1.25280c5dab3e1p1, 0x1p1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, + -0x1.26a82185c302ap1, 0x1p1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, + -0x1.2826b9282eccp1, 0x1p1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, + -0x1.29a3c484f1cedp1, 0x1p1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, + -0x1.2b1f34eb563fcp1, 0x1p1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, + -0x1.2c98fbba7e4f9p1, 0x1p1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, + -0x1.2e110a61f48b4p1, 0x1p1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, + -0x1.2f8752623b99dp1, 0x1p1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, + -0x1.30fbc54d5d52cp1, 0x1p1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, + -0x1.326e54c77927bp1, 0x1p1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, + -0x1.33def28751db1p1, 0x1p1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, + -0x1.354d9056da7f9p1, 0x1p1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, + -0x1.36ba2013c2b98p1, 0x1p1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, + -0x1.382493b0023ddp1, 0x1p1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, + -0x1.398cdd326388cp1, 0x1p1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, + -0x1.3af2eeb70dc71p1, 0x1p1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, + -0x1.3c56ba700dec7p1, 0x1p1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, + -0x1.3db832a5def1bp1, 0x1p1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, + -0x1.3f1749b7f1357p1, 0x1p1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, + -0x1.80e7e43a61f5bp0, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, + -0x1.839c3cc917ff7p0, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, + -0x1.864b826aec4c7p0, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, + -0x1.88f59aa0da591p0, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, + -0x1.8b9a6b1ef6da4p0, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, + -0x1.8e39d9cd73464p0, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, + -0x1.90d3ccc99f5acp0, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, + -0x1.93682a66e896fp0, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, + -0x1.95f6d92fd79f5p0, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, + -0x1.987fbfe70b81ap0, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, + -0x1.9b02c58832cf9p0, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, + -0x1.9d7fd1490285dp0, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, + -0x1.9ff6ca9a2ab6ap0, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, + -0x1.a267992848eebp0, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, + -0x1.a4d224dcd849cp0, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, + -0x1.a73655df1f2f5p0, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, + -0x1.a99414951aacbp0, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, + -0x1.abeb49a46765p0, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, + -0x1.ae3bddf3280c6p0, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, + -0x1.b085baa8e966fp0, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, + -0x1.b2c8c92f83c1fp0, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, + -0x1.b504f333f9de6p0, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, + -0x1.b73a22a755457p0, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, + -0x1.b96841bf7ffcbp0, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, + -0x1.bb8f3af81b931p0, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, + -0x1.bdaef913557d7p0, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, + -0x1.bfc7671ab8bb8p0, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, + -0x1.c1d8705ffcbb7p0, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, + -0x1.c3e2007dd175fp0, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, + -0x1.c5e40358a8bap0, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, + -0x1.c7de651f7ca06p0, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, + -0x1.c9d1124c931fep0, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, + -0x1.cbbbf7a63eba1p0, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, + -0x1.cd9f023f9c3ap0, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, + -0x1.cf7a1f794d7cap0, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, + -0x1.d14d3d02313c1p0, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, + -0x1.d31848d817d71p0, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, + -0x1.d4db3148750d2p0, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, + -0x1.d695e4f10ea88p0, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, + -0x1.d84852c0a81p0, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, + -0x1.d9f269f7aab89p0, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, + -0x1.db941a28cb71fp0, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, + -0x1.dd2d5339ac869p0, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, + -0x1.debe05637ca95p0, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, + -0x1.e046213392aa5p0, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, + -0x1.e1c5978c05ed8p0, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, + -0x1.e33c59a4439cep0, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, + -0x1.e4aa5909a08fap0, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, + -0x1.e60f879fe7e2ep0, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, + -0x1.e76bd7a1e63b9p0, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, + -0x1.e8bf3ba1f1aeep0, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, + -0x1.ea09a68a6e49dp0, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, + -0x1.eb4b0b9e4f345p0, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, + -0x1.ec835e79946a3p0, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, + -0x1.edb29311c504dp0, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, + -0x1.eed89db66611ep0, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, + -0x1.eff573116df15p0, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, + -0x1.f1090827b4372p0, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, + -0x1.f21352595e0bfp0, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, + -0x1.f314476247089p0, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, + -0x1.f40bdd5a66886p0, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, + -0x1.f4fa0ab6316edp0, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, + -0x1.f5dec646f85bap0, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, + -0x1.f6ba073b424b2p0, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, + -0x1.f78bc51f239e1p0, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, + -0x1.f853f7dc9186cp0, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, + -0x1.f91297bbb1d6dp0, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, + -0x1.f9c79d63272c4p0, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, + -0x1.fa7301d859796p0, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, + -0x1.fb14be7fbae58p0, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, + -0x1.fbaccd1d0903cp0, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, + -0x1.fc3b27d38a5d5p0, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, + -0x1.fcbfc926484cdp0, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, + -0x1.fd3aabf84528bp0, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, + -0x1.fdabcb8caeba1p0, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, + -0x1.fe1323870cfeap0, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, + -0x1.fe70afeb6d33dp0, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, + -0x1.fec46d1e89293p0, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, + -0x1.ff0e57e5ead85p0, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, + -0x1.ff4e6d680c41dp0, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, + -0x1.ff84ab2c738d7p0, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, + -0x1.ffb10f1bcb6bfp0, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, + -0x1.ffd3977ff7baep0, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, + -0x1.ffec430426686p0, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, + -0x1.fffb10b4dc96ep0, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, + -0x1p1, 0x1p0, 0, 0, + -0x1.fffb10b4dc96ep0, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, + -0x1.ffec430426686p0, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, + -0x1.ffd3977ff7baep0, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, + -0x1.ffb10f1bcb6bfp0, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, + -0x1.ff84ab2c738d7p0, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, + -0x1.ff4e6d680c41dp0, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, + -0x1.ff0e57e5ead85p0, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, + -0x1.fec46d1e89293p0, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, + -0x1.fe70afeb6d33dp0, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, + -0x1.fe1323870cfeap0, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, + -0x1.fdabcb8caeba1p0, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, + -0x1.fd3aabf84528bp0, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, + -0x1.fcbfc926484cdp0, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, + -0x1.fc3b27d38a5d5p0, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, + -0x1.fbaccd1d0903cp0, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, + -0x1.fb14be7fbae58p0, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, + -0x1.fa7301d859796p0, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, + -0x1.f9c79d63272c4p0, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, + -0x1.f91297bbb1d6dp0, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, + -0x1.f853f7dc9186cp0, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, + -0x1.f78bc51f239e1p0, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, + -0x1.f6ba073b424b2p0, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, + -0x1.f5dec646f85bap0, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, + -0x1.f4fa0ab6316edp0, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, + -0x1.f40bdd5a66886p0, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, + -0x1.f314476247089p0, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, + -0x1.f21352595e0bfp0, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, + -0x1.f1090827b4372p0, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, + -0x1.eff573116df15p0, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, + -0x1.eed89db66611ep0, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, + -0x1.edb29311c504dp0, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, + -0x1.ec835e79946a3p0, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, + -0x1.eb4b0b9e4f345p0, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, + -0x1.ea09a68a6e49dp0, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, + -0x1.e8bf3ba1f1aeep0, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, + -0x1.e76bd7a1e63b9p0, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, + -0x1.e60f879fe7e2ep0, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, + -0x1.e4aa5909a08fap0, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, + -0x1.e33c59a4439cep0, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, + -0x1.e1c5978c05ed8p0, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, + -0x1.e046213392aa5p0, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, + -0x1.debe05637ca95p0, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, + -0x1.dd2d5339ac869p0, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, + -0x1.db941a28cb71fp0, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, + -0x1.d9f269f7aab89p0, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, + -0x1.d84852c0a81p0, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, + -0x1.d695e4f10ea88p0, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, + -0x1.d4db3148750d2p0, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, + -0x1.d31848d817d71p0, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, + -0x1.d14d3d02313c1p0, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, + -0x1.cf7a1f794d7cap0, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, + -0x1.cd9f023f9c3ap0, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, + -0x1.cbbbf7a63eba1p0, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, + -0x1.c9d1124c931fep0, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, + -0x1.c7de651f7ca06p0, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, + -0x1.c5e40358a8bap0, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, + -0x1.c3e2007dd175fp0, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, + -0x1.c1d8705ffcbb7p0, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, + -0x1.bfc7671ab8bb8p0, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, + -0x1.bdaef913557d7p0, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, + -0x1.bb8f3af81b931p0, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, + -0x1.b96841bf7ffcbp0, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, + -0x1.b73a22a755457p0, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, + -0x1.b504f333f9de6p0, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, + -0x1.b2c8c92f83c1fp0, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, + -0x1.b085baa8e966fp0, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, + -0x1.ae3bddf3280c6p0, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, + -0x1.abeb49a46765p0, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, + -0x1.a99414951aacbp0, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, + -0x1.a73655df1f2f5p0, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, + -0x1.a4d224dcd849cp0, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, + -0x1.a267992848eebp0, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, + -0x1.9ff6ca9a2ab6ap0, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, + -0x1.9d7fd1490285dp0, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, + -0x1.9b02c58832cf9p0, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, + -0x1.987fbfe70b81ap0, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, + -0x1.95f6d92fd79f5p0, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, + -0x1.93682a66e896fp0, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, + -0x1.90d3ccc99f5acp0, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, + -0x1.8e39d9cd73464p0, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, + -0x1.8b9a6b1ef6da4p0, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, + -0x1.88f59aa0da591p0, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, + -0x1.864b826aec4c7p0, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, + -0x1.839c3cc917ff7p0, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, + -0x1.80e7e43a61f5bp0, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, + -0x1.3f1749b7f1357p1, 0x1p1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, + -0x1.3db832a5def1bp1, 0x1p1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, + -0x1.3c56ba700dec7p1, 0x1p1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, + -0x1.3af2eeb70dc71p1, 0x1p1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, + -0x1.398cdd326388cp1, 0x1p1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, + -0x1.382493b0023ddp1, 0x1p1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, + -0x1.36ba2013c2b98p1, 0x1p1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, + -0x1.354d9056da7f9p1, 0x1p1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, + -0x1.33def28751db1p1, 0x1p1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, + -0x1.326e54c77927bp1, 0x1p1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, + -0x1.30fbc54d5d52cp1, 0x1p1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, + -0x1.2f8752623b99dp1, 0x1p1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, + -0x1.2e110a61f48b4p1, 0x1p1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, + -0x1.2c98fbba7e4f9p1, 0x1p1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, + -0x1.2b1f34eb563fcp1, 0x1p1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, + -0x1.29a3c484f1cedp1, 0x1p1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, + -0x1.2826b9282eccp1, 0x1p1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, + -0x1.26a82185c302ap1, 0x1p1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, + -0x1.25280c5dab3e1p1, 0x1p1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, + -0x1.23a6887e99b68p1, 0x1p1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, + -0x1.2223a4c563ecfp1, 0x1p1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, + -0x1.209f701c6ffb6p1, 0x1p1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, + -0x1.0f8cfcbd90af9p2, 0x1p2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, + -0x1.0ec9a7f2a2a19p2, 0x1p2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, + -0x1.0e05c1353f27bp2, 0x1p2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, + -0x1.0d415012d8023p2, 0x1p2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, + -0x1.0c7c5c1e34d3p2, 0x1p2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, + -0x1.0bb6ecef285fap2, 0x1p2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, + -0x1.0af10a22459fep2, 0x1p2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, + -0x1.0a2abb58949f3p2, 0x1p2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, + -0x1.096408374730ap2, 0x1p2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, + -0x1.089cf8676d7acp2, 0x1p2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, + -0x1.03eac9cad52e6p3, 0x1p3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, + -0x1.0386f0b8f3d86p3, 0x1p3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, + -0x1.0322f4d785368p3, 0x1p3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, + -0x1.02beda0153548p3, 0x1p3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, + -0x1.025aa41259c34p3, 0x1p3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, + -0x1.00fb2b73cfc1p4, 0x1p4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, + -0x1.00c8fb2f886ecp4, 0x1p4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, + -0x1.0096c32baca2bp4, 0x1p4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, + -0x1.003242abef46dp5, 0x1p5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, + -0x1.000c90e8fe6f6p6, 0x1p6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, + 0, 0, -0x1p0, 0, + -0x1.b78b80c84e1eep-9, 0x1p-6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, + -0x1.b7aa821726608p-8, 0x1p-5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, + -0x1.a4f3514d75466p-6, 0x1p-4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, + -0x1.b82683bc89fbp-7, 0x1p-4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, + -0x1.35230c0fbe402p-10, 0x1p-4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, + -0x1.a55beda63cc14p-5, 0x1p-3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, + -0x1.4125feacab7cep-5, 0x1p-3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, + -0x1.ba1650f592f5p-6, 0x1p-3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, + -0x1.e43d1c309e958p-7, 0x1p-3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, + -0x1.536352ad19e39p-9, 0x1p-3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, + -0x1.d8c1e624a1513p-4, 0x1p-2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, + -0x1.a6fdf22e33d8cp-4, 0x1p-2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, + -0x1.755129dad834cp-4, 0x1p-2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, + -0x1.43bd776e98073p-4, 0x1p-2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, + -0x1.1244c435e819dp-4, 0x1p-2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, + -0x1.c1d1f0e5967d5p-5, 0x1p-2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, + -0x1.5f57f693feebep-5, 0x1p-2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, + -0x1.fa3ecac0d84e8p-6, 0x1p-2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, + -0x1.36580d5d5e775p-6, 0x1p-2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, + -0x1.cc0d09bd41caap-8, 0x1p-2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, + -0x1.f608fe39004a4p-3, 0x1p-1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, + -0x1.ddc5b3a9c1311p-3, 0x1p-1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, + -0x1.c597781664984p-3, 0x1p-1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, + -0x1.ad7f3a254c1f5p-3, 0x1p-1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, + -0x1.957de7a3cfd5dp-3, 0x1p-1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, + -0x1.7d946d7d133fdp-3, 0x1p-1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, + -0x1.65c3b7b0e312cp-3, 0x1p-1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, + -0x1.4e0cb14a9c046p-3, 0x1p-1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, + -0x1.367044581b074p-3, 0x1p-1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, + -0x1.1eef59e0b74c3p-3, 0x1p-1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, + -0x1.078ad9dc46632p-3, 0x1p-1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, + -0x1.e087565455a75p-4, 0x1p-1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, + -0x1.b2356710db0a3p-4, 0x1p-1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, + -0x1.8421af15c49d7p-4, 0x1p-1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, + -0x1.564df524b00dap-4, 0x1p-1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, + -0x1.28bbfd87a8cffp-4, 0x1p-1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, + -0x1.f6db13ff708cbp-5, 0x1p-1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, + -0x1.9cc8b3671dd0fp-5, 0x1p-1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, + -0x1.4344523c8e3b5p-5, 0x1p-1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, + -0x1.d4a2c7f909c4ep-6, 0x1p-1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, + -0x1.23e6ad10872a7p-6, 0x1p-1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, + -0x1.d16c901d95181p-8, 0x1p-1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, + -0x1.fc606f1678292p-2, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, + -0x1.f18f0cdba0025p-2, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, + -0x1.e6d1f6544ece3p-2, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, + -0x1.dc29957c969bbp-2, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, + -0x1.d19653842496fp-2, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, + -0x1.c71898ca32e6fp-2, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, + -0x1.bcb0ccd98294fp-2, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, + -0x1.b25f56645da43p-2, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, + -0x1.a8249b40a182cp-2, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, + -0x1.9e010063d1f96p-2, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, + -0x1.93f4e9df34c1bp-2, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, + -0x1.8a00badbf5e8ep-2, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, + -0x1.8024d59755257p-2, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, + -0x1.76619b5edc454p-2, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, + -0x1.6cb76c8c9ed8fp-2, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, + -0x1.6326a8838342ep-2, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, + -0x1.59afadab954d4p-2, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, + -0x1.5052d96e626c1p-2, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, + -0x1.471088335fce7p-2, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, + -0x1.3de9155c5a642p-2, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, + -0x1.34dcdb41f0f85p-2, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, + -0x1.2bec333018867p-2, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, + -0x1.23177562aaea3p-2, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, + -0x1.1a5ef902000d3p-2, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, + -0x1.11c3141f91b3ep-2, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, + -0x1.09441bb2aa0a2p-2, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, + -0x1.00e263951d11fp-2, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, + -0x1.f13c7d001a249p-3, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, + -0x1.e0effc1174505p-3, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, + -0x1.d0dfe53aba2fdp-3, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, + -0x1.c10cd7041afccp-3, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, + -0x1.b1776d9b67013p-3, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, + -0x1.a22042ce0a2f9p-3, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, + -0x1.9307ee031e2fdp-3, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, + -0x1.842f0435941afp-3, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, + -0x1.759617ee761f9p-3, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, + -0x1.673db93f41479p-3, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, + -0x1.592675bc57974p-3, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, + -0x1.4b50d8778abbdp-3, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, + -0x1.3dbd69fabf802p-3, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, + -0x1.306cb042aa3bap-3, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, + -0x1.235f2eb9a470ap-3, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, + -0x1.169566329bcb7p-3, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, + -0x1.0a0fd4e41ab5ap-3, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, + -0x1.fb9decc6d55b8p-4, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, + -0x1.e3a6873fa1279p-4, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, + -0x1.cc3a65bbc6327p-4, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, + -0x1.b55a6f65f7058p-4, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, + -0x1.9f07860181d1ep-4, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, + -0x1.894285e19c468p-4, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, + -0x1.740c45e0e512p-4, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, + -0x1.5f6597591b633p-4, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, + -0x1.4b4f461b0cbaap-4, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, + -0x1.37ca1866b95cfp-4, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, + -0x1.24d6cee3afb2ap-4, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, + -0x1.127624999ee1dp-4, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, + -0x1.00a8cee920eabp-4, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, + -0x1.dedefb09791b4p-5, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, + -0x1.bd95b4d43e819p-5, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, + -0x1.9d7713b71eee1p-5, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, + -0x1.7e8454b32ef34p-5, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, + -0x1.60bea939d225ap-5, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, + -0x1.44273720f48bcp-5, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, + -0x1.28bf1897b69ccp-5, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, + -0x1.0e875c1b8c3dap-5, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, + -0x1.eb0208db9e51bp-6, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, + -0x1.bb5a11138a4c9p-6, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, + -0x1.8e18a73634ee7p-6, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, + -0x1.633f89e9a1a66p-6, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, + -0x1.3ad06011469fbp-6, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, + -0x1.14ccb8bdbf114p-6, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, + -0x1.e26c163ad15b3p-7, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, + -0x1.a01b6cdbd995ep-7, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, + -0x1.62aa03dd6ba58p-7, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, + -0x1.2a1a39a8a2fb7p-7, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, + -0x1.ecdc78f30165cp-8, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, + -0x1.8f501492cc296p-8, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, + -0x1.3b92e176d6d31p-8, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, + -0x1.e350342a4f6e6p-9, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, + -0x1.63252fe77c5ebp-9, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, + -0x1.ed534e31ca57fp-10, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, + -0x1.3bc390d250439p-10, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, + -0x1.6344004228d8bp-11, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, + -0x1.3bcfbd9979a27p-12, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, + -0x1.3bd2c8da49511p-14, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, + 0, 0x1p0, 0, 0, + -0x1.3bd2c8da49511p-14, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, + -0x1.3bcfbd9979a27p-12, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, + -0x1.6344004228d8bp-11, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, + -0x1.3bc390d250439p-10, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, + -0x1.ed534e31ca57fp-10, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, + -0x1.63252fe77c5ebp-9, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, + -0x1.e350342a4f6e6p-9, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, + -0x1.3b92e176d6d31p-8, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, + -0x1.8f501492cc296p-8, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, + -0x1.ecdc78f30165cp-8, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, + -0x1.2a1a39a8a2fb7p-7, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, + -0x1.62aa03dd6ba58p-7, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, + -0x1.a01b6cdbd995ep-7, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, + -0x1.e26c163ad15b3p-7, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, + -0x1.14ccb8bdbf114p-6, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, + -0x1.3ad06011469fbp-6, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, + -0x1.633f89e9a1a66p-6, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, + -0x1.8e18a73634ee7p-6, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, + -0x1.bb5a11138a4c9p-6, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, + -0x1.eb0208db9e51bp-6, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, + -0x1.0e875c1b8c3dap-5, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, + -0x1.28bf1897b69ccp-5, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, + -0x1.44273720f48bcp-5, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, + -0x1.60bea939d225ap-5, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, + -0x1.7e8454b32ef34p-5, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, + -0x1.9d7713b71eee1p-5, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, + -0x1.bd95b4d43e819p-5, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, + -0x1.dedefb09791b4p-5, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, + -0x1.00a8cee920eabp-4, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, + -0x1.127624999ee1dp-4, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, + -0x1.24d6cee3afb2ap-4, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, + -0x1.37ca1866b95cfp-4, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, + -0x1.4b4f461b0cbaap-4, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, + -0x1.5f6597591b633p-4, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, + -0x1.740c45e0e512p-4, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, + -0x1.894285e19c468p-4, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, + -0x1.9f07860181d1ep-4, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, + -0x1.b55a6f65f7058p-4, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, + -0x1.cc3a65bbc6327p-4, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, + -0x1.e3a6873fa1279p-4, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, + -0x1.fb9decc6d55b8p-4, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, + -0x1.0a0fd4e41ab5ap-3, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, + -0x1.169566329bcb7p-3, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, + -0x1.235f2eb9a470ap-3, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, + -0x1.306cb042aa3bap-3, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, + -0x1.3dbd69fabf802p-3, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, + -0x1.4b50d8778abbdp-3, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, + -0x1.592675bc57974p-3, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, + -0x1.673db93f41479p-3, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, + -0x1.759617ee761f9p-3, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, + -0x1.842f0435941afp-3, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, + -0x1.9307ee031e2fdp-3, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, + -0x1.a22042ce0a2f9p-3, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, + -0x1.b1776d9b67013p-3, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, + -0x1.c10cd7041afccp-3, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, + -0x1.d0dfe53aba2fdp-3, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, + -0x1.e0effc1174505p-3, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, + -0x1.f13c7d001a249p-3, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, + -0x1.00e263951d11fp-2, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, + -0x1.09441bb2aa0a2p-2, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, + -0x1.11c3141f91b3ep-2, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, + -0x1.1a5ef902000d3p-2, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, + -0x1.23177562aaea3p-2, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, + -0x1.2bec333018867p-2, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, + -0x1.34dcdb41f0f85p-2, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, + -0x1.3de9155c5a642p-2, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, + -0x1.471088335fce7p-2, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, + -0x1.5052d96e626c1p-2, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, + -0x1.59afadab954d4p-2, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, + -0x1.6326a8838342ep-2, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, + -0x1.6cb76c8c9ed8fp-2, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, + -0x1.76619b5edc454p-2, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, + -0x1.8024d59755257p-2, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, + -0x1.8a00badbf5e8ep-2, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, + -0x1.93f4e9df34c1bp-2, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, + -0x1.9e010063d1f96p-2, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, + -0x1.a8249b40a182cp-2, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, + -0x1.b25f56645da43p-2, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, + -0x1.bcb0ccd98294fp-2, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, + -0x1.c71898ca32e6fp-2, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, + -0x1.d19653842496fp-2, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, + -0x1.dc29957c969bbp-2, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, + -0x1.e6d1f6544ece3p-2, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, + -0x1.f18f0cdba0025p-2, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, + -0x1.fc606f1678292p-2, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, + -0x1.d16c901d95181p-8, 0x1p-1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, + -0x1.23e6ad10872a7p-6, 0x1p-1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, + -0x1.d4a2c7f909c4ep-6, 0x1p-1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, + -0x1.4344523c8e3b5p-5, 0x1p-1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, + -0x1.9cc8b3671dd0fp-5, 0x1p-1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, + -0x1.f6db13ff708cbp-5, 0x1p-1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, + -0x1.28bbfd87a8cffp-4, 0x1p-1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, + -0x1.564df524b00dap-4, 0x1p-1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, + -0x1.8421af15c49d7p-4, 0x1p-1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, + -0x1.b2356710db0a3p-4, 0x1p-1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, + -0x1.e087565455a75p-4, 0x1p-1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, + -0x1.078ad9dc46632p-3, 0x1p-1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, + -0x1.1eef59e0b74c3p-3, 0x1p-1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, + -0x1.367044581b074p-3, 0x1p-1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, + -0x1.4e0cb14a9c046p-3, 0x1p-1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, + -0x1.65c3b7b0e312cp-3, 0x1p-1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, + -0x1.7d946d7d133fdp-3, 0x1p-1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, + -0x1.957de7a3cfd5dp-3, 0x1p-1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, + -0x1.ad7f3a254c1f5p-3, 0x1p-1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, + -0x1.c597781664984p-3, 0x1p-1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, + -0x1.ddc5b3a9c1311p-3, 0x1p-1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, + -0x1.f608fe39004a4p-3, 0x1p-1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, + -0x1.cc0d09bd41caap-8, 0x1p-2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, + -0x1.36580d5d5e775p-6, 0x1p-2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, + -0x1.fa3ecac0d84e8p-6, 0x1p-2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, + -0x1.5f57f693feebep-5, 0x1p-2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, + -0x1.c1d1f0e5967d5p-5, 0x1p-2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, + -0x1.1244c435e819dp-4, 0x1p-2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, + -0x1.43bd776e98073p-4, 0x1p-2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, + -0x1.755129dad834cp-4, 0x1p-2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, + -0x1.a6fdf22e33d8cp-4, 0x1p-2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, + -0x1.d8c1e624a1513p-4, 0x1p-2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, + -0x1.536352ad19e39p-9, 0x1p-3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, + -0x1.e43d1c309e958p-7, 0x1p-3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, + -0x1.ba1650f592f5p-6, 0x1p-3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, + -0x1.4125feacab7cep-5, 0x1p-3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, + -0x1.a55beda63cc14p-5, 0x1p-3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, + -0x1.35230c0fbe402p-10, 0x1p-4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, + -0x1.b82683bc89fbp-7, 0x1p-4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, + -0x1.a4f3514d75466p-6, 0x1p-4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, + -0x1.b7aa821726608p-8, 0x1p-5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, + -0x1.b78b80c84e1eep-9, 0x1p-6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, +}; +}} // namespace {namespace} +#endif // NPSR_TRIG_DATA_LARGE_APROX_H_PY diff --git a/npsr/trig/data/large-aprox.h.py b/npsr/trig/data/large-aprox.h.py new file mode 100644 index 0000000..5b271bd --- /dev/null +++ b/npsr/trig/data/large-aprox.h.py @@ -0,0 +1,52 @@ +from itertools import chain +from generator import c_array, c_header, sollya + + +def gen_approx(float_size, func, func_driv): + n = 1 << (8 if float_size == 32 else 9) + trunc_upper, cast = ( + ("p2", "single") if float_size == 32 else ("round(p2, 24, RZ)", "double") + ) + return sollya( + f""" + prec = {float_size*4}; + display = hexadecimal; + cast = {cast}(x); + func = {func}(x); + scale = 2.0 * pi / {n}; + for e from 0 to {n - 1} do {{ + theta = e * scale; + p1 = cast(func(theta)); + p2 = cast(func(theta) - p1); + p2 = {trunc_upper}; + deriv = {func_driv}(theta); + k = ceil(log2(abs(deriv))); + if (deriv < 0) then {{ + k = -k; + }}; + p3 = 2.0^k; + p0 = cast(deriv - p3); + p0;p3;p1;p2; + }}; + """ + ) + + +print( + c_header( + "template constexpr T kSinApproxTable[] = {};", + "template constexpr T kCosApproxTable[] = {};", + *chain.from_iterable( + [ + ( + f"template <> constexpr {T} kSinApproxTable<{T}>[] = " + + c_array(gen_approx(size, "sin", "cos"), col=4, sfx=sfx), + f"template <> constexpr {T} kCosApproxTable<{T}>[] = " + + c_array(gen_approx(size, "cos", "-sin"), col=4, sfx=sfx), + ) + for size, T, sfx in [(32, "float", "f"), (64, "double", "")] + ] + ), + namespace="npsr::trig::data", + ) +) diff --git a/npsr/trig/data/large-reduction.h b/npsr/trig/data/large-reduction.h new file mode 100644 index 0000000..758f079 --- /dev/null +++ b/npsr/trig/data/large-reduction.h @@ -0,0 +1,2316 @@ +// Do not edit this file, it is generated by npsr/trig/data/large-reduction.h.py +// use `spin generate -f` to force regeneration +#ifndef NPSR_TRIG_DATA_LARGE_REDUCTION_H_PY +#define NPSR_TRIG_DATA_LARGE_REDUCTION_H_PY +namespace npsr::trig::data { namespace { +template constexpr T kLargeReductionTable[] = {}; +template <> constexpr uint32_t kLargeReductionTable[] = { + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x0U, + 0x0U, 0x0U, 0x1U, + 0x0U, 0x0U, 0x2U, + 0x0U, 0x0U, 0x5U, + 0x0U, 0x0U, 0xaU, + 0x0U, 0x0U, 0x14U, + 0x0U, 0x0U, 0x28U, + 0x0U, 0x0U, 0x51U, + 0x0U, 0x0U, 0xa2U, + 0x0U, 0x0U, 0x145U, + 0x0U, 0x0U, 0x28bU, + 0x0U, 0x0U, 0x517U, + 0x0U, 0x0U, 0xa2fU, + 0x0U, 0x0U, 0x145fU, + 0x0U, 0x0U, 0x28beU, + 0x0U, 0x0U, 0x517cU, + 0x0U, 0x0U, 0xa2f9U, + 0x0U, 0x0U, 0x145f3U, + 0x0U, 0x0U, 0x28be6U, + 0x0U, 0x0U, 0x517ccU, + 0x0U, 0x0U, 0xa2f98U, + 0x0U, 0x0U, 0x145f30U, + 0x0U, 0x0U, 0x28be60U, + 0x0U, 0x0U, 0x517cc1U, + 0x0U, 0x0U, 0xa2f983U, + 0x0U, 0x0U, 0x145f306U, + 0x0U, 0x0U, 0x28be60dU, + 0x0U, 0x0U, 0x517cc1bU, + 0x0U, 0x0U, 0xa2f9836U, + 0x0U, 0x0U, 0x145f306dU, + 0x0U, 0x0U, 0x28be60dbU, + 0x0U, 0x0U, 0x517cc1b7U, + 0x0U, 0x0U, 0xa2f9836eU, + 0x0U, 0x1U, 0x45f306dcU, + 0x0U, 0x2U, 0x8be60db9U, + 0x0U, 0x5U, 0x17cc1b72U, + 0x0U, 0xaU, 0x2f9836e4U, + 0x0U, 0x14U, 0x5f306dc9U, + 0x0U, 0x28U, 0xbe60db93U, + 0x0U, 0x51U, 0x7cc1b727U, + 0x0U, 0xa2U, 0xf9836e4eU, + 0x0U, 0x145U, 0xf306dc9cU, + 0x0U, 0x28bU, 0xe60db939U, + 0x0U, 0x517U, 0xcc1b7272U, + 0x0U, 0xa2fU, 0x9836e4e4U, + 0x0U, 0x145fU, 0x306dc9c8U, + 0x0U, 0x28beU, 0x60db9391U, + 0x0U, 0x517cU, 0xc1b72722U, + 0x0U, 0xa2f9U, 0x836e4e44U, + 0x0U, 0x145f3U, 0x6dc9c88U, + 0x0U, 0x28be6U, 0xdb93910U, + 0x0U, 0x517ccU, 0x1b727220U, + 0x0U, 0xa2f98U, 0x36e4e441U, + 0x0U, 0x145f30U, 0x6dc9c882U, + 0x0U, 0x28be60U, 0xdb939105U, + 0x0U, 0x517cc1U, 0xb727220aU, + 0x0U, 0xa2f983U, 0x6e4e4415U, + 0x0U, 0x145f306U, 0xdc9c882aU, + 0x0U, 0x28be60dU, 0xb9391054U, + 0x0U, 0x517cc1bU, 0x727220a9U, + 0x0U, 0xa2f9836U, 0xe4e44152U, + 0x0U, 0x145f306dU, 0xc9c882a5U, + 0x0U, 0x28be60dbU, 0x9391054aU, + 0x0U, 0x517cc1b7U, 0x27220a94U, + 0x0U, 0xa2f9836eU, 0x4e441529U, + 0x1U, 0x45f306dcU, 0x9c882a53U, + 0x2U, 0x8be60db9U, 0x391054a7U, + 0x5U, 0x17cc1b72U, 0x7220a94fU, + 0xaU, 0x2f9836e4U, 0xe441529fU, + 0x14U, 0x5f306dc9U, 0xc882a53fU, + 0x28U, 0xbe60db93U, 0x91054a7fU, + 0x51U, 0x7cc1b727U, 0x220a94feU, + 0xa2U, 0xf9836e4eU, 0x441529fcU, + 0x145U, 0xf306dc9cU, 0x882a53f8U, + 0x28bU, 0xe60db939U, 0x1054a7f0U, + 0x517U, 0xcc1b7272U, 0x20a94fe1U, + 0xa2fU, 0x9836e4e4U, 0x41529fc2U, + 0x145fU, 0x306dc9c8U, 0x82a53f84U, + 0x28beU, 0x60db9391U, 0x54a7f09U, + 0x517cU, 0xc1b72722U, 0xa94fe13U, + 0xa2f9U, 0x836e4e44U, 0x1529fc27U, + 0x145f3U, 0x6dc9c88U, 0x2a53f84eU, + 0x28be6U, 0xdb93910U, 0x54a7f09dU, + 0x517ccU, 0x1b727220U, 0xa94fe13aU, + 0xa2f98U, 0x36e4e441U, 0x529fc275U, + 0x145f30U, 0x6dc9c882U, 0xa53f84eaU, + 0x28be60U, 0xdb939105U, 0x4a7f09d5U, + 0x517cc1U, 0xb727220aU, 0x94fe13abU, + 0xa2f983U, 0x6e4e4415U, 0x29fc2757U, + 0x145f306U, 0xdc9c882aU, 0x53f84eafU, + 0x28be60dU, 0xb9391054U, 0xa7f09d5fU, + 0x517cc1bU, 0x727220a9U, 0x4fe13abeU, + 0xa2f9836U, 0xe4e44152U, 0x9fc2757dU, + 0x145f306dU, 0xc9c882a5U, 0x3f84eafaU, + 0x28be60dbU, 0x9391054aU, 0x7f09d5f4U, + 0x517cc1b7U, 0x27220a94U, 0xfe13abe8U, + 0xa2f9836eU, 0x4e441529U, 0xfc2757d1U, + 0x45f306dcU, 0x9c882a53U, 0xf84eafa3U, + 0x8be60db9U, 0x391054a7U, 0xf09d5f47U, + 0x17cc1b72U, 0x7220a94fU, 0xe13abe8fU, + 0x2f9836e4U, 0xe441529fU, 0xc2757d1fU, + 0x5f306dc9U, 0xc882a53fU, 0x84eafa3eU, + 0xbe60db93U, 0x91054a7fU, 0x9d5f47dU, + 0x7cc1b727U, 0x220a94feU, 0x13abe8faU, + 0xf9836e4eU, 0x441529fcU, 0x2757d1f5U, + 0xf306dc9cU, 0x882a53f8U, 0x4eafa3eaU, + 0xe60db939U, 0x1054a7f0U, 0x9d5f47d4U, + 0xcc1b7272U, 0x20a94fe1U, 0x3abe8fa9U, + 0x9836e4e4U, 0x41529fc2U, 0x757d1f53U, + 0x306dc9c8U, 0x82a53f84U, 0xeafa3ea6U, + 0x60db9391U, 0x54a7f09U, 0xd5f47d4dU, + 0xc1b72722U, 0xa94fe13U, 0xabe8fa9aU, + 0x836e4e44U, 0x1529fc27U, 0x57d1f534U, + 0x6dc9c88U, 0x2a53f84eU, 0xafa3ea69U, + 0xdb93910U, 0x54a7f09dU, 0x5f47d4d3U, + 0x1b727220U, 0xa94fe13aU, 0xbe8fa9a6U, + 0x36e4e441U, 0x529fc275U, 0x7d1f534dU, + 0x6dc9c882U, 0xa53f84eaU, 0xfa3ea69bU, + 0xdb939105U, 0x4a7f09d5U, 0xf47d4d37U, + 0xb727220aU, 0x94fe13abU, 0xe8fa9a6eU, + 0x6e4e4415U, 0x29fc2757U, 0xd1f534ddU, + 0xdc9c882aU, 0x53f84eafU, 0xa3ea69bbU, + 0xb9391054U, 0xa7f09d5fU, 0x47d4d377U, + 0x727220a9U, 0x4fe13abeU, 0x8fa9a6eeU, + 0xe4e44152U, 0x9fc2757dU, 0x1f534ddcU, + 0xc9c882a5U, 0x3f84eafaU, 0x3ea69bb8U, + 0x9391054aU, 0x7f09d5f4U, 0x7d4d3770U, + 0x27220a94U, 0xfe13abe8U, 0xfa9a6ee0U, + 0x4e441529U, 0xfc2757d1U, 0xf534ddc0U, + 0x9c882a53U, 0xf84eafa3U, 0xea69bb81U, + 0x391054a7U, 0xf09d5f47U, 0xd4d37703U, + 0x7220a94fU, 0xe13abe8fU, 0xa9a6ee06U, + 0xe441529fU, 0xc2757d1fU, 0x534ddc0dU, + 0xc882a53fU, 0x84eafa3eU, 0xa69bb81bU, + 0x91054a7fU, 0x9d5f47dU, 0x4d377036U, + 0x220a94feU, 0x13abe8faU, 0x9a6ee06dU, + 0x441529fcU, 0x2757d1f5U, 0x34ddc0dbU, + 0x882a53f8U, 0x4eafa3eaU, 0x69bb81b6U, + 0x1054a7f0U, 0x9d5f47d4U, 0xd377036dU, + 0x20a94fe1U, 0x3abe8fa9U, 0xa6ee06dbU, + 0x41529fc2U, 0x757d1f53U, 0x4ddc0db6U, + 0x82a53f84U, 0xeafa3ea6U, 0x9bb81b6cU, + 0x54a7f09U, 0xd5f47d4dU, 0x377036d8U, + 0xa94fe13U, 0xabe8fa9aU, 0x6ee06db1U, + 0x1529fc27U, 0x57d1f534U, 0xddc0db62U, + 0x2a53f84eU, 0xafa3ea69U, 0xbb81b6c5U, + 0x54a7f09dU, 0x5f47d4d3U, 0x77036d8aU, + 0xa94fe13aU, 0xbe8fa9a6U, 0xee06db14U, + 0x529fc275U, 0x7d1f534dU, 0xdc0db629U, + 0xa53f84eaU, 0xfa3ea69bU, 0xb81b6c52U, + 0x4a7f09d5U, 0xf47d4d37U, 0x7036d8a5U, + 0x94fe13abU, 0xe8fa9a6eU, 0xe06db14aU, + 0x29fc2757U, 0xd1f534ddU, 0xc0db6295U, + 0x53f84eafU, 0xa3ea69bbU, 0x81b6c52bU, + 0xa7f09d5fU, 0x47d4d377U, 0x36d8a56U, + 0x4fe13abeU, 0x8fa9a6eeU, 0x6db14acU, + 0x9fc2757dU, 0x1f534ddcU, 0xdb62959U, + 0x3f84eafaU, 0x3ea69bb8U, 0x1b6c52b3U, + 0x7f09d5f4U, 0x7d4d3770U, 0x36d8a566U, + 0xfe13abe8U, 0xfa9a6ee0U, 0x6db14accU, + 0xfc2757d1U, 0xf534ddc0U, 0xdb629599U, + 0xf84eafa3U, 0xea69bb81U, 0xb6c52b32U, + 0xf09d5f47U, 0xd4d37703U, 0x6d8a5664U, + 0xe13abe8fU, 0xa9a6ee06U, 0xdb14acc9U, + 0xc2757d1fU, 0x534ddc0dU, 0xb6295993U, + 0x84eafa3eU, 0xa69bb81bU, 0x6c52b327U, + 0x9d5f47dU, 0x4d377036U, 0xd8a5664fU, + 0x13abe8faU, 0x9a6ee06dU, 0xb14acc9eU, + 0x2757d1f5U, 0x34ddc0dbU, 0x6295993cU, + 0x4eafa3eaU, 0x69bb81b6U, 0xc52b3278U, + 0x9d5f47d4U, 0xd377036dU, 0x8a5664f1U, + 0x3abe8fa9U, 0xa6ee06dbU, 0x14acc9e2U, + 0x757d1f53U, 0x4ddc0db6U, 0x295993c4U, + 0xeafa3ea6U, 0x9bb81b6cU, 0x52b32788U, + 0xd5f47d4dU, 0x377036d8U, 0xa5664f10U, + 0xabe8fa9aU, 0x6ee06db1U, 0x4acc9e21U, + 0x57d1f534U, 0xddc0db62U, 0x95993c43U, + 0xafa3ea69U, 0xbb81b6c5U, 0x2b327887U, + 0x5f47d4d3U, 0x77036d8aU, 0x5664f10eU, + 0xbe8fa9a6U, 0xee06db14U, 0xacc9e21cU, + 0x7d1f534dU, 0xdc0db629U, 0x5993c439U, + 0xfa3ea69bU, 0xb81b6c52U, 0xb3278872U, + 0xf47d4d37U, 0x7036d8a5U, 0x664f10e4U, + 0xe8fa9a6eU, 0xe06db14aU, 0xcc9e21c8U, + 0xd1f534ddU, 0xc0db6295U, 0x993c4390U, + 0xa3ea69bbU, 0x81b6c52bU, 0x32788720U, + 0x47d4d377U, 0x36d8a56U, 0x64f10e41U, + 0x8fa9a6eeU, 0x6db14acU, 0xc9e21c82U, + 0x1f534ddcU, 0xdb62959U, 0x93c43904U, + 0x3ea69bb8U, 0x1b6c52b3U, 0x27887208U, + 0x7d4d3770U, 0x36d8a566U, 0x4f10e410U, + 0xfa9a6ee0U, 0x6db14accU, 0x9e21c820U, + 0xf534ddc0U, 0xdb629599U, 0x3c439041U, + 0xea69bb81U, 0xb6c52b32U, 0x78872083U, + 0xd4d37703U, 0x6d8a5664U, 0xf10e4107U, + 0xa9a6ee06U, 0xdb14acc9U, 0xe21c820fU, + 0x534ddc0dU, 0xb6295993U, 0xc439041fU, + 0xa69bb81bU, 0x6c52b327U, 0x8872083fU, + 0x4d377036U, 0xd8a5664fU, 0x10e4107fU, + 0x9a6ee06dU, 0xb14acc9eU, 0x21c82100U, +}; +template <> constexpr uint64_t kLargeReductionTable[] = { + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x0ULL, + 0x0ULL, 0x0ULL, 0x1ULL, + 0x0ULL, 0x0ULL, 0x2ULL, + 0x0ULL, 0x0ULL, 0x5ULL, + 0x0ULL, 0x0ULL, 0xaULL, + 0x0ULL, 0x0ULL, 0x14ULL, + 0x0ULL, 0x0ULL, 0x28ULL, + 0x0ULL, 0x0ULL, 0x51ULL, + 0x0ULL, 0x0ULL, 0xa2ULL, + 0x0ULL, 0x0ULL, 0x145ULL, + 0x0ULL, 0x0ULL, 0x28bULL, + 0x0ULL, 0x0ULL, 0x517ULL, + 0x0ULL, 0x0ULL, 0xa2fULL, + 0x0ULL, 0x0ULL, 0x145fULL, + 0x0ULL, 0x0ULL, 0x28beULL, + 0x0ULL, 0x0ULL, 0x517cULL, + 0x0ULL, 0x0ULL, 0xa2f9ULL, + 0x0ULL, 0x0ULL, 0x145f3ULL, + 0x0ULL, 0x0ULL, 0x28be6ULL, + 0x0ULL, 0x0ULL, 0x517ccULL, + 0x0ULL, 0x0ULL, 0xa2f98ULL, + 0x0ULL, 0x0ULL, 0x145f30ULL, + 0x0ULL, 0x0ULL, 0x28be60ULL, + 0x0ULL, 0x0ULL, 0x517cc1ULL, + 0x0ULL, 0x0ULL, 0xa2f983ULL, + 0x0ULL, 0x0ULL, 0x145f306ULL, + 0x0ULL, 0x0ULL, 0x28be60dULL, + 0x0ULL, 0x0ULL, 0x517cc1bULL, + 0x0ULL, 0x0ULL, 0xa2f9836ULL, + 0x0ULL, 0x0ULL, 0x145f306dULL, + 0x0ULL, 0x0ULL, 0x28be60dbULL, + 0x0ULL, 0x0ULL, 0x517cc1b7ULL, + 0x0ULL, 0x0ULL, 0xa2f9836eULL, + 0x0ULL, 0x0ULL, 0x145f306dcULL, + 0x0ULL, 0x0ULL, 0x28be60db9ULL, + 0x0ULL, 0x0ULL, 0x517cc1b72ULL, + 0x0ULL, 0x0ULL, 0xa2f9836e4ULL, + 0x0ULL, 0x0ULL, 0x145f306dc9ULL, + 0x0ULL, 0x0ULL, 0x28be60db93ULL, + 0x0ULL, 0x0ULL, 0x517cc1b727ULL, + 0x0ULL, 0x0ULL, 0xa2f9836e4eULL, + 0x0ULL, 0x0ULL, 0x145f306dc9cULL, + 0x0ULL, 0x0ULL, 0x28be60db939ULL, + 0x0ULL, 0x0ULL, 0x517cc1b7272ULL, + 0x0ULL, 0x0ULL, 0xa2f9836e4e4ULL, + 0x0ULL, 0x0ULL, 0x145f306dc9c8ULL, + 0x0ULL, 0x0ULL, 0x28be60db9391ULL, + 0x0ULL, 0x0ULL, 0x517cc1b72722ULL, + 0x0ULL, 0x0ULL, 0xa2f9836e4e44ULL, + 0x0ULL, 0x0ULL, 0x145f306dc9c88ULL, + 0x0ULL, 0x0ULL, 0x28be60db93910ULL, + 0x0ULL, 0x0ULL, 0x517cc1b727220ULL, + 0x0ULL, 0x0ULL, 0xa2f9836e4e441ULL, + 0x0ULL, 0x0ULL, 0x145f306dc9c882ULL, + 0x0ULL, 0x0ULL, 0x28be60db939105ULL, + 0x0ULL, 0x0ULL, 0x517cc1b727220aULL, + 0x0ULL, 0x0ULL, 0xa2f9836e4e4415ULL, + 0x0ULL, 0x0ULL, 0x145f306dc9c882aULL, + 0x0ULL, 0x0ULL, 0x28be60db9391054ULL, + 0x0ULL, 0x0ULL, 0x517cc1b727220a9ULL, + 0x0ULL, 0x0ULL, 0xa2f9836e4e44152ULL, + 0x0ULL, 0x0ULL, 0x145f306dc9c882a5ULL, + 0x0ULL, 0x0ULL, 0x28be60db9391054aULL, + 0x0ULL, 0x0ULL, 0x517cc1b727220a94ULL, + 0x0ULL, 0x0ULL, 0xa2f9836e4e441529ULL, + 0x0ULL, 0x1ULL, 0x45f306dc9c882a53ULL, + 0x0ULL, 0x2ULL, 0x8be60db9391054a7ULL, + 0x0ULL, 0x5ULL, 0x17cc1b727220a94fULL, + 0x0ULL, 0xaULL, 0x2f9836e4e441529fULL, + 0x0ULL, 0x14ULL, 0x5f306dc9c882a53fULL, + 0x0ULL, 0x28ULL, 0xbe60db9391054a7fULL, + 0x0ULL, 0x51ULL, 0x7cc1b727220a94feULL, + 0x0ULL, 0xa2ULL, 0xf9836e4e441529fcULL, + 0x0ULL, 0x145ULL, 0xf306dc9c882a53f8ULL, + 0x0ULL, 0x28bULL, 0xe60db9391054a7f0ULL, + 0x0ULL, 0x517ULL, 0xcc1b727220a94fe1ULL, + 0x0ULL, 0xa2fULL, 0x9836e4e441529fc2ULL, + 0x0ULL, 0x145fULL, 0x306dc9c882a53f84ULL, + 0x0ULL, 0x28beULL, 0x60db9391054a7f09ULL, + 0x0ULL, 0x517cULL, 0xc1b727220a94fe13ULL, + 0x0ULL, 0xa2f9ULL, 0x836e4e441529fc27ULL, + 0x0ULL, 0x145f3ULL, 0x6dc9c882a53f84eULL, + 0x0ULL, 0x28be6ULL, 0xdb9391054a7f09dULL, + 0x0ULL, 0x517ccULL, 0x1b727220a94fe13aULL, + 0x0ULL, 0xa2f98ULL, 0x36e4e441529fc275ULL, + 0x0ULL, 0x145f30ULL, 0x6dc9c882a53f84eaULL, + 0x0ULL, 0x28be60ULL, 0xdb9391054a7f09d5ULL, + 0x0ULL, 0x517cc1ULL, 0xb727220a94fe13abULL, + 0x0ULL, 0xa2f983ULL, 0x6e4e441529fc2757ULL, + 0x0ULL, 0x145f306ULL, 0xdc9c882a53f84eafULL, + 0x0ULL, 0x28be60dULL, 0xb9391054a7f09d5fULL, + 0x0ULL, 0x517cc1bULL, 0x727220a94fe13abeULL, + 0x0ULL, 0xa2f9836ULL, 0xe4e441529fc2757dULL, + 0x0ULL, 0x145f306dULL, 0xc9c882a53f84eafaULL, + 0x0ULL, 0x28be60dbULL, 0x9391054a7f09d5f4ULL, + 0x0ULL, 0x517cc1b7ULL, 0x27220a94fe13abe8ULL, + 0x0ULL, 0xa2f9836eULL, 0x4e441529fc2757d1ULL, + 0x0ULL, 0x145f306dcULL, 0x9c882a53f84eafa3ULL, + 0x0ULL, 0x28be60db9ULL, 0x391054a7f09d5f47ULL, + 0x0ULL, 0x517cc1b72ULL, 0x7220a94fe13abe8fULL, + 0x0ULL, 0xa2f9836e4ULL, 0xe441529fc2757d1fULL, + 0x0ULL, 0x145f306dc9ULL, 0xc882a53f84eafa3eULL, + 0x0ULL, 0x28be60db93ULL, 0x91054a7f09d5f47dULL, + 0x0ULL, 0x517cc1b727ULL, 0x220a94fe13abe8faULL, + 0x0ULL, 0xa2f9836e4eULL, 0x441529fc2757d1f5ULL, + 0x0ULL, 0x145f306dc9cULL, 0x882a53f84eafa3eaULL, + 0x0ULL, 0x28be60db939ULL, 0x1054a7f09d5f47d4ULL, + 0x0ULL, 0x517cc1b7272ULL, 0x20a94fe13abe8fa9ULL, + 0x0ULL, 0xa2f9836e4e4ULL, 0x41529fc2757d1f53ULL, + 0x0ULL, 0x145f306dc9c8ULL, 0x82a53f84eafa3ea6ULL, + 0x0ULL, 0x28be60db9391ULL, 0x54a7f09d5f47d4dULL, + 0x0ULL, 0x517cc1b72722ULL, 0xa94fe13abe8fa9aULL, + 0x0ULL, 0xa2f9836e4e44ULL, 0x1529fc2757d1f534ULL, + 0x0ULL, 0x145f306dc9c88ULL, 0x2a53f84eafa3ea69ULL, + 0x0ULL, 0x28be60db93910ULL, 0x54a7f09d5f47d4d3ULL, + 0x0ULL, 0x517cc1b727220ULL, 0xa94fe13abe8fa9a6ULL, + 0x0ULL, 0xa2f9836e4e441ULL, 0x529fc2757d1f534dULL, + 0x0ULL, 0x145f306dc9c882ULL, 0xa53f84eafa3ea69bULL, + 0x0ULL, 0x28be60db939105ULL, 0x4a7f09d5f47d4d37ULL, + 0x0ULL, 0x517cc1b727220aULL, 0x94fe13abe8fa9a6eULL, + 0x0ULL, 0xa2f9836e4e4415ULL, 0x29fc2757d1f534ddULL, + 0x0ULL, 0x145f306dc9c882aULL, 0x53f84eafa3ea69bbULL, + 0x0ULL, 0x28be60db9391054ULL, 0xa7f09d5f47d4d377ULL, + 0x0ULL, 0x517cc1b727220a9ULL, 0x4fe13abe8fa9a6eeULL, + 0x0ULL, 0xa2f9836e4e44152ULL, 0x9fc2757d1f534ddcULL, + 0x0ULL, 0x145f306dc9c882a5ULL, 0x3f84eafa3ea69bb8ULL, + 0x0ULL, 0x28be60db9391054aULL, 0x7f09d5f47d4d3770ULL, + 0x0ULL, 0x517cc1b727220a94ULL, 0xfe13abe8fa9a6ee0ULL, + 0x0ULL, 0xa2f9836e4e441529ULL, 0xfc2757d1f534ddc0ULL, + 0x1ULL, 0x45f306dc9c882a53ULL, 0xf84eafa3ea69bb81ULL, + 0x2ULL, 0x8be60db9391054a7ULL, 0xf09d5f47d4d37703ULL, + 0x5ULL, 0x17cc1b727220a94fULL, 0xe13abe8fa9a6ee06ULL, + 0xaULL, 0x2f9836e4e441529fULL, 0xc2757d1f534ddc0dULL, + 0x14ULL, 0x5f306dc9c882a53fULL, 0x84eafa3ea69bb81bULL, + 0x28ULL, 0xbe60db9391054a7fULL, 0x9d5f47d4d377036ULL, + 0x51ULL, 0x7cc1b727220a94feULL, 0x13abe8fa9a6ee06dULL, + 0xa2ULL, 0xf9836e4e441529fcULL, 0x2757d1f534ddc0dbULL, + 0x145ULL, 0xf306dc9c882a53f8ULL, 0x4eafa3ea69bb81b6ULL, + 0x28bULL, 0xe60db9391054a7f0ULL, 0x9d5f47d4d377036dULL, + 0x517ULL, 0xcc1b727220a94fe1ULL, 0x3abe8fa9a6ee06dbULL, + 0xa2fULL, 0x9836e4e441529fc2ULL, 0x757d1f534ddc0db6ULL, + 0x145fULL, 0x306dc9c882a53f84ULL, 0xeafa3ea69bb81b6cULL, + 0x28beULL, 0x60db9391054a7f09ULL, 0xd5f47d4d377036d8ULL, + 0x517cULL, 0xc1b727220a94fe13ULL, 0xabe8fa9a6ee06db1ULL, + 0xa2f9ULL, 0x836e4e441529fc27ULL, 0x57d1f534ddc0db62ULL, + 0x145f3ULL, 0x6dc9c882a53f84eULL, 0xafa3ea69bb81b6c5ULL, + 0x28be6ULL, 0xdb9391054a7f09dULL, 0x5f47d4d377036d8aULL, + 0x517ccULL, 0x1b727220a94fe13aULL, 0xbe8fa9a6ee06db14ULL, + 0xa2f98ULL, 0x36e4e441529fc275ULL, 0x7d1f534ddc0db629ULL, + 0x145f30ULL, 0x6dc9c882a53f84eaULL, 0xfa3ea69bb81b6c52ULL, + 0x28be60ULL, 0xdb9391054a7f09d5ULL, 0xf47d4d377036d8a5ULL, + 0x517cc1ULL, 0xb727220a94fe13abULL, 0xe8fa9a6ee06db14aULL, + 0xa2f983ULL, 0x6e4e441529fc2757ULL, 0xd1f534ddc0db6295ULL, + 0x145f306ULL, 0xdc9c882a53f84eafULL, 0xa3ea69bb81b6c52bULL, + 0x28be60dULL, 0xb9391054a7f09d5fULL, 0x47d4d377036d8a56ULL, + 0x517cc1bULL, 0x727220a94fe13abeULL, 0x8fa9a6ee06db14acULL, + 0xa2f9836ULL, 0xe4e441529fc2757dULL, 0x1f534ddc0db62959ULL, + 0x145f306dULL, 0xc9c882a53f84eafaULL, 0x3ea69bb81b6c52b3ULL, + 0x28be60dbULL, 0x9391054a7f09d5f4ULL, 0x7d4d377036d8a566ULL, + 0x517cc1b7ULL, 0x27220a94fe13abe8ULL, 0xfa9a6ee06db14accULL, + 0xa2f9836eULL, 0x4e441529fc2757d1ULL, 0xf534ddc0db629599ULL, + 0x145f306dcULL, 0x9c882a53f84eafa3ULL, 0xea69bb81b6c52b32ULL, + 0x28be60db9ULL, 0x391054a7f09d5f47ULL, 0xd4d377036d8a5664ULL, + 0x517cc1b72ULL, 0x7220a94fe13abe8fULL, 0xa9a6ee06db14acc9ULL, + 0xa2f9836e4ULL, 0xe441529fc2757d1fULL, 0x534ddc0db6295993ULL, + 0x145f306dc9ULL, 0xc882a53f84eafa3eULL, 0xa69bb81b6c52b327ULL, + 0x28be60db93ULL, 0x91054a7f09d5f47dULL, 0x4d377036d8a5664fULL, + 0x517cc1b727ULL, 0x220a94fe13abe8faULL, 0x9a6ee06db14acc9eULL, + 0xa2f9836e4eULL, 0x441529fc2757d1f5ULL, 0x34ddc0db6295993cULL, + 0x145f306dc9cULL, 0x882a53f84eafa3eaULL, 0x69bb81b6c52b3278ULL, + 0x28be60db939ULL, 0x1054a7f09d5f47d4ULL, 0xd377036d8a5664f1ULL, + 0x517cc1b7272ULL, 0x20a94fe13abe8fa9ULL, 0xa6ee06db14acc9e2ULL, + 0xa2f9836e4e4ULL, 0x41529fc2757d1f53ULL, 0x4ddc0db6295993c4ULL, + 0x145f306dc9c8ULL, 0x82a53f84eafa3ea6ULL, 0x9bb81b6c52b32788ULL, + 0x28be60db9391ULL, 0x54a7f09d5f47d4dULL, 0x377036d8a5664f10ULL, + 0x517cc1b72722ULL, 0xa94fe13abe8fa9aULL, 0x6ee06db14acc9e21ULL, + 0xa2f9836e4e44ULL, 0x1529fc2757d1f534ULL, 0xddc0db6295993c43ULL, + 0x145f306dc9c88ULL, 0x2a53f84eafa3ea69ULL, 0xbb81b6c52b327887ULL, + 0x28be60db93910ULL, 0x54a7f09d5f47d4d3ULL, 0x77036d8a5664f10eULL, + 0x517cc1b727220ULL, 0xa94fe13abe8fa9a6ULL, 0xee06db14acc9e21cULL, + 0xa2f9836e4e441ULL, 0x529fc2757d1f534dULL, 0xdc0db6295993c439ULL, + 0x145f306dc9c882ULL, 0xa53f84eafa3ea69bULL, 0xb81b6c52b3278872ULL, + 0x28be60db939105ULL, 0x4a7f09d5f47d4d37ULL, 0x7036d8a5664f10e4ULL, + 0x517cc1b727220aULL, 0x94fe13abe8fa9a6eULL, 0xe06db14acc9e21c8ULL, + 0xa2f9836e4e4415ULL, 0x29fc2757d1f534ddULL, 0xc0db6295993c4390ULL, + 0x145f306dc9c882aULL, 0x53f84eafa3ea69bbULL, 0x81b6c52b32788720ULL, + 0x28be60db9391054ULL, 0xa7f09d5f47d4d377ULL, 0x36d8a5664f10e41ULL, + 0x517cc1b727220a9ULL, 0x4fe13abe8fa9a6eeULL, 0x6db14acc9e21c82ULL, + 0xa2f9836e4e44152ULL, 0x9fc2757d1f534ddcULL, 0xdb6295993c43904ULL, + 0x145f306dc9c882a5ULL, 0x3f84eafa3ea69bb8ULL, 0x1b6c52b327887208ULL, + 0x28be60db9391054aULL, 0x7f09d5f47d4d3770ULL, 0x36d8a5664f10e410ULL, + 0x517cc1b727220a94ULL, 0xfe13abe8fa9a6ee0ULL, 0x6db14acc9e21c820ULL, + 0xa2f9836e4e441529ULL, 0xfc2757d1f534ddc0ULL, 0xdb6295993c439041ULL, + 0x45f306dc9c882a53ULL, 0xf84eafa3ea69bb81ULL, 0xb6c52b3278872083ULL, + 0x8be60db9391054a7ULL, 0xf09d5f47d4d37703ULL, 0x6d8a5664f10e4107ULL, + 0x17cc1b727220a94fULL, 0xe13abe8fa9a6ee06ULL, 0xdb14acc9e21c820fULL, + 0x2f9836e4e441529fULL, 0xc2757d1f534ddc0dULL, 0xb6295993c439041fULL, + 0x5f306dc9c882a53fULL, 0x84eafa3ea69bb81bULL, 0x6c52b3278872083fULL, + 0xbe60db9391054a7fULL, 0x9d5f47d4d377036ULL, 0xd8a5664f10e4107fULL, + 0x7cc1b727220a94feULL, 0x13abe8fa9a6ee06dULL, 0xb14acc9e21c820ffULL, + 0xf9836e4e441529fcULL, 0x2757d1f534ddc0dbULL, 0x6295993c439041feULL, + 0xf306dc9c882a53f8ULL, 0x4eafa3ea69bb81b6ULL, 0xc52b3278872083fcULL, + 0xe60db9391054a7f0ULL, 0x9d5f47d4d377036dULL, 0x8a5664f10e4107f9ULL, + 0xcc1b727220a94fe1ULL, 0x3abe8fa9a6ee06dbULL, 0x14acc9e21c820ff2ULL, + 0x9836e4e441529fc2ULL, 0x757d1f534ddc0db6ULL, 0x295993c439041fe5ULL, + 0x306dc9c882a53f84ULL, 0xeafa3ea69bb81b6cULL, 0x52b3278872083fcaULL, + 0x60db9391054a7f09ULL, 0xd5f47d4d377036d8ULL, 0xa5664f10e4107f94ULL, + 0xc1b727220a94fe13ULL, 0xabe8fa9a6ee06db1ULL, 0x4acc9e21c820ff28ULL, + 0x836e4e441529fc27ULL, 0x57d1f534ddc0db62ULL, 0x95993c439041fe51ULL, + 0x6dc9c882a53f84eULL, 0xafa3ea69bb81b6c5ULL, 0x2b3278872083fca2ULL, + 0xdb9391054a7f09dULL, 0x5f47d4d377036d8aULL, 0x5664f10e4107f945ULL, + 0x1b727220a94fe13aULL, 0xbe8fa9a6ee06db14ULL, 0xacc9e21c820ff28bULL, + 0x36e4e441529fc275ULL, 0x7d1f534ddc0db629ULL, 0x5993c439041fe516ULL, + 0x6dc9c882a53f84eaULL, 0xfa3ea69bb81b6c52ULL, 0xb3278872083fca2cULL, + 0xdb9391054a7f09d5ULL, 0xf47d4d377036d8a5ULL, 0x664f10e4107f9458ULL, + 0xb727220a94fe13abULL, 0xe8fa9a6ee06db14aULL, 0xcc9e21c820ff28b1ULL, + 0x6e4e441529fc2757ULL, 0xd1f534ddc0db6295ULL, 0x993c439041fe5163ULL, + 0xdc9c882a53f84eafULL, 0xa3ea69bb81b6c52bULL, 0x3278872083fca2c7ULL, + 0xb9391054a7f09d5fULL, 0x47d4d377036d8a56ULL, 0x64f10e4107f9458eULL, + 0x727220a94fe13abeULL, 0x8fa9a6ee06db14acULL, 0xc9e21c820ff28b1dULL, + 0xe4e441529fc2757dULL, 0x1f534ddc0db62959ULL, 0x93c439041fe5163aULL, + 0xc9c882a53f84eafaULL, 0x3ea69bb81b6c52b3ULL, 0x278872083fca2c75ULL, + 0x9391054a7f09d5f4ULL, 0x7d4d377036d8a566ULL, 0x4f10e4107f9458eaULL, + 0x27220a94fe13abe8ULL, 0xfa9a6ee06db14accULL, 0x9e21c820ff28b1d5ULL, + 0x4e441529fc2757d1ULL, 0xf534ddc0db629599ULL, 0x3c439041fe5163abULL, + 0x9c882a53f84eafa3ULL, 0xea69bb81b6c52b32ULL, 0x78872083fca2c757ULL, + 0x391054a7f09d5f47ULL, 0xd4d377036d8a5664ULL, 0xf10e4107f9458eafULL, + 0x7220a94fe13abe8fULL, 0xa9a6ee06db14acc9ULL, 0xe21c820ff28b1d5eULL, + 0xe441529fc2757d1fULL, 0x534ddc0db6295993ULL, 0xc439041fe5163abdULL, + 0xc882a53f84eafa3eULL, 0xa69bb81b6c52b327ULL, 0x8872083fca2c757bULL, + 0x91054a7f09d5f47dULL, 0x4d377036d8a5664fULL, 0x10e4107f9458eaf7ULL, + 0x220a94fe13abe8faULL, 0x9a6ee06db14acc9eULL, 0x21c820ff28b1d5efULL, + 0x441529fc2757d1f5ULL, 0x34ddc0db6295993cULL, 0x439041fe5163abdeULL, + 0x882a53f84eafa3eaULL, 0x69bb81b6c52b3278ULL, 0x872083fca2c757bdULL, + 0x1054a7f09d5f47d4ULL, 0xd377036d8a5664f1ULL, 0xe4107f9458eaf7aULL, + 0x20a94fe13abe8fa9ULL, 0xa6ee06db14acc9e2ULL, 0x1c820ff28b1d5ef5ULL, + 0x41529fc2757d1f53ULL, 0x4ddc0db6295993c4ULL, 0x39041fe5163abdebULL, + 0x82a53f84eafa3ea6ULL, 0x9bb81b6c52b32788ULL, 0x72083fca2c757bd7ULL, + 0x54a7f09d5f47d4dULL, 0x377036d8a5664f10ULL, 0xe4107f9458eaf7aeULL, + 0xa94fe13abe8fa9aULL, 0x6ee06db14acc9e21ULL, 0xc820ff28b1d5ef5dULL, + 0x1529fc2757d1f534ULL, 0xddc0db6295993c43ULL, 0x9041fe5163abdebbULL, + 0x2a53f84eafa3ea69ULL, 0xbb81b6c52b327887ULL, 0x2083fca2c757bd77ULL, + 0x54a7f09d5f47d4d3ULL, 0x77036d8a5664f10eULL, 0x4107f9458eaf7aefULL, + 0xa94fe13abe8fa9a6ULL, 0xee06db14acc9e21cULL, 0x820ff28b1d5ef5deULL, + 0x529fc2757d1f534dULL, 0xdc0db6295993c439ULL, 0x41fe5163abdebbcULL, + 0xa53f84eafa3ea69bULL, 0xb81b6c52b3278872ULL, 0x83fca2c757bd778ULL, + 0x4a7f09d5f47d4d37ULL, 0x7036d8a5664f10e4ULL, 0x107f9458eaf7aef1ULL, + 0x94fe13abe8fa9a6eULL, 0xe06db14acc9e21c8ULL, 0x20ff28b1d5ef5de2ULL, + 0x29fc2757d1f534ddULL, 0xc0db6295993c4390ULL, 0x41fe5163abdebbc5ULL, + 0x53f84eafa3ea69bbULL, 0x81b6c52b32788720ULL, 0x83fca2c757bd778aULL, + 0xa7f09d5f47d4d377ULL, 0x36d8a5664f10e41ULL, 0x7f9458eaf7aef15ULL, + 0x4fe13abe8fa9a6eeULL, 0x6db14acc9e21c82ULL, 0xff28b1d5ef5de2bULL, + 0x9fc2757d1f534ddcULL, 0xdb6295993c43904ULL, 0x1fe5163abdebbc56ULL, + 0x3f84eafa3ea69bb8ULL, 0x1b6c52b327887208ULL, 0x3fca2c757bd778acULL, + 0x7f09d5f47d4d3770ULL, 0x36d8a5664f10e410ULL, 0x7f9458eaf7aef158ULL, + 0xfe13abe8fa9a6ee0ULL, 0x6db14acc9e21c820ULL, 0xff28b1d5ef5de2b0ULL, + 0xfc2757d1f534ddc0ULL, 0xdb6295993c439041ULL, 0xfe5163abdebbc561ULL, + 0xf84eafa3ea69bb81ULL, 0xb6c52b3278872083ULL, 0xfca2c757bd778ac3ULL, + 0xf09d5f47d4d37703ULL, 0x6d8a5664f10e4107ULL, 0xf9458eaf7aef1586ULL, + 0xe13abe8fa9a6ee06ULL, 0xdb14acc9e21c820fULL, 0xf28b1d5ef5de2b0dULL, + 0xc2757d1f534ddc0dULL, 0xb6295993c439041fULL, 0xe5163abdebbc561bULL, + 0x84eafa3ea69bb81bULL, 0x6c52b3278872083fULL, 0xca2c757bd778ac36ULL, + 0x9d5f47d4d377036ULL, 0xd8a5664f10e4107fULL, 0x9458eaf7aef1586dULL, + 0x13abe8fa9a6ee06dULL, 0xb14acc9e21c820ffULL, 0x28b1d5ef5de2b0dbULL, + 0x2757d1f534ddc0dbULL, 0x6295993c439041feULL, 0x5163abdebbc561b7ULL, + 0x4eafa3ea69bb81b6ULL, 0xc52b3278872083fcULL, 0xa2c757bd778ac36eULL, + 0x9d5f47d4d377036dULL, 0x8a5664f10e4107f9ULL, 0x458eaf7aef1586dcULL, + 0x3abe8fa9a6ee06dbULL, 0x14acc9e21c820ff2ULL, 0x8b1d5ef5de2b0db9ULL, + 0x757d1f534ddc0db6ULL, 0x295993c439041fe5ULL, 0x163abdebbc561b72ULL, + 0xeafa3ea69bb81b6cULL, 0x52b3278872083fcaULL, 0x2c757bd778ac36e4ULL, + 0xd5f47d4d377036d8ULL, 0xa5664f10e4107f94ULL, 0x58eaf7aef1586dc9ULL, + 0xabe8fa9a6ee06db1ULL, 0x4acc9e21c820ff28ULL, 0xb1d5ef5de2b0db92ULL, + 0x57d1f534ddc0db62ULL, 0x95993c439041fe51ULL, 0x63abdebbc561b724ULL, + 0xafa3ea69bb81b6c5ULL, 0x2b3278872083fca2ULL, 0xc757bd778ac36e48ULL, + 0x5f47d4d377036d8aULL, 0x5664f10e4107f945ULL, 0x8eaf7aef1586dc91ULL, + 0xbe8fa9a6ee06db14ULL, 0xacc9e21c820ff28bULL, 0x1d5ef5de2b0db923ULL, + 0x7d1f534ddc0db629ULL, 0x5993c439041fe516ULL, 0x3abdebbc561b7246ULL, + 0xfa3ea69bb81b6c52ULL, 0xb3278872083fca2cULL, 0x757bd778ac36e48dULL, + 0xf47d4d377036d8a5ULL, 0x664f10e4107f9458ULL, 0xeaf7aef1586dc91bULL, + 0xe8fa9a6ee06db14aULL, 0xcc9e21c820ff28b1ULL, 0xd5ef5de2b0db9237ULL, + 0xd1f534ddc0db6295ULL, 0x993c439041fe5163ULL, 0xabdebbc561b7246eULL, + 0xa3ea69bb81b6c52bULL, 0x3278872083fca2c7ULL, 0x57bd778ac36e48dcULL, + 0x47d4d377036d8a56ULL, 0x64f10e4107f9458eULL, 0xaf7aef1586dc91b8ULL, + 0x8fa9a6ee06db14acULL, 0xc9e21c820ff28b1dULL, 0x5ef5de2b0db92371ULL, + 0x1f534ddc0db62959ULL, 0x93c439041fe5163aULL, 0xbdebbc561b7246e3ULL, + 0x3ea69bb81b6c52b3ULL, 0x278872083fca2c75ULL, 0x7bd778ac36e48dc7ULL, + 0x7d4d377036d8a566ULL, 0x4f10e4107f9458eaULL, 0xf7aef1586dc91b8eULL, + 0xfa9a6ee06db14accULL, 0x9e21c820ff28b1d5ULL, 0xef5de2b0db92371dULL, + 0xf534ddc0db629599ULL, 0x3c439041fe5163abULL, 0xdebbc561b7246e3aULL, + 0xea69bb81b6c52b32ULL, 0x78872083fca2c757ULL, 0xbd778ac36e48dc74ULL, + 0xd4d377036d8a5664ULL, 0xf10e4107f9458eafULL, 0x7aef1586dc91b8e9ULL, + 0xa9a6ee06db14acc9ULL, 0xe21c820ff28b1d5eULL, 0xf5de2b0db92371d2ULL, + 0x534ddc0db6295993ULL, 0xc439041fe5163abdULL, 0xebbc561b7246e3a4ULL, + 0xa69bb81b6c52b327ULL, 0x8872083fca2c757bULL, 0xd778ac36e48dc748ULL, + 0x4d377036d8a5664fULL, 0x10e4107f9458eaf7ULL, 0xaef1586dc91b8e90ULL, + 0x9a6ee06db14acc9eULL, 0x21c820ff28b1d5efULL, 0x5de2b0db92371d21ULL, + 0x34ddc0db6295993cULL, 0x439041fe5163abdeULL, 0xbbc561b7246e3a42ULL, + 0x69bb81b6c52b3278ULL, 0x872083fca2c757bdULL, 0x778ac36e48dc7484ULL, + 0xd377036d8a5664f1ULL, 0xe4107f9458eaf7aULL, 0xef1586dc91b8e909ULL, + 0xa6ee06db14acc9e2ULL, 0x1c820ff28b1d5ef5ULL, 0xde2b0db92371d212ULL, + 0x4ddc0db6295993c4ULL, 0x39041fe5163abdebULL, 0xbc561b7246e3a424ULL, + 0x9bb81b6c52b32788ULL, 0x72083fca2c757bd7ULL, 0x78ac36e48dc74849ULL, + 0x377036d8a5664f10ULL, 0xe4107f9458eaf7aeULL, 0xf1586dc91b8e9093ULL, + 0x6ee06db14acc9e21ULL, 0xc820ff28b1d5ef5dULL, 0xe2b0db92371d2126ULL, + 0xddc0db6295993c43ULL, 0x9041fe5163abdebbULL, 0xc561b7246e3a424dULL, + 0xbb81b6c52b327887ULL, 0x2083fca2c757bd77ULL, 0x8ac36e48dc74849bULL, + 0x77036d8a5664f10eULL, 0x4107f9458eaf7aefULL, 0x1586dc91b8e90937ULL, + 0xee06db14acc9e21cULL, 0x820ff28b1d5ef5deULL, 0x2b0db92371d2126eULL, + 0xdc0db6295993c439ULL, 0x41fe5163abdebbcULL, 0x561b7246e3a424ddULL, + 0xb81b6c52b3278872ULL, 0x83fca2c757bd778ULL, 0xac36e48dc74849baULL, + 0x7036d8a5664f10e4ULL, 0x107f9458eaf7aef1ULL, 0x586dc91b8e909374ULL, + 0xe06db14acc9e21c8ULL, 0x20ff28b1d5ef5de2ULL, 0xb0db92371d2126e9ULL, + 0xc0db6295993c4390ULL, 0x41fe5163abdebbc5ULL, 0x61b7246e3a424dd2ULL, + 0x81b6c52b32788720ULL, 0x83fca2c757bd778aULL, 0xc36e48dc74849ba5ULL, + 0x36d8a5664f10e41ULL, 0x7f9458eaf7aef15ULL, 0x86dc91b8e909374bULL, + 0x6db14acc9e21c82ULL, 0xff28b1d5ef5de2bULL, 0xdb92371d2126e97ULL, + 0xdb6295993c43904ULL, 0x1fe5163abdebbc56ULL, 0x1b7246e3a424dd2eULL, + 0x1b6c52b327887208ULL, 0x3fca2c757bd778acULL, 0x36e48dc74849ba5cULL, + 0x36d8a5664f10e410ULL, 0x7f9458eaf7aef158ULL, 0x6dc91b8e909374b8ULL, + 0x6db14acc9e21c820ULL, 0xff28b1d5ef5de2b0ULL, 0xdb92371d2126e970ULL, + 0xdb6295993c439041ULL, 0xfe5163abdebbc561ULL, 0xb7246e3a424dd2e0ULL, + 0xb6c52b3278872083ULL, 0xfca2c757bd778ac3ULL, 0x6e48dc74849ba5c0ULL, + 0x6d8a5664f10e4107ULL, 0xf9458eaf7aef1586ULL, 0xdc91b8e909374b80ULL, + 0xdb14acc9e21c820fULL, 0xf28b1d5ef5de2b0dULL, 0xb92371d2126e9700ULL, + 0xb6295993c439041fULL, 0xe5163abdebbc561bULL, 0x7246e3a424dd2e00ULL, + 0x6c52b3278872083fULL, 0xca2c757bd778ac36ULL, 0xe48dc74849ba5c00ULL, + 0xd8a5664f10e4107fULL, 0x9458eaf7aef1586dULL, 0xc91b8e909374b801ULL, + 0xb14acc9e21c820ffULL, 0x28b1d5ef5de2b0dbULL, 0x92371d2126e97003ULL, + 0x6295993c439041feULL, 0x5163abdebbc561b7ULL, 0x246e3a424dd2e006ULL, + 0xc52b3278872083fcULL, 0xa2c757bd778ac36eULL, 0x48dc74849ba5c00cULL, + 0x8a5664f10e4107f9ULL, 0x458eaf7aef1586dcULL, 0x91b8e909374b8019ULL, + 0x14acc9e21c820ff2ULL, 0x8b1d5ef5de2b0db9ULL, 0x2371d2126e970032ULL, + 0x295993c439041fe5ULL, 0x163abdebbc561b72ULL, 0x46e3a424dd2e0064ULL, + 0x52b3278872083fcaULL, 0x2c757bd778ac36e4ULL, 0x8dc74849ba5c00c9ULL, + 0xa5664f10e4107f94ULL, 0x58eaf7aef1586dc9ULL, 0x1b8e909374b80192ULL, + 0x4acc9e21c820ff28ULL, 0xb1d5ef5de2b0db92ULL, 0x371d2126e9700324ULL, + 0x95993c439041fe51ULL, 0x63abdebbc561b724ULL, 0x6e3a424dd2e00649ULL, + 0x2b3278872083fca2ULL, 0xc757bd778ac36e48ULL, 0xdc74849ba5c00c92ULL, + 0x5664f10e4107f945ULL, 0x8eaf7aef1586dc91ULL, 0xb8e909374b801924ULL, + 0xacc9e21c820ff28bULL, 0x1d5ef5de2b0db923ULL, 0x71d2126e97003249ULL, + 0x5993c439041fe516ULL, 0x3abdebbc561b7246ULL, 0xe3a424dd2e006492ULL, + 0xb3278872083fca2cULL, 0x757bd778ac36e48dULL, 0xc74849ba5c00c925ULL, + 0x664f10e4107f9458ULL, 0xeaf7aef1586dc91bULL, 0x8e909374b801924bULL, + 0xcc9e21c820ff28b1ULL, 0xd5ef5de2b0db9237ULL, 0x1d2126e970032497ULL, + 0x993c439041fe5163ULL, 0xabdebbc561b7246eULL, 0x3a424dd2e006492eULL, + 0x3278872083fca2c7ULL, 0x57bd778ac36e48dcULL, 0x74849ba5c00c925dULL, + 0x64f10e4107f9458eULL, 0xaf7aef1586dc91b8ULL, 0xe909374b801924bbULL, + 0xc9e21c820ff28b1dULL, 0x5ef5de2b0db92371ULL, 0xd2126e9700324977ULL, + 0x93c439041fe5163aULL, 0xbdebbc561b7246e3ULL, 0xa424dd2e006492eeULL, + 0x278872083fca2c75ULL, 0x7bd778ac36e48dc7ULL, 0x4849ba5c00c925ddULL, + 0x4f10e4107f9458eaULL, 0xf7aef1586dc91b8eULL, 0x909374b801924bbaULL, + 0x9e21c820ff28b1d5ULL, 0xef5de2b0db92371dULL, 0x2126e97003249775ULL, + 0x3c439041fe5163abULL, 0xdebbc561b7246e3aULL, 0x424dd2e006492eeaULL, + 0x78872083fca2c757ULL, 0xbd778ac36e48dc74ULL, 0x849ba5c00c925dd4ULL, + 0xf10e4107f9458eafULL, 0x7aef1586dc91b8e9ULL, 0x9374b801924bba8ULL, + 0xe21c820ff28b1d5eULL, 0xf5de2b0db92371d2ULL, 0x126e970032497750ULL, + 0xc439041fe5163abdULL, 0xebbc561b7246e3a4ULL, 0x24dd2e006492eea0ULL, + 0x8872083fca2c757bULL, 0xd778ac36e48dc748ULL, 0x49ba5c00c925dd41ULL, + 0x10e4107f9458eaf7ULL, 0xaef1586dc91b8e90ULL, 0x9374b801924bba82ULL, + 0x21c820ff28b1d5efULL, 0x5de2b0db92371d21ULL, 0x26e9700324977504ULL, + 0x439041fe5163abdeULL, 0xbbc561b7246e3a42ULL, 0x4dd2e006492eea09ULL, + 0x872083fca2c757bdULL, 0x778ac36e48dc7484ULL, 0x9ba5c00c925dd413ULL, + 0xe4107f9458eaf7aULL, 0xef1586dc91b8e909ULL, 0x374b801924bba827ULL, + 0x1c820ff28b1d5ef5ULL, 0xde2b0db92371d212ULL, 0x6e9700324977504eULL, + 0x39041fe5163abdebULL, 0xbc561b7246e3a424ULL, 0xdd2e006492eea09dULL, + 0x72083fca2c757bd7ULL, 0x78ac36e48dc74849ULL, 0xba5c00c925dd413aULL, + 0xe4107f9458eaf7aeULL, 0xf1586dc91b8e9093ULL, 0x74b801924bba8274ULL, + 0xc820ff28b1d5ef5dULL, 0xe2b0db92371d2126ULL, 0xe9700324977504e8ULL, + 0x9041fe5163abdebbULL, 0xc561b7246e3a424dULL, 0xd2e006492eea09d1ULL, + 0x2083fca2c757bd77ULL, 0x8ac36e48dc74849bULL, 0xa5c00c925dd413a3ULL, + 0x4107f9458eaf7aefULL, 0x1586dc91b8e90937ULL, 0x4b801924bba82746ULL, + 0x820ff28b1d5ef5deULL, 0x2b0db92371d2126eULL, 0x9700324977504e8cULL, + 0x41fe5163abdebbcULL, 0x561b7246e3a424ddULL, 0x2e006492eea09d19ULL, + 0x83fca2c757bd778ULL, 0xac36e48dc74849baULL, 0x5c00c925dd413a32ULL, + 0x107f9458eaf7aef1ULL, 0x586dc91b8e909374ULL, 0xb801924bba827464ULL, + 0x20ff28b1d5ef5de2ULL, 0xb0db92371d2126e9ULL, 0x700324977504e8c9ULL, + 0x41fe5163abdebbc5ULL, 0x61b7246e3a424dd2ULL, 0xe006492eea09d192ULL, + 0x83fca2c757bd778aULL, 0xc36e48dc74849ba5ULL, 0xc00c925dd413a324ULL, + 0x7f9458eaf7aef15ULL, 0x86dc91b8e909374bULL, 0x801924bba8274648ULL, + 0xff28b1d5ef5de2bULL, 0xdb92371d2126e97ULL, 0x324977504e8c90ULL, + 0x1fe5163abdebbc56ULL, 0x1b7246e3a424dd2eULL, 0x6492eea09d1921ULL, + 0x3fca2c757bd778acULL, 0x36e48dc74849ba5cULL, 0xc925dd413a3243ULL, + 0x7f9458eaf7aef158ULL, 0x6dc91b8e909374b8ULL, 0x1924bba82746487ULL, + 0xff28b1d5ef5de2b0ULL, 0xdb92371d2126e970ULL, 0x324977504e8c90eULL, + 0xfe5163abdebbc561ULL, 0xb7246e3a424dd2e0ULL, 0x6492eea09d1921cULL, + 0xfca2c757bd778ac3ULL, 0x6e48dc74849ba5c0ULL, 0xc925dd413a32439ULL, + 0xf9458eaf7aef1586ULL, 0xdc91b8e909374b80ULL, 0x1924bba827464873ULL, + 0xf28b1d5ef5de2b0dULL, 0xb92371d2126e9700ULL, 0x324977504e8c90e7ULL, + 0xe5163abdebbc561bULL, 0x7246e3a424dd2e00ULL, 0x6492eea09d1921cfULL, + 0xca2c757bd778ac36ULL, 0xe48dc74849ba5c00ULL, 0xc925dd413a32439fULL, + 0x9458eaf7aef1586dULL, 0xc91b8e909374b801ULL, 0x924bba827464873fULL, + 0x28b1d5ef5de2b0dbULL, 0x92371d2126e97003ULL, 0x24977504e8c90e7fULL, + 0x5163abdebbc561b7ULL, 0x246e3a424dd2e006ULL, 0x492eea09d1921cfeULL, + 0xa2c757bd778ac36eULL, 0x48dc74849ba5c00cULL, 0x925dd413a32439fcULL, + 0x458eaf7aef1586dcULL, 0x91b8e909374b8019ULL, 0x24bba827464873f8ULL, + 0x8b1d5ef5de2b0db9ULL, 0x2371d2126e970032ULL, 0x4977504e8c90e7f0ULL, + 0x163abdebbc561b72ULL, 0x46e3a424dd2e0064ULL, 0x92eea09d1921cfe1ULL, + 0x2c757bd778ac36e4ULL, 0x8dc74849ba5c00c9ULL, 0x25dd413a32439fc3ULL, + 0x58eaf7aef1586dc9ULL, 0x1b8e909374b80192ULL, 0x4bba827464873f87ULL, + 0xb1d5ef5de2b0db92ULL, 0x371d2126e9700324ULL, 0x977504e8c90e7f0eULL, + 0x63abdebbc561b724ULL, 0x6e3a424dd2e00649ULL, 0x2eea09d1921cfe1dULL, + 0xc757bd778ac36e48ULL, 0xdc74849ba5c00c92ULL, 0x5dd413a32439fc3bULL, + 0x8eaf7aef1586dc91ULL, 0xb8e909374b801924ULL, 0xbba827464873f877ULL, + 0x1d5ef5de2b0db923ULL, 0x71d2126e97003249ULL, 0x77504e8c90e7f0efULL, + 0x3abdebbc561b7246ULL, 0xe3a424dd2e006492ULL, 0xeea09d1921cfe1deULL, + 0x757bd778ac36e48dULL, 0xc74849ba5c00c925ULL, 0xdd413a32439fc3bdULL, + 0xeaf7aef1586dc91bULL, 0x8e909374b801924bULL, 0xba827464873f877aULL, + 0xd5ef5de2b0db9237ULL, 0x1d2126e970032497ULL, 0x7504e8c90e7f0ef5ULL, + 0xabdebbc561b7246eULL, 0x3a424dd2e006492eULL, 0xea09d1921cfe1debULL, + 0x57bd778ac36e48dcULL, 0x74849ba5c00c925dULL, 0xd413a32439fc3bd6ULL, + 0xaf7aef1586dc91b8ULL, 0xe909374b801924bbULL, 0xa827464873f877acULL, + 0x5ef5de2b0db92371ULL, 0xd2126e9700324977ULL, 0x504e8c90e7f0ef58ULL, + 0xbdebbc561b7246e3ULL, 0xa424dd2e006492eeULL, 0xa09d1921cfe1deb1ULL, + 0x7bd778ac36e48dc7ULL, 0x4849ba5c00c925ddULL, 0x413a32439fc3bd63ULL, + 0xf7aef1586dc91b8eULL, 0x909374b801924bbaULL, 0x827464873f877ac7ULL, + 0xef5de2b0db92371dULL, 0x2126e97003249775ULL, 0x4e8c90e7f0ef58eULL, + 0xdebbc561b7246e3aULL, 0x424dd2e006492eeaULL, 0x9d1921cfe1deb1cULL, + 0xbd778ac36e48dc74ULL, 0x849ba5c00c925dd4ULL, 0x13a32439fc3bd639ULL, + 0x7aef1586dc91b8e9ULL, 0x9374b801924bba8ULL, 0x27464873f877ac72ULL, + 0xf5de2b0db92371d2ULL, 0x126e970032497750ULL, 0x4e8c90e7f0ef58e5ULL, + 0xebbc561b7246e3a4ULL, 0x24dd2e006492eea0ULL, 0x9d1921cfe1deb1cbULL, + 0xd778ac36e48dc748ULL, 0x49ba5c00c925dd41ULL, 0x3a32439fc3bd6396ULL, + 0xaef1586dc91b8e90ULL, 0x9374b801924bba82ULL, 0x7464873f877ac72cULL, + 0x5de2b0db92371d21ULL, 0x26e9700324977504ULL, 0xe8c90e7f0ef58e58ULL, + 0xbbc561b7246e3a42ULL, 0x4dd2e006492eea09ULL, 0xd1921cfe1deb1cb1ULL, + 0x778ac36e48dc7484ULL, 0x9ba5c00c925dd413ULL, 0xa32439fc3bd63962ULL, + 0xef1586dc91b8e909ULL, 0x374b801924bba827ULL, 0x464873f877ac72c4ULL, + 0xde2b0db92371d212ULL, 0x6e9700324977504eULL, 0x8c90e7f0ef58e589ULL, + 0xbc561b7246e3a424ULL, 0xdd2e006492eea09dULL, 0x1921cfe1deb1cb12ULL, + 0x78ac36e48dc74849ULL, 0xba5c00c925dd413aULL, 0x32439fc3bd639625ULL, + 0xf1586dc91b8e9093ULL, 0x74b801924bba8274ULL, 0x64873f877ac72c4aULL, + 0xe2b0db92371d2126ULL, 0xe9700324977504e8ULL, 0xc90e7f0ef58e5894ULL, + 0xc561b7246e3a424dULL, 0xd2e006492eea09d1ULL, 0x921cfe1deb1cb129ULL, + 0x8ac36e48dc74849bULL, 0xa5c00c925dd413a3ULL, 0x2439fc3bd6396253ULL, + 0x1586dc91b8e90937ULL, 0x4b801924bba82746ULL, 0x4873f877ac72c4a6ULL, + 0x2b0db92371d2126eULL, 0x9700324977504e8cULL, 0x90e7f0ef58e5894dULL, + 0x561b7246e3a424ddULL, 0x2e006492eea09d19ULL, 0x21cfe1deb1cb129aULL, + 0xac36e48dc74849baULL, 0x5c00c925dd413a32ULL, 0x439fc3bd63962534ULL, + 0x586dc91b8e909374ULL, 0xb801924bba827464ULL, 0x873f877ac72c4a69ULL, + 0xb0db92371d2126e9ULL, 0x700324977504e8c9ULL, 0xe7f0ef58e5894d3ULL, + 0x61b7246e3a424dd2ULL, 0xe006492eea09d192ULL, 0x1cfe1deb1cb129a7ULL, + 0xc36e48dc74849ba5ULL, 0xc00c925dd413a324ULL, 0x39fc3bd63962534eULL, + 0x86dc91b8e909374bULL, 0x801924bba8274648ULL, 0x73f877ac72c4a69cULL, + 0xdb92371d2126e97ULL, 0x324977504e8c90ULL, 0xe7f0ef58e5894d39ULL, + 0x1b7246e3a424dd2eULL, 0x6492eea09d1921ULL, 0xcfe1deb1cb129a73ULL, + 0x36e48dc74849ba5cULL, 0xc925dd413a3243ULL, 0x9fc3bd63962534e7ULL, + 0x6dc91b8e909374b8ULL, 0x1924bba82746487ULL, 0x3f877ac72c4a69cfULL, + 0xdb92371d2126e970ULL, 0x324977504e8c90eULL, 0x7f0ef58e5894d39fULL, + 0xb7246e3a424dd2e0ULL, 0x6492eea09d1921cULL, 0xfe1deb1cb129a73eULL, + 0x6e48dc74849ba5c0ULL, 0xc925dd413a32439ULL, 0xfc3bd63962534e7dULL, + 0xdc91b8e909374b80ULL, 0x1924bba827464873ULL, 0xf877ac72c4a69cfbULL, + 0xb92371d2126e9700ULL, 0x324977504e8c90e7ULL, 0xf0ef58e5894d39f7ULL, + 0x7246e3a424dd2e00ULL, 0x6492eea09d1921cfULL, 0xe1deb1cb129a73eeULL, + 0xe48dc74849ba5c00ULL, 0xc925dd413a32439fULL, 0xc3bd63962534e7ddULL, + 0xc91b8e909374b801ULL, 0x924bba827464873fULL, 0x877ac72c4a69cfbaULL, + 0x92371d2126e97003ULL, 0x24977504e8c90e7fULL, 0xef58e5894d39f74ULL, + 0x246e3a424dd2e006ULL, 0x492eea09d1921cfeULL, 0x1deb1cb129a73ee8ULL, + 0x48dc74849ba5c00cULL, 0x925dd413a32439fcULL, 0x3bd63962534e7dd1ULL, + 0x91b8e909374b8019ULL, 0x24bba827464873f8ULL, 0x77ac72c4a69cfba2ULL, + 0x2371d2126e970032ULL, 0x4977504e8c90e7f0ULL, 0xef58e5894d39f744ULL, + 0x46e3a424dd2e0064ULL, 0x92eea09d1921cfe1ULL, 0xdeb1cb129a73ee88ULL, + 0x8dc74849ba5c00c9ULL, 0x25dd413a32439fc3ULL, 0xbd63962534e7dd10ULL, + 0x1b8e909374b80192ULL, 0x4bba827464873f87ULL, 0x7ac72c4a69cfba20ULL, + 0x371d2126e9700324ULL, 0x977504e8c90e7f0eULL, 0xf58e5894d39f7441ULL, + 0x6e3a424dd2e00649ULL, 0x2eea09d1921cfe1dULL, 0xeb1cb129a73ee882ULL, + 0xdc74849ba5c00c92ULL, 0x5dd413a32439fc3bULL, 0xd63962534e7dd104ULL, + 0xb8e909374b801924ULL, 0xbba827464873f877ULL, 0xac72c4a69cfba208ULL, + 0x71d2126e97003249ULL, 0x77504e8c90e7f0efULL, 0x58e5894d39f74411ULL, + 0xe3a424dd2e006492ULL, 0xeea09d1921cfe1deULL, 0xb1cb129a73ee8823ULL, + 0xc74849ba5c00c925ULL, 0xdd413a32439fc3bdULL, 0x63962534e7dd1046ULL, + 0x8e909374b801924bULL, 0xba827464873f877aULL, 0xc72c4a69cfba208dULL, + 0x1d2126e970032497ULL, 0x7504e8c90e7f0ef5ULL, 0x8e5894d39f74411aULL, + 0x3a424dd2e006492eULL, 0xea09d1921cfe1debULL, 0x1cb129a73ee88235ULL, + 0x74849ba5c00c925dULL, 0xd413a32439fc3bd6ULL, 0x3962534e7dd1046bULL, + 0xe909374b801924bbULL, 0xa827464873f877acULL, 0x72c4a69cfba208d7ULL, + 0xd2126e9700324977ULL, 0x504e8c90e7f0ef58ULL, 0xe5894d39f74411afULL, + 0xa424dd2e006492eeULL, 0xa09d1921cfe1deb1ULL, 0xcb129a73ee88235fULL, + 0x4849ba5c00c925ddULL, 0x413a32439fc3bd63ULL, 0x962534e7dd1046beULL, + 0x909374b801924bbaULL, 0x827464873f877ac7ULL, 0x2c4a69cfba208d7dULL, + 0x2126e97003249775ULL, 0x4e8c90e7f0ef58eULL, 0x5894d39f74411afaULL, + 0x424dd2e006492eeaULL, 0x9d1921cfe1deb1cULL, 0xb129a73ee88235f5ULL, + 0x849ba5c00c925dd4ULL, 0x13a32439fc3bd639ULL, 0x62534e7dd1046beaULL, + 0x9374b801924bba8ULL, 0x27464873f877ac72ULL, 0xc4a69cfba208d7d4ULL, + 0x126e970032497750ULL, 0x4e8c90e7f0ef58e5ULL, 0x894d39f74411afa9ULL, + 0x24dd2e006492eea0ULL, 0x9d1921cfe1deb1cbULL, 0x129a73ee88235f52ULL, + 0x49ba5c00c925dd41ULL, 0x3a32439fc3bd6396ULL, 0x2534e7dd1046bea5ULL, + 0x9374b801924bba82ULL, 0x7464873f877ac72cULL, 0x4a69cfba208d7d4bULL, + 0x26e9700324977504ULL, 0xe8c90e7f0ef58e58ULL, 0x94d39f74411afa97ULL, + 0x4dd2e006492eea09ULL, 0xd1921cfe1deb1cb1ULL, 0x29a73ee88235f52eULL, + 0x9ba5c00c925dd413ULL, 0xa32439fc3bd63962ULL, 0x534e7dd1046bea5dULL, + 0x374b801924bba827ULL, 0x464873f877ac72c4ULL, 0xa69cfba208d7d4baULL, + 0x6e9700324977504eULL, 0x8c90e7f0ef58e589ULL, 0x4d39f74411afa975ULL, + 0xdd2e006492eea09dULL, 0x1921cfe1deb1cb12ULL, 0x9a73ee88235f52ebULL, + 0xba5c00c925dd413aULL, 0x32439fc3bd639625ULL, 0x34e7dd1046bea5d7ULL, + 0x74b801924bba8274ULL, 0x64873f877ac72c4aULL, 0x69cfba208d7d4baeULL, + 0xe9700324977504e8ULL, 0xc90e7f0ef58e5894ULL, 0xd39f74411afa975dULL, + 0xd2e006492eea09d1ULL, 0x921cfe1deb1cb129ULL, 0xa73ee88235f52ebbULL, + 0xa5c00c925dd413a3ULL, 0x2439fc3bd6396253ULL, 0x4e7dd1046bea5d76ULL, + 0x4b801924bba82746ULL, 0x4873f877ac72c4a6ULL, 0x9cfba208d7d4baedULL, + 0x9700324977504e8cULL, 0x90e7f0ef58e5894dULL, 0x39f74411afa975daULL, + 0x2e006492eea09d19ULL, 0x21cfe1deb1cb129aULL, 0x73ee88235f52ebb4ULL, + 0x5c00c925dd413a32ULL, 0x439fc3bd63962534ULL, 0xe7dd1046bea5d768ULL, + 0xb801924bba827464ULL, 0x873f877ac72c4a69ULL, 0xcfba208d7d4baed1ULL, + 0x700324977504e8c9ULL, 0xe7f0ef58e5894d3ULL, 0x9f74411afa975da2ULL, + 0xe006492eea09d192ULL, 0x1cfe1deb1cb129a7ULL, 0x3ee88235f52ebb44ULL, + 0xc00c925dd413a324ULL, 0x39fc3bd63962534eULL, 0x7dd1046bea5d7689ULL, + 0x801924bba8274648ULL, 0x73f877ac72c4a69cULL, 0xfba208d7d4baed12ULL, + 0x324977504e8c90ULL, 0xe7f0ef58e5894d39ULL, 0xf74411afa975da24ULL, + 0x6492eea09d1921ULL, 0xcfe1deb1cb129a73ULL, 0xee88235f52ebb448ULL, + 0xc925dd413a3243ULL, 0x9fc3bd63962534e7ULL, 0xdd1046bea5d76890ULL, + 0x1924bba82746487ULL, 0x3f877ac72c4a69cfULL, 0xba208d7d4baed121ULL, + 0x324977504e8c90eULL, 0x7f0ef58e5894d39fULL, 0x74411afa975da242ULL, + 0x6492eea09d1921cULL, 0xfe1deb1cb129a73eULL, 0xe88235f52ebb4484ULL, + 0xc925dd413a32439ULL, 0xfc3bd63962534e7dULL, 0xd1046bea5d768909ULL, + 0x1924bba827464873ULL, 0xf877ac72c4a69cfbULL, 0xa208d7d4baed1213ULL, + 0x324977504e8c90e7ULL, 0xf0ef58e5894d39f7ULL, 0x4411afa975da2427ULL, + 0x6492eea09d1921cfULL, 0xe1deb1cb129a73eeULL, 0x88235f52ebb4484eULL, + 0xc925dd413a32439fULL, 0xc3bd63962534e7ddULL, 0x1046bea5d768909dULL, + 0x924bba827464873fULL, 0x877ac72c4a69cfbaULL, 0x208d7d4baed1213aULL, + 0x24977504e8c90e7fULL, 0xef58e5894d39f74ULL, 0x411afa975da24274ULL, + 0x492eea09d1921cfeULL, 0x1deb1cb129a73ee8ULL, 0x8235f52ebb4484e9ULL, + 0x925dd413a32439fcULL, 0x3bd63962534e7dd1ULL, 0x46bea5d768909d3ULL, + 0x24bba827464873f8ULL, 0x77ac72c4a69cfba2ULL, 0x8d7d4baed1213a6ULL, + 0x4977504e8c90e7f0ULL, 0xef58e5894d39f744ULL, 0x11afa975da24274cULL, + 0x92eea09d1921cfe1ULL, 0xdeb1cb129a73ee88ULL, 0x235f52ebb4484e99ULL, + 0x25dd413a32439fc3ULL, 0xbd63962534e7dd10ULL, 0x46bea5d768909d33ULL, + 0x4bba827464873f87ULL, 0x7ac72c4a69cfba20ULL, 0x8d7d4baed1213a67ULL, + 0x977504e8c90e7f0eULL, 0xf58e5894d39f7441ULL, 0x1afa975da24274ceULL, + 0x2eea09d1921cfe1dULL, 0xeb1cb129a73ee882ULL, 0x35f52ebb4484e99cULL, + 0x5dd413a32439fc3bULL, 0xd63962534e7dd104ULL, 0x6bea5d768909d338ULL, + 0xbba827464873f877ULL, 0xac72c4a69cfba208ULL, 0xd7d4baed1213a671ULL, + 0x77504e8c90e7f0efULL, 0x58e5894d39f74411ULL, 0xafa975da24274ce3ULL, + 0xeea09d1921cfe1deULL, 0xb1cb129a73ee8823ULL, 0x5f52ebb4484e99c7ULL, + 0xdd413a32439fc3bdULL, 0x63962534e7dd1046ULL, 0xbea5d768909d338eULL, + 0xba827464873f877aULL, 0xc72c4a69cfba208dULL, 0x7d4baed1213a671cULL, + 0x7504e8c90e7f0ef5ULL, 0x8e5894d39f74411aULL, 0xfa975da24274ce38ULL, + 0xea09d1921cfe1debULL, 0x1cb129a73ee88235ULL, 0xf52ebb4484e99c70ULL, + 0xd413a32439fc3bd6ULL, 0x3962534e7dd1046bULL, 0xea5d768909d338e0ULL, + 0xa827464873f877acULL, 0x72c4a69cfba208d7ULL, 0xd4baed1213a671c0ULL, + 0x504e8c90e7f0ef58ULL, 0xe5894d39f74411afULL, 0xa975da24274ce381ULL, + 0xa09d1921cfe1deb1ULL, 0xcb129a73ee88235fULL, 0x52ebb4484e99c702ULL, + 0x413a32439fc3bd63ULL, 0x962534e7dd1046beULL, 0xa5d768909d338e04ULL, + 0x827464873f877ac7ULL, 0x2c4a69cfba208d7dULL, 0x4baed1213a671c09ULL, + 0x4e8c90e7f0ef58eULL, 0x5894d39f74411afaULL, 0x975da24274ce3813ULL, + 0x9d1921cfe1deb1cULL, 0xb129a73ee88235f5ULL, 0x2ebb4484e99c7026ULL, + 0x13a32439fc3bd639ULL, 0x62534e7dd1046beaULL, 0x5d768909d338e04dULL, + 0x27464873f877ac72ULL, 0xc4a69cfba208d7d4ULL, 0xbaed1213a671c09aULL, + 0x4e8c90e7f0ef58e5ULL, 0x894d39f74411afa9ULL, 0x75da24274ce38135ULL, + 0x9d1921cfe1deb1cbULL, 0x129a73ee88235f52ULL, 0xebb4484e99c7026bULL, + 0x3a32439fc3bd6396ULL, 0x2534e7dd1046bea5ULL, 0xd768909d338e04d6ULL, + 0x7464873f877ac72cULL, 0x4a69cfba208d7d4bULL, 0xaed1213a671c09adULL, + 0xe8c90e7f0ef58e58ULL, 0x94d39f74411afa97ULL, 0x5da24274ce38135aULL, + 0xd1921cfe1deb1cb1ULL, 0x29a73ee88235f52eULL, 0xbb4484e99c7026b4ULL, + 0xa32439fc3bd63962ULL, 0x534e7dd1046bea5dULL, 0x768909d338e04d68ULL, + 0x464873f877ac72c4ULL, 0xa69cfba208d7d4baULL, 0xed1213a671c09ad1ULL, + 0x8c90e7f0ef58e589ULL, 0x4d39f74411afa975ULL, 0xda24274ce38135a2ULL, + 0x1921cfe1deb1cb12ULL, 0x9a73ee88235f52ebULL, 0xb4484e99c7026b45ULL, + 0x32439fc3bd639625ULL, 0x34e7dd1046bea5d7ULL, 0x68909d338e04d68bULL, + 0x64873f877ac72c4aULL, 0x69cfba208d7d4baeULL, 0xd1213a671c09ad17ULL, + 0xc90e7f0ef58e5894ULL, 0xd39f74411afa975dULL, 0xa24274ce38135a2fULL, + 0x921cfe1deb1cb129ULL, 0xa73ee88235f52ebbULL, 0x4484e99c7026b45fULL, + 0x2439fc3bd6396253ULL, 0x4e7dd1046bea5d76ULL, 0x8909d338e04d68beULL, + 0x4873f877ac72c4a6ULL, 0x9cfba208d7d4baedULL, 0x1213a671c09ad17dULL, + 0x90e7f0ef58e5894dULL, 0x39f74411afa975daULL, 0x24274ce38135a2fbULL, + 0x21cfe1deb1cb129aULL, 0x73ee88235f52ebb4ULL, 0x484e99c7026b45f7ULL, + 0x439fc3bd63962534ULL, 0xe7dd1046bea5d768ULL, 0x909d338e04d68befULL, + 0x873f877ac72c4a69ULL, 0xcfba208d7d4baed1ULL, 0x213a671c09ad17dfULL, + 0xe7f0ef58e5894d3ULL, 0x9f74411afa975da2ULL, 0x4274ce38135a2fbfULL, + 0x1cfe1deb1cb129a7ULL, 0x3ee88235f52ebb44ULL, 0x84e99c7026b45f7eULL, + 0x39fc3bd63962534eULL, 0x7dd1046bea5d7689ULL, 0x9d338e04d68befcULL, + 0x73f877ac72c4a69cULL, 0xfba208d7d4baed12ULL, 0x13a671c09ad17df9ULL, + 0xe7f0ef58e5894d39ULL, 0xf74411afa975da24ULL, 0x274ce38135a2fbf2ULL, + 0xcfe1deb1cb129a73ULL, 0xee88235f52ebb448ULL, 0x4e99c7026b45f7e4ULL, + 0x9fc3bd63962534e7ULL, 0xdd1046bea5d76890ULL, 0x9d338e04d68befc8ULL, + 0x3f877ac72c4a69cfULL, 0xba208d7d4baed121ULL, 0x3a671c09ad17df90ULL, + 0x7f0ef58e5894d39fULL, 0x74411afa975da242ULL, 0x74ce38135a2fbf20ULL, + 0xfe1deb1cb129a73eULL, 0xe88235f52ebb4484ULL, 0xe99c7026b45f7e41ULL, + 0xfc3bd63962534e7dULL, 0xd1046bea5d768909ULL, 0xd338e04d68befc82ULL, + 0xf877ac72c4a69cfbULL, 0xa208d7d4baed1213ULL, 0xa671c09ad17df904ULL, + 0xf0ef58e5894d39f7ULL, 0x4411afa975da2427ULL, 0x4ce38135a2fbf209ULL, + 0xe1deb1cb129a73eeULL, 0x88235f52ebb4484eULL, 0x99c7026b45f7e413ULL, + 0xc3bd63962534e7ddULL, 0x1046bea5d768909dULL, 0x338e04d68befc827ULL, + 0x877ac72c4a69cfbaULL, 0x208d7d4baed1213aULL, 0x671c09ad17df904eULL, + 0xef58e5894d39f74ULL, 0x411afa975da24274ULL, 0xce38135a2fbf209cULL, + 0x1deb1cb129a73ee8ULL, 0x8235f52ebb4484e9ULL, 0x9c7026b45f7e4139ULL, + 0x3bd63962534e7dd1ULL, 0x46bea5d768909d3ULL, 0x38e04d68befc8273ULL, + 0x77ac72c4a69cfba2ULL, 0x8d7d4baed1213a6ULL, 0x71c09ad17df904e6ULL, + 0xef58e5894d39f744ULL, 0x11afa975da24274cULL, 0xe38135a2fbf209ccULL, + 0xdeb1cb129a73ee88ULL, 0x235f52ebb4484e99ULL, 0xc7026b45f7e41399ULL, + 0xbd63962534e7dd10ULL, 0x46bea5d768909d33ULL, 0x8e04d68befc82732ULL, + 0x7ac72c4a69cfba20ULL, 0x8d7d4baed1213a67ULL, 0x1c09ad17df904e64ULL, + 0xf58e5894d39f7441ULL, 0x1afa975da24274ceULL, 0x38135a2fbf209cc8ULL, + 0xeb1cb129a73ee882ULL, 0x35f52ebb4484e99cULL, 0x7026b45f7e413991ULL, + 0xd63962534e7dd104ULL, 0x6bea5d768909d338ULL, 0xe04d68befc827323ULL, + 0xac72c4a69cfba208ULL, 0xd7d4baed1213a671ULL, 0xc09ad17df904e647ULL, + 0x58e5894d39f74411ULL, 0xafa975da24274ce3ULL, 0x8135a2fbf209cc8eULL, + 0xb1cb129a73ee8823ULL, 0x5f52ebb4484e99c7ULL, 0x26b45f7e413991dULL, + 0x63962534e7dd1046ULL, 0xbea5d768909d338eULL, 0x4d68befc827323aULL, + 0xc72c4a69cfba208dULL, 0x7d4baed1213a671cULL, 0x9ad17df904e6475ULL, + 0x8e5894d39f74411aULL, 0xfa975da24274ce38ULL, 0x135a2fbf209cc8ebULL, + 0x1cb129a73ee88235ULL, 0xf52ebb4484e99c70ULL, 0x26b45f7e413991d6ULL, + 0x3962534e7dd1046bULL, 0xea5d768909d338e0ULL, 0x4d68befc827323acULL, + 0x72c4a69cfba208d7ULL, 0xd4baed1213a671c0ULL, 0x9ad17df904e64758ULL, + 0xe5894d39f74411afULL, 0xa975da24274ce381ULL, 0x35a2fbf209cc8eb1ULL, + 0xcb129a73ee88235fULL, 0x52ebb4484e99c702ULL, 0x6b45f7e413991d63ULL, + 0x962534e7dd1046beULL, 0xa5d768909d338e04ULL, 0xd68befc827323ac7ULL, + 0x2c4a69cfba208d7dULL, 0x4baed1213a671c09ULL, 0xad17df904e64758eULL, + 0x5894d39f74411afaULL, 0x975da24274ce3813ULL, 0x5a2fbf209cc8eb1cULL, + 0xb129a73ee88235f5ULL, 0x2ebb4484e99c7026ULL, 0xb45f7e413991d639ULL, + 0x62534e7dd1046beaULL, 0x5d768909d338e04dULL, 0x68befc827323ac73ULL, + 0xc4a69cfba208d7d4ULL, 0xbaed1213a671c09aULL, 0xd17df904e64758e6ULL, + 0x894d39f74411afa9ULL, 0x75da24274ce38135ULL, 0xa2fbf209cc8eb1ccULL, + 0x129a73ee88235f52ULL, 0xebb4484e99c7026bULL, 0x45f7e413991d6398ULL, + 0x2534e7dd1046bea5ULL, 0xd768909d338e04d6ULL, 0x8befc827323ac730ULL, + 0x4a69cfba208d7d4bULL, 0xaed1213a671c09adULL, 0x17df904e64758e60ULL, + 0x94d39f74411afa97ULL, 0x5da24274ce38135aULL, 0x2fbf209cc8eb1cc1ULL, + 0x29a73ee88235f52eULL, 0xbb4484e99c7026b4ULL, 0x5f7e413991d63983ULL, + 0x534e7dd1046bea5dULL, 0x768909d338e04d68ULL, 0xbefc827323ac7306ULL, + 0xa69cfba208d7d4baULL, 0xed1213a671c09ad1ULL, 0x7df904e64758e60dULL, + 0x4d39f74411afa975ULL, 0xda24274ce38135a2ULL, 0xfbf209cc8eb1cc1aULL, + 0x9a73ee88235f52ebULL, 0xb4484e99c7026b45ULL, 0xf7e413991d639835ULL, + 0x34e7dd1046bea5d7ULL, 0x68909d338e04d68bULL, 0xefc827323ac7306aULL, + 0x69cfba208d7d4baeULL, 0xd1213a671c09ad17ULL, 0xdf904e64758e60d4ULL, + 0xd39f74411afa975dULL, 0xa24274ce38135a2fULL, 0xbf209cc8eb1cc1a9ULL, + 0xa73ee88235f52ebbULL, 0x4484e99c7026b45fULL, 0x7e413991d6398353ULL, + 0x4e7dd1046bea5d76ULL, 0x8909d338e04d68beULL, 0xfc827323ac7306a6ULL, + 0x9cfba208d7d4baedULL, 0x1213a671c09ad17dULL, 0xf904e64758e60d4cULL, + 0x39f74411afa975daULL, 0x24274ce38135a2fbULL, 0xf209cc8eb1cc1a99ULL, + 0x73ee88235f52ebb4ULL, 0x484e99c7026b45f7ULL, 0xe413991d63983533ULL, + 0xe7dd1046bea5d768ULL, 0x909d338e04d68befULL, 0xc827323ac7306a67ULL, + 0xcfba208d7d4baed1ULL, 0x213a671c09ad17dfULL, 0x904e64758e60d4ceULL, + 0x9f74411afa975da2ULL, 0x4274ce38135a2fbfULL, 0x209cc8eb1cc1a99cULL, + 0x3ee88235f52ebb44ULL, 0x84e99c7026b45f7eULL, 0x413991d639835339ULL, + 0x7dd1046bea5d7689ULL, 0x9d338e04d68befcULL, 0x827323ac7306a673ULL, + 0xfba208d7d4baed12ULL, 0x13a671c09ad17df9ULL, 0x4e64758e60d4ce7ULL, + 0xf74411afa975da24ULL, 0x274ce38135a2fbf2ULL, 0x9cc8eb1cc1a99cfULL, + 0xee88235f52ebb448ULL, 0x4e99c7026b45f7e4ULL, 0x13991d639835339fULL, + 0xdd1046bea5d76890ULL, 0x9d338e04d68befc8ULL, 0x27323ac7306a673eULL, + 0xba208d7d4baed121ULL, 0x3a671c09ad17df90ULL, 0x4e64758e60d4ce7dULL, + 0x74411afa975da242ULL, 0x74ce38135a2fbf20ULL, 0x9cc8eb1cc1a99cfaULL, + 0xe88235f52ebb4484ULL, 0xe99c7026b45f7e41ULL, 0x3991d639835339f4ULL, + 0xd1046bea5d768909ULL, 0xd338e04d68befc82ULL, 0x7323ac7306a673e9ULL, + 0xa208d7d4baed1213ULL, 0xa671c09ad17df904ULL, 0xe64758e60d4ce7d2ULL, + 0x4411afa975da2427ULL, 0x4ce38135a2fbf209ULL, 0xcc8eb1cc1a99cfa4ULL, + 0x88235f52ebb4484eULL, 0x99c7026b45f7e413ULL, 0x991d639835339f49ULL, + 0x1046bea5d768909dULL, 0x338e04d68befc827ULL, 0x323ac7306a673e93ULL, + 0x208d7d4baed1213aULL, 0x671c09ad17df904eULL, 0x64758e60d4ce7d27ULL, + 0x411afa975da24274ULL, 0xce38135a2fbf209cULL, 0xc8eb1cc1a99cfa4eULL, + 0x8235f52ebb4484e9ULL, 0x9c7026b45f7e4139ULL, 0x91d639835339f49cULL, + 0x46bea5d768909d3ULL, 0x38e04d68befc8273ULL, 0x23ac7306a673e939ULL, + 0x8d7d4baed1213a6ULL, 0x71c09ad17df904e6ULL, 0x4758e60d4ce7d272ULL, + 0x11afa975da24274cULL, 0xe38135a2fbf209ccULL, 0x8eb1cc1a99cfa4e4ULL, + 0x235f52ebb4484e99ULL, 0xc7026b45f7e41399ULL, 0x1d639835339f49c8ULL, + 0x46bea5d768909d33ULL, 0x8e04d68befc82732ULL, 0x3ac7306a673e9390ULL, + 0x8d7d4baed1213a67ULL, 0x1c09ad17df904e64ULL, 0x758e60d4ce7d2721ULL, + 0x1afa975da24274ceULL, 0x38135a2fbf209cc8ULL, 0xeb1cc1a99cfa4e42ULL, + 0x35f52ebb4484e99cULL, 0x7026b45f7e413991ULL, 0xd639835339f49c84ULL, + 0x6bea5d768909d338ULL, 0xe04d68befc827323ULL, 0xac7306a673e93908ULL, + 0xd7d4baed1213a671ULL, 0xc09ad17df904e647ULL, 0x58e60d4ce7d27211ULL, + 0xafa975da24274ce3ULL, 0x8135a2fbf209cc8eULL, 0xb1cc1a99cfa4e422ULL, + 0x5f52ebb4484e99c7ULL, 0x26b45f7e413991dULL, 0x639835339f49c845ULL, + 0xbea5d768909d338eULL, 0x4d68befc827323aULL, 0xc7306a673e93908bULL, + 0x7d4baed1213a671cULL, 0x9ad17df904e6475ULL, 0x8e60d4ce7d272117ULL, + 0xfa975da24274ce38ULL, 0x135a2fbf209cc8ebULL, 0x1cc1a99cfa4e422fULL, + 0xf52ebb4484e99c70ULL, 0x26b45f7e413991d6ULL, 0x39835339f49c845fULL, + 0xea5d768909d338e0ULL, 0x4d68befc827323acULL, 0x7306a673e93908bfULL, + 0xd4baed1213a671c0ULL, 0x9ad17df904e64758ULL, 0xe60d4ce7d272117eULL, + 0xa975da24274ce381ULL, 0x35a2fbf209cc8eb1ULL, 0xcc1a99cfa4e422fcULL, + 0x52ebb4484e99c702ULL, 0x6b45f7e413991d63ULL, 0x9835339f49c845f8ULL, + 0xa5d768909d338e04ULL, 0xd68befc827323ac7ULL, 0x306a673e93908bf1ULL, + 0x4baed1213a671c09ULL, 0xad17df904e64758eULL, 0x60d4ce7d272117e2ULL, + 0x975da24274ce3813ULL, 0x5a2fbf209cc8eb1cULL, 0xc1a99cfa4e422fc5ULL, + 0x2ebb4484e99c7026ULL, 0xb45f7e413991d639ULL, 0x835339f49c845f8bULL, + 0x5d768909d338e04dULL, 0x68befc827323ac73ULL, 0x6a673e93908bf17ULL, + 0xbaed1213a671c09aULL, 0xd17df904e64758e6ULL, 0xd4ce7d272117e2eULL, + 0x75da24274ce38135ULL, 0xa2fbf209cc8eb1ccULL, 0x1a99cfa4e422fc5dULL, + 0xebb4484e99c7026bULL, 0x45f7e413991d6398ULL, 0x35339f49c845f8bbULL, + 0xd768909d338e04d6ULL, 0x8befc827323ac730ULL, 0x6a673e93908bf177ULL, + 0xaed1213a671c09adULL, 0x17df904e64758e60ULL, 0xd4ce7d272117e2efULL, + 0x5da24274ce38135aULL, 0x2fbf209cc8eb1cc1ULL, 0xa99cfa4e422fc5deULL, + 0xbb4484e99c7026b4ULL, 0x5f7e413991d63983ULL, 0x5339f49c845f8bbdULL, + 0x768909d338e04d68ULL, 0xbefc827323ac7306ULL, 0xa673e93908bf177bULL, + 0xed1213a671c09ad1ULL, 0x7df904e64758e60dULL, 0x4ce7d272117e2ef7ULL, + 0xda24274ce38135a2ULL, 0xfbf209cc8eb1cc1aULL, 0x99cfa4e422fc5defULL, + 0xb4484e99c7026b45ULL, 0xf7e413991d639835ULL, 0x339f49c845f8bbdfULL, + 0x68909d338e04d68bULL, 0xefc827323ac7306aULL, 0x673e93908bf177bfULL, + 0xd1213a671c09ad17ULL, 0xdf904e64758e60d4ULL, 0xce7d272117e2ef7eULL, + 0xa24274ce38135a2fULL, 0xbf209cc8eb1cc1a9ULL, 0x9cfa4e422fc5defcULL, + 0x4484e99c7026b45fULL, 0x7e413991d6398353ULL, 0x39f49c845f8bbdf9ULL, + 0x8909d338e04d68beULL, 0xfc827323ac7306a6ULL, 0x73e93908bf177bf2ULL, + 0x1213a671c09ad17dULL, 0xf904e64758e60d4cULL, 0xe7d272117e2ef7e4ULL, + 0x24274ce38135a2fbULL, 0xf209cc8eb1cc1a99ULL, 0xcfa4e422fc5defc9ULL, + 0x484e99c7026b45f7ULL, 0xe413991d63983533ULL, 0x9f49c845f8bbdf92ULL, + 0x909d338e04d68befULL, 0xc827323ac7306a67ULL, 0x3e93908bf177bf25ULL, + 0x213a671c09ad17dfULL, 0x904e64758e60d4ceULL, 0x7d272117e2ef7e4aULL, + 0x4274ce38135a2fbfULL, 0x209cc8eb1cc1a99cULL, 0xfa4e422fc5defc94ULL, + 0x84e99c7026b45f7eULL, 0x413991d639835339ULL, 0xf49c845f8bbdf928ULL, + 0x9d338e04d68befcULL, 0x827323ac7306a673ULL, 0xe93908bf177bf250ULL, + 0x13a671c09ad17df9ULL, 0x4e64758e60d4ce7ULL, 0xd272117e2ef7e4a0ULL, + 0x274ce38135a2fbf2ULL, 0x9cc8eb1cc1a99cfULL, 0xa4e422fc5defc941ULL, + 0x4e99c7026b45f7e4ULL, 0x13991d639835339fULL, 0x49c845f8bbdf9283ULL, + 0x9d338e04d68befc8ULL, 0x27323ac7306a673eULL, 0x93908bf177bf2507ULL, + 0x3a671c09ad17df90ULL, 0x4e64758e60d4ce7dULL, 0x272117e2ef7e4a0eULL, + 0x74ce38135a2fbf20ULL, 0x9cc8eb1cc1a99cfaULL, 0x4e422fc5defc941dULL, + 0xe99c7026b45f7e41ULL, 0x3991d639835339f4ULL, 0x9c845f8bbdf9283bULL, + 0xd338e04d68befc82ULL, 0x7323ac7306a673e9ULL, 0x3908bf177bf25076ULL, + 0xa671c09ad17df904ULL, 0xe64758e60d4ce7d2ULL, 0x72117e2ef7e4a0ecULL, + 0x4ce38135a2fbf209ULL, 0xcc8eb1cc1a99cfa4ULL, 0xe422fc5defc941d8ULL, + 0x99c7026b45f7e413ULL, 0x991d639835339f49ULL, 0xc845f8bbdf9283b1ULL, + 0x338e04d68befc827ULL, 0x323ac7306a673e93ULL, 0x908bf177bf250763ULL, + 0x671c09ad17df904eULL, 0x64758e60d4ce7d27ULL, 0x2117e2ef7e4a0ec7ULL, + 0xce38135a2fbf209cULL, 0xc8eb1cc1a99cfa4eULL, 0x422fc5defc941d8fULL, + 0x9c7026b45f7e4139ULL, 0x91d639835339f49cULL, 0x845f8bbdf9283b1fULL, + 0x38e04d68befc8273ULL, 0x23ac7306a673e939ULL, 0x8bf177bf250763fULL, + 0x71c09ad17df904e6ULL, 0x4758e60d4ce7d272ULL, 0x117e2ef7e4a0ec7fULL, + 0xe38135a2fbf209ccULL, 0x8eb1cc1a99cfa4e4ULL, 0x22fc5defc941d8ffULL, + 0xc7026b45f7e41399ULL, 0x1d639835339f49c8ULL, 0x45f8bbdf9283b1ffULL, + 0x8e04d68befc82732ULL, 0x3ac7306a673e9390ULL, 0x8bf177bf250763ffULL, + 0x1c09ad17df904e64ULL, 0x758e60d4ce7d2721ULL, 0x17e2ef7e4a0ec7feULL, + 0x38135a2fbf209cc8ULL, 0xeb1cc1a99cfa4e42ULL, 0x2fc5defc941d8ffcULL, + 0x7026b45f7e413991ULL, 0xd639835339f49c84ULL, 0x5f8bbdf9283b1ff8ULL, + 0xe04d68befc827323ULL, 0xac7306a673e93908ULL, 0xbf177bf250763ff1ULL, + 0xc09ad17df904e647ULL, 0x58e60d4ce7d27211ULL, 0x7e2ef7e4a0ec7fe2ULL, + 0x8135a2fbf209cc8eULL, 0xb1cc1a99cfa4e422ULL, 0xfc5defc941d8ffc4ULL, + 0x26b45f7e413991dULL, 0x639835339f49c845ULL, 0xf8bbdf9283b1ff89ULL, + 0x4d68befc827323aULL, 0xc7306a673e93908bULL, 0xf177bf250763ff12ULL, + 0x9ad17df904e6475ULL, 0x8e60d4ce7d272117ULL, 0xe2ef7e4a0ec7fe25ULL, + 0x135a2fbf209cc8ebULL, 0x1cc1a99cfa4e422fULL, 0xc5defc941d8ffc4bULL, + 0x26b45f7e413991d6ULL, 0x39835339f49c845fULL, 0x8bbdf9283b1ff897ULL, + 0x4d68befc827323acULL, 0x7306a673e93908bfULL, 0x177bf250763ff12fULL, + 0x9ad17df904e64758ULL, 0xe60d4ce7d272117eULL, 0x2ef7e4a0ec7fe25fULL, + 0x35a2fbf209cc8eb1ULL, 0xcc1a99cfa4e422fcULL, 0x5defc941d8ffc4bfULL, + 0x6b45f7e413991d63ULL, 0x9835339f49c845f8ULL, 0xbbdf9283b1ff897fULL, + 0xd68befc827323ac7ULL, 0x306a673e93908bf1ULL, 0x77bf250763ff12ffULL, + 0xad17df904e64758eULL, 0x60d4ce7d272117e2ULL, 0xef7e4a0ec7fe25ffULL, + 0x5a2fbf209cc8eb1cULL, 0xc1a99cfa4e422fc5ULL, 0xdefc941d8ffc4bffULL, + 0xb45f7e413991d639ULL, 0x835339f49c845f8bULL, 0xbdf9283b1ff897ffULL, + 0x68befc827323ac73ULL, 0x6a673e93908bf17ULL, 0x7bf250763ff12fffULL, + 0xd17df904e64758e6ULL, 0xd4ce7d272117e2eULL, 0xf7e4a0ec7fe25fffULL, + 0xa2fbf209cc8eb1ccULL, 0x1a99cfa4e422fc5dULL, 0xefc941d8ffc4bffeULL, + 0x45f7e413991d6398ULL, 0x35339f49c845f8bbULL, 0xdf9283b1ff897ffdULL, + 0x8befc827323ac730ULL, 0x6a673e93908bf177ULL, 0xbf250763ff12fffbULL, + 0x17df904e64758e60ULL, 0xd4ce7d272117e2efULL, 0x7e4a0ec7fe25fff7ULL, + 0x2fbf209cc8eb1cc1ULL, 0xa99cfa4e422fc5deULL, 0xfc941d8ffc4bffefULL, + 0x5f7e413991d63983ULL, 0x5339f49c845f8bbdULL, 0xf9283b1ff897ffdeULL, + 0xbefc827323ac7306ULL, 0xa673e93908bf177bULL, 0xf250763ff12fffbcULL, + 0x7df904e64758e60dULL, 0x4ce7d272117e2ef7ULL, 0xe4a0ec7fe25fff78ULL, + 0xfbf209cc8eb1cc1aULL, 0x99cfa4e422fc5defULL, 0xc941d8ffc4bffef0ULL, + 0xf7e413991d639835ULL, 0x339f49c845f8bbdfULL, 0x9283b1ff897ffde0ULL, + 0xefc827323ac7306aULL, 0x673e93908bf177bfULL, 0x250763ff12fffbc0ULL, + 0xdf904e64758e60d4ULL, 0xce7d272117e2ef7eULL, 0x4a0ec7fe25fff781ULL, + 0xbf209cc8eb1cc1a9ULL, 0x9cfa4e422fc5defcULL, 0x941d8ffc4bffef02ULL, + 0x7e413991d6398353ULL, 0x39f49c845f8bbdf9ULL, 0x283b1ff897ffde05ULL, + 0xfc827323ac7306a6ULL, 0x73e93908bf177bf2ULL, 0x50763ff12fffbc0bULL, + 0xf904e64758e60d4cULL, 0xe7d272117e2ef7e4ULL, 0xa0ec7fe25fff7816ULL, + 0xf209cc8eb1cc1a99ULL, 0xcfa4e422fc5defc9ULL, 0x41d8ffc4bffef02cULL, + 0xe413991d63983533ULL, 0x9f49c845f8bbdf92ULL, 0x83b1ff897ffde059ULL, + 0xc827323ac7306a67ULL, 0x3e93908bf177bf25ULL, 0x763ff12fffbc0b3ULL, + 0x904e64758e60d4ceULL, 0x7d272117e2ef7e4aULL, 0xec7fe25fff78166ULL, + 0x209cc8eb1cc1a99cULL, 0xfa4e422fc5defc94ULL, 0x1d8ffc4bffef02ccULL, + 0x413991d639835339ULL, 0xf49c845f8bbdf928ULL, 0x3b1ff897ffde0598ULL, + 0x827323ac7306a673ULL, 0xe93908bf177bf250ULL, 0x763ff12fffbc0b30ULL, + 0x4e64758e60d4ce7ULL, 0xd272117e2ef7e4a0ULL, 0xec7fe25fff781660ULL, + 0x9cc8eb1cc1a99cfULL, 0xa4e422fc5defc941ULL, 0xd8ffc4bffef02cc0ULL, + 0x13991d639835339fULL, 0x49c845f8bbdf9283ULL, 0xb1ff897ffde05980ULL, + 0x27323ac7306a673eULL, 0x93908bf177bf2507ULL, 0x63ff12fffbc0b301ULL, + 0x4e64758e60d4ce7dULL, 0x272117e2ef7e4a0eULL, 0xc7fe25fff7816603ULL, + 0x9cc8eb1cc1a99cfaULL, 0x4e422fc5defc941dULL, 0x8ffc4bffef02cc07ULL, + 0x3991d639835339f4ULL, 0x9c845f8bbdf9283bULL, 0x1ff897ffde05980fULL, + 0x7323ac7306a673e9ULL, 0x3908bf177bf25076ULL, 0x3ff12fffbc0b301fULL, + 0xe64758e60d4ce7d2ULL, 0x72117e2ef7e4a0ecULL, 0x7fe25fff7816603fULL, + 0xcc8eb1cc1a99cfa4ULL, 0xe422fc5defc941d8ULL, 0xffc4bffef02cc07fULL, + 0x991d639835339f49ULL, 0xc845f8bbdf9283b1ULL, 0xff897ffde05980feULL, + 0x323ac7306a673e93ULL, 0x908bf177bf250763ULL, 0xff12fffbc0b301fdULL, + 0x64758e60d4ce7d27ULL, 0x2117e2ef7e4a0ec7ULL, 0xfe25fff7816603fbULL, + 0xc8eb1cc1a99cfa4eULL, 0x422fc5defc941d8fULL, 0xfc4bffef02cc07f7ULL, + 0x91d639835339f49cULL, 0x845f8bbdf9283b1fULL, 0xf897ffde05980fefULL, + 0x23ac7306a673e939ULL, 0x8bf177bf250763fULL, 0xf12fffbc0b301fdeULL, + 0x4758e60d4ce7d272ULL, 0x117e2ef7e4a0ec7fULL, 0xe25fff7816603fbcULL, + 0x8eb1cc1a99cfa4e4ULL, 0x22fc5defc941d8ffULL, 0xc4bffef02cc07f79ULL, + 0x1d639835339f49c8ULL, 0x45f8bbdf9283b1ffULL, 0x897ffde05980fef2ULL, + 0x3ac7306a673e9390ULL, 0x8bf177bf250763ffULL, 0x12fffbc0b301fde5ULL, + 0x758e60d4ce7d2721ULL, 0x17e2ef7e4a0ec7feULL, 0x25fff7816603fbcbULL, + 0xeb1cc1a99cfa4e42ULL, 0x2fc5defc941d8ffcULL, 0x4bffef02cc07f797ULL, + 0xd639835339f49c84ULL, 0x5f8bbdf9283b1ff8ULL, 0x97ffde05980fef2fULL, + 0xac7306a673e93908ULL, 0xbf177bf250763ff1ULL, 0x2fffbc0b301fde5eULL, + 0x58e60d4ce7d27211ULL, 0x7e2ef7e4a0ec7fe2ULL, 0x5fff7816603fbcbcULL, + 0xb1cc1a99cfa4e422ULL, 0xfc5defc941d8ffc4ULL, 0xbffef02cc07f7978ULL, + 0x639835339f49c845ULL, 0xf8bbdf9283b1ff89ULL, 0x7ffde05980fef2f1ULL, + 0xc7306a673e93908bULL, 0xf177bf250763ff12ULL, 0xfffbc0b301fde5e2ULL, + 0x8e60d4ce7d272117ULL, 0xe2ef7e4a0ec7fe25ULL, 0xfff7816603fbcbc4ULL, + 0x1cc1a99cfa4e422fULL, 0xc5defc941d8ffc4bULL, 0xffef02cc07f79788ULL, + 0x39835339f49c845fULL, 0x8bbdf9283b1ff897ULL, 0xffde05980fef2f11ULL, + 0x7306a673e93908bfULL, 0x177bf250763ff12fULL, 0xffbc0b301fde5e23ULL, + 0xe60d4ce7d272117eULL, 0x2ef7e4a0ec7fe25fULL, 0xff7816603fbcbc46ULL, + 0xcc1a99cfa4e422fcULL, 0x5defc941d8ffc4bfULL, 0xfef02cc07f79788cULL, + 0x9835339f49c845f8ULL, 0xbbdf9283b1ff897fULL, 0xfde05980fef2f118ULL, + 0x306a673e93908bf1ULL, 0x77bf250763ff12ffULL, 0xfbc0b301fde5e231ULL, + 0x60d4ce7d272117e2ULL, 0xef7e4a0ec7fe25ffULL, 0xf7816603fbcbc462ULL, + 0xc1a99cfa4e422fc5ULL, 0xdefc941d8ffc4bffULL, 0xef02cc07f79788c5ULL, + 0x835339f49c845f8bULL, 0xbdf9283b1ff897ffULL, 0xde05980fef2f118bULL, + 0x6a673e93908bf17ULL, 0x7bf250763ff12fffULL, 0xbc0b301fde5e2316ULL, + 0xd4ce7d272117e2eULL, 0xf7e4a0ec7fe25fffULL, 0x7816603fbcbc462dULL, + 0x1a99cfa4e422fc5dULL, 0xefc941d8ffc4bffeULL, 0xf02cc07f79788c5aULL, + 0x35339f49c845f8bbULL, 0xdf9283b1ff897ffdULL, 0xe05980fef2f118b5ULL, + 0x6a673e93908bf177ULL, 0xbf250763ff12fffbULL, 0xc0b301fde5e2316bULL, + 0xd4ce7d272117e2efULL, 0x7e4a0ec7fe25fff7ULL, 0x816603fbcbc462d6ULL, + 0xa99cfa4e422fc5deULL, 0xfc941d8ffc4bffefULL, 0x2cc07f79788c5adULL, + 0x5339f49c845f8bbdULL, 0xf9283b1ff897ffdeULL, 0x5980fef2f118b5aULL, + 0xa673e93908bf177bULL, 0xf250763ff12fffbcULL, 0xb301fde5e2316b4ULL, + 0x4ce7d272117e2ef7ULL, 0xe4a0ec7fe25fff78ULL, 0x16603fbcbc462d68ULL, + 0x99cfa4e422fc5defULL, 0xc941d8ffc4bffef0ULL, 0x2cc07f79788c5ad0ULL, + 0x339f49c845f8bbdfULL, 0x9283b1ff897ffde0ULL, 0x5980fef2f118b5a0ULL, + 0x673e93908bf177bfULL, 0x250763ff12fffbc0ULL, 0xb301fde5e2316b41ULL, + 0xce7d272117e2ef7eULL, 0x4a0ec7fe25fff781ULL, 0x6603fbcbc462d682ULL, + 0x9cfa4e422fc5defcULL, 0x941d8ffc4bffef02ULL, 0xcc07f79788c5ad05ULL, + 0x39f49c845f8bbdf9ULL, 0x283b1ff897ffde05ULL, 0x980fef2f118b5a0aULL, + 0x73e93908bf177bf2ULL, 0x50763ff12fffbc0bULL, 0x301fde5e2316b414ULL, + 0xe7d272117e2ef7e4ULL, 0xa0ec7fe25fff7816ULL, 0x603fbcbc462d6829ULL, + 0xcfa4e422fc5defc9ULL, 0x41d8ffc4bffef02cULL, 0xc07f79788c5ad053ULL, + 0x9f49c845f8bbdf92ULL, 0x83b1ff897ffde059ULL, 0x80fef2f118b5a0a6ULL, + 0x3e93908bf177bf25ULL, 0x763ff12fffbc0b3ULL, 0x1fde5e2316b414dULL, + 0x7d272117e2ef7e4aULL, 0xec7fe25fff78166ULL, 0x3fbcbc462d6829bULL, + 0xfa4e422fc5defc94ULL, 0x1d8ffc4bffef02ccULL, 0x7f79788c5ad0536ULL, + 0xf49c845f8bbdf928ULL, 0x3b1ff897ffde0598ULL, 0xfef2f118b5a0a6dULL, + 0xe93908bf177bf250ULL, 0x763ff12fffbc0b30ULL, 0x1fde5e2316b414daULL, + 0xd272117e2ef7e4a0ULL, 0xec7fe25fff781660ULL, 0x3fbcbc462d6829b4ULL, + 0xa4e422fc5defc941ULL, 0xd8ffc4bffef02cc0ULL, 0x7f79788c5ad05368ULL, + 0x49c845f8bbdf9283ULL, 0xb1ff897ffde05980ULL, 0xfef2f118b5a0a6d1ULL, + 0x93908bf177bf2507ULL, 0x63ff12fffbc0b301ULL, 0xfde5e2316b414da3ULL, + 0x272117e2ef7e4a0eULL, 0xc7fe25fff7816603ULL, 0xfbcbc462d6829b47ULL, + 0x4e422fc5defc941dULL, 0x8ffc4bffef02cc07ULL, 0xf79788c5ad05368fULL, + 0x9c845f8bbdf9283bULL, 0x1ff897ffde05980fULL, 0xef2f118b5a0a6d1fULL, + 0x3908bf177bf25076ULL, 0x3ff12fffbc0b301fULL, 0xde5e2316b414da3eULL, + 0x72117e2ef7e4a0ecULL, 0x7fe25fff7816603fULL, 0xbcbc462d6829b47dULL, + 0xe422fc5defc941d8ULL, 0xffc4bffef02cc07fULL, 0x79788c5ad05368fbULL, + 0xc845f8bbdf9283b1ULL, 0xff897ffde05980feULL, 0xf2f118b5a0a6d1f6ULL, + 0x908bf177bf250763ULL, 0xff12fffbc0b301fdULL, 0xe5e2316b414da3edULL, + 0x2117e2ef7e4a0ec7ULL, 0xfe25fff7816603fbULL, 0xcbc462d6829b47dbULL, + 0x422fc5defc941d8fULL, 0xfc4bffef02cc07f7ULL, 0x9788c5ad05368fb6ULL, + 0x845f8bbdf9283b1fULL, 0xf897ffde05980fefULL, 0x2f118b5a0a6d1f6dULL, + 0x8bf177bf250763fULL, 0xf12fffbc0b301fdeULL, 0x5e2316b414da3edaULL, + 0x117e2ef7e4a0ec7fULL, 0xe25fff7816603fbcULL, 0xbc462d6829b47db4ULL, + 0x22fc5defc941d8ffULL, 0xc4bffef02cc07f79ULL, 0x788c5ad05368fb69ULL, + 0x45f8bbdf9283b1ffULL, 0x897ffde05980fef2ULL, 0xf118b5a0a6d1f6d3ULL, + 0x8bf177bf250763ffULL, 0x12fffbc0b301fde5ULL, 0xe2316b414da3eda6ULL, + 0x17e2ef7e4a0ec7feULL, 0x25fff7816603fbcbULL, 0xc462d6829b47db4dULL, + 0x2fc5defc941d8ffcULL, 0x4bffef02cc07f797ULL, 0x88c5ad05368fb69bULL, + 0x5f8bbdf9283b1ff8ULL, 0x97ffde05980fef2fULL, 0x118b5a0a6d1f6d36ULL, + 0xbf177bf250763ff1ULL, 0x2fffbc0b301fde5eULL, 0x2316b414da3eda6cULL, + 0x7e2ef7e4a0ec7fe2ULL, 0x5fff7816603fbcbcULL, 0x462d6829b47db4d9ULL, + 0xfc5defc941d8ffc4ULL, 0xbffef02cc07f7978ULL, 0x8c5ad05368fb69b3ULL, + 0xf8bbdf9283b1ff89ULL, 0x7ffde05980fef2f1ULL, 0x18b5a0a6d1f6d367ULL, + 0xf177bf250763ff12ULL, 0xfffbc0b301fde5e2ULL, 0x316b414da3eda6cfULL, + 0xe2ef7e4a0ec7fe25ULL, 0xfff7816603fbcbc4ULL, 0x62d6829b47db4d9fULL, + 0xc5defc941d8ffc4bULL, 0xffef02cc07f79788ULL, 0xc5ad05368fb69b3fULL, + 0x8bbdf9283b1ff897ULL, 0xffde05980fef2f11ULL, 0x8b5a0a6d1f6d367eULL, + 0x177bf250763ff12fULL, 0xffbc0b301fde5e23ULL, 0x16b414da3eda6cfdULL, + 0x2ef7e4a0ec7fe25fULL, 0xff7816603fbcbc46ULL, 0x2d6829b47db4d9fbULL, + 0x5defc941d8ffc4bfULL, 0xfef02cc07f79788cULL, 0x5ad05368fb69b3f6ULL, + 0xbbdf9283b1ff897fULL, 0xfde05980fef2f118ULL, 0xb5a0a6d1f6d367ecULL, + 0x77bf250763ff12ffULL, 0xfbc0b301fde5e231ULL, 0x6b414da3eda6cfd9ULL, + 0xef7e4a0ec7fe25ffULL, 0xf7816603fbcbc462ULL, 0xd6829b47db4d9fb3ULL, + 0xdefc941d8ffc4bffULL, 0xef02cc07f79788c5ULL, 0xad05368fb69b3f67ULL, + 0xbdf9283b1ff897ffULL, 0xde05980fef2f118bULL, 0x5a0a6d1f6d367ecfULL, + 0x7bf250763ff12fffULL, 0xbc0b301fde5e2316ULL, 0xb414da3eda6cfd9eULL, + 0xf7e4a0ec7fe25fffULL, 0x7816603fbcbc462dULL, 0x6829b47db4d9fb3cULL, + 0xefc941d8ffc4bffeULL, 0xf02cc07f79788c5aULL, 0xd05368fb69b3f679ULL, + 0xdf9283b1ff897ffdULL, 0xe05980fef2f118b5ULL, 0xa0a6d1f6d367ecf2ULL, + 0xbf250763ff12fffbULL, 0xc0b301fde5e2316bULL, 0x414da3eda6cfd9e4ULL, + 0x7e4a0ec7fe25fff7ULL, 0x816603fbcbc462d6ULL, 0x829b47db4d9fb3c9ULL, + 0xfc941d8ffc4bffefULL, 0x2cc07f79788c5adULL, 0x5368fb69b3f6793ULL, + 0xf9283b1ff897ffdeULL, 0x5980fef2f118b5aULL, 0xa6d1f6d367ecf27ULL, + 0xf250763ff12fffbcULL, 0xb301fde5e2316b4ULL, 0x14da3eda6cfd9e4fULL, + 0xe4a0ec7fe25fff78ULL, 0x16603fbcbc462d68ULL, 0x29b47db4d9fb3c9fULL, + 0xc941d8ffc4bffef0ULL, 0x2cc07f79788c5ad0ULL, 0x5368fb69b3f6793eULL, + 0x9283b1ff897ffde0ULL, 0x5980fef2f118b5a0ULL, 0xa6d1f6d367ecf27cULL, + 0x250763ff12fffbc0ULL, 0xb301fde5e2316b41ULL, 0x4da3eda6cfd9e4f9ULL, + 0x4a0ec7fe25fff781ULL, 0x6603fbcbc462d682ULL, 0x9b47db4d9fb3c9f2ULL, + 0x941d8ffc4bffef02ULL, 0xcc07f79788c5ad05ULL, 0x368fb69b3f6793e5ULL, + 0x283b1ff897ffde05ULL, 0x980fef2f118b5a0aULL, 0x6d1f6d367ecf27cbULL, + 0x50763ff12fffbc0bULL, 0x301fde5e2316b414ULL, 0xda3eda6cfd9e4f96ULL, + 0xa0ec7fe25fff7816ULL, 0x603fbcbc462d6829ULL, 0xb47db4d9fb3c9f2cULL, + 0x41d8ffc4bffef02cULL, 0xc07f79788c5ad053ULL, 0x68fb69b3f6793e58ULL, + 0x83b1ff897ffde059ULL, 0x80fef2f118b5a0a6ULL, 0xd1f6d367ecf27cb0ULL, + 0x763ff12fffbc0b3ULL, 0x1fde5e2316b414dULL, 0xa3eda6cfd9e4f961ULL, + 0xec7fe25fff78166ULL, 0x3fbcbc462d6829bULL, 0x47db4d9fb3c9f2c2ULL, + 0x1d8ffc4bffef02ccULL, 0x7f79788c5ad0536ULL, 0x8fb69b3f6793e584ULL, + 0x3b1ff897ffde0598ULL, 0xfef2f118b5a0a6dULL, 0x1f6d367ecf27cb09ULL, + 0x763ff12fffbc0b30ULL, 0x1fde5e2316b414daULL, 0x3eda6cfd9e4f9613ULL, + 0xec7fe25fff781660ULL, 0x3fbcbc462d6829b4ULL, 0x7db4d9fb3c9f2c26ULL, + 0xd8ffc4bffef02cc0ULL, 0x7f79788c5ad05368ULL, 0xfb69b3f6793e584dULL, + 0xb1ff897ffde05980ULL, 0xfef2f118b5a0a6d1ULL, 0xf6d367ecf27cb09bULL, + 0x63ff12fffbc0b301ULL, 0xfde5e2316b414da3ULL, 0xeda6cfd9e4f96136ULL, + 0xc7fe25fff7816603ULL, 0xfbcbc462d6829b47ULL, 0xdb4d9fb3c9f2c26dULL, + 0x8ffc4bffef02cc07ULL, 0xf79788c5ad05368fULL, 0xb69b3f6793e584dbULL, + 0x1ff897ffde05980fULL, 0xef2f118b5a0a6d1fULL, 0x6d367ecf27cb09b7ULL, + 0x3ff12fffbc0b301fULL, 0xde5e2316b414da3eULL, 0xda6cfd9e4f96136eULL, + 0x7fe25fff7816603fULL, 0xbcbc462d6829b47dULL, 0xb4d9fb3c9f2c26ddULL, + 0xffc4bffef02cc07fULL, 0x79788c5ad05368fbULL, 0x69b3f6793e584dbaULL, + 0xff897ffde05980feULL, 0xf2f118b5a0a6d1f6ULL, 0xd367ecf27cb09b74ULL, + 0xff12fffbc0b301fdULL, 0xe5e2316b414da3edULL, 0xa6cfd9e4f96136e9ULL, + 0xfe25fff7816603fbULL, 0xcbc462d6829b47dbULL, 0x4d9fb3c9f2c26dd3ULL, + 0xfc4bffef02cc07f7ULL, 0x9788c5ad05368fb6ULL, 0x9b3f6793e584dba7ULL, + 0xf897ffde05980fefULL, 0x2f118b5a0a6d1f6dULL, 0x367ecf27cb09b74fULL, + 0xf12fffbc0b301fdeULL, 0x5e2316b414da3edaULL, 0x6cfd9e4f96136e9eULL, + 0xe25fff7816603fbcULL, 0xbc462d6829b47db4ULL, 0xd9fb3c9f2c26dd3dULL, + 0xc4bffef02cc07f79ULL, 0x788c5ad05368fb69ULL, 0xb3f6793e584dba7aULL, + 0x897ffde05980fef2ULL, 0xf118b5a0a6d1f6d3ULL, 0x67ecf27cb09b74f4ULL, + 0x12fffbc0b301fde5ULL, 0xe2316b414da3eda6ULL, 0xcfd9e4f96136e9e8ULL, + 0x25fff7816603fbcbULL, 0xc462d6829b47db4dULL, 0x9fb3c9f2c26dd3d1ULL, + 0x4bffef02cc07f797ULL, 0x88c5ad05368fb69bULL, 0x3f6793e584dba7a3ULL, + 0x97ffde05980fef2fULL, 0x118b5a0a6d1f6d36ULL, 0x7ecf27cb09b74f46ULL, + 0x2fffbc0b301fde5eULL, 0x2316b414da3eda6cULL, 0xfd9e4f96136e9e8cULL, + 0x5fff7816603fbcbcULL, 0x462d6829b47db4d9ULL, 0xfb3c9f2c26dd3d18ULL, + 0xbffef02cc07f7978ULL, 0x8c5ad05368fb69b3ULL, 0xf6793e584dba7a31ULL, + 0x7ffde05980fef2f1ULL, 0x18b5a0a6d1f6d367ULL, 0xecf27cb09b74f463ULL, + 0xfffbc0b301fde5e2ULL, 0x316b414da3eda6cfULL, 0xd9e4f96136e9e8c7ULL, + 0xfff7816603fbcbc4ULL, 0x62d6829b47db4d9fULL, 0xb3c9f2c26dd3d18fULL, + 0xffef02cc07f79788ULL, 0xc5ad05368fb69b3fULL, 0x6793e584dba7a31fULL, + 0xffde05980fef2f11ULL, 0x8b5a0a6d1f6d367eULL, 0xcf27cb09b74f463fULL, + 0xffbc0b301fde5e23ULL, 0x16b414da3eda6cfdULL, 0x9e4f96136e9e8c7eULL, + 0xff7816603fbcbc46ULL, 0x2d6829b47db4d9fbULL, 0x3c9f2c26dd3d18fdULL, + 0xfef02cc07f79788cULL, 0x5ad05368fb69b3f6ULL, 0x793e584dba7a31fbULL, + 0xfde05980fef2f118ULL, 0xb5a0a6d1f6d367ecULL, 0xf27cb09b74f463f6ULL, + 0xfbc0b301fde5e231ULL, 0x6b414da3eda6cfd9ULL, 0xe4f96136e9e8c7ecULL, + 0xf7816603fbcbc462ULL, 0xd6829b47db4d9fb3ULL, 0xc9f2c26dd3d18fd9ULL, + 0xef02cc07f79788c5ULL, 0xad05368fb69b3f67ULL, 0x93e584dba7a31fb3ULL, + 0xde05980fef2f118bULL, 0x5a0a6d1f6d367ecfULL, 0x27cb09b74f463f66ULL, + 0xbc0b301fde5e2316ULL, 0xb414da3eda6cfd9eULL, 0x4f96136e9e8c7ecdULL, + 0x7816603fbcbc462dULL, 0x6829b47db4d9fb3cULL, 0x9f2c26dd3d18fd9aULL, + 0xf02cc07f79788c5aULL, 0xd05368fb69b3f679ULL, 0x3e584dba7a31fb34ULL, + 0xe05980fef2f118b5ULL, 0xa0a6d1f6d367ecf2ULL, 0x7cb09b74f463f669ULL, + 0xc0b301fde5e2316bULL, 0x414da3eda6cfd9e4ULL, 0xf96136e9e8c7ecd3ULL, + 0x816603fbcbc462d6ULL, 0x829b47db4d9fb3c9ULL, 0xf2c26dd3d18fd9a7ULL, + 0x2cc07f79788c5adULL, 0x5368fb69b3f6793ULL, 0xe584dba7a31fb34fULL, + 0x5980fef2f118b5aULL, 0xa6d1f6d367ecf27ULL, 0xcb09b74f463f669eULL, + 0xb301fde5e2316b4ULL, 0x14da3eda6cfd9e4fULL, 0x96136e9e8c7ecd3cULL, + 0x16603fbcbc462d68ULL, 0x29b47db4d9fb3c9fULL, 0x2c26dd3d18fd9a79ULL, + 0x2cc07f79788c5ad0ULL, 0x5368fb69b3f6793eULL, 0x584dba7a31fb34f2ULL, + 0x5980fef2f118b5a0ULL, 0xa6d1f6d367ecf27cULL, 0xb09b74f463f669e5ULL, + 0xb301fde5e2316b41ULL, 0x4da3eda6cfd9e4f9ULL, 0x6136e9e8c7ecd3cbULL, + 0x6603fbcbc462d682ULL, 0x9b47db4d9fb3c9f2ULL, 0xc26dd3d18fd9a797ULL, + 0xcc07f79788c5ad05ULL, 0x368fb69b3f6793e5ULL, 0x84dba7a31fb34f2fULL, + 0x980fef2f118b5a0aULL, 0x6d1f6d367ecf27cbULL, 0x9b74f463f669e5fULL, + 0x301fde5e2316b414ULL, 0xda3eda6cfd9e4f96ULL, 0x136e9e8c7ecd3cbfULL, + 0x603fbcbc462d6829ULL, 0xb47db4d9fb3c9f2cULL, 0x26dd3d18fd9a797fULL, + 0xc07f79788c5ad053ULL, 0x68fb69b3f6793e58ULL, 0x4dba7a31fb34f2ffULL, + 0x80fef2f118b5a0a6ULL, 0xd1f6d367ecf27cb0ULL, 0x9b74f463f669e5feULL, + 0x1fde5e2316b414dULL, 0xa3eda6cfd9e4f961ULL, 0x36e9e8c7ecd3cbfdULL, + 0x3fbcbc462d6829bULL, 0x47db4d9fb3c9f2c2ULL, 0x6dd3d18fd9a797faULL, + 0x7f79788c5ad0536ULL, 0x8fb69b3f6793e584ULL, 0xdba7a31fb34f2ff5ULL, + 0xfef2f118b5a0a6dULL, 0x1f6d367ecf27cb09ULL, 0xb74f463f669e5feaULL, + 0x1fde5e2316b414daULL, 0x3eda6cfd9e4f9613ULL, 0x6e9e8c7ecd3cbfd4ULL, + 0x3fbcbc462d6829b4ULL, 0x7db4d9fb3c9f2c26ULL, 0xdd3d18fd9a797fa8ULL, + 0x7f79788c5ad05368ULL, 0xfb69b3f6793e584dULL, 0xba7a31fb34f2ff51ULL, + 0xfef2f118b5a0a6d1ULL, 0xf6d367ecf27cb09bULL, 0x74f463f669e5fea2ULL, + 0xfde5e2316b414da3ULL, 0xeda6cfd9e4f96136ULL, 0xe9e8c7ecd3cbfd45ULL, + 0xfbcbc462d6829b47ULL, 0xdb4d9fb3c9f2c26dULL, 0xd3d18fd9a797fa8bULL, + 0xf79788c5ad05368fULL, 0xb69b3f6793e584dbULL, 0xa7a31fb34f2ff516ULL, + 0xef2f118b5a0a6d1fULL, 0x6d367ecf27cb09b7ULL, 0x4f463f669e5fea2dULL, + 0xde5e2316b414da3eULL, 0xda6cfd9e4f96136eULL, 0x9e8c7ecd3cbfd45aULL, + 0xbcbc462d6829b47dULL, 0xb4d9fb3c9f2c26ddULL, 0x3d18fd9a797fa8b5ULL, + 0x79788c5ad05368fbULL, 0x69b3f6793e584dbaULL, 0x7a31fb34f2ff516bULL, + 0xf2f118b5a0a6d1f6ULL, 0xd367ecf27cb09b74ULL, 0xf463f669e5fea2d7ULL, + 0xe5e2316b414da3edULL, 0xa6cfd9e4f96136e9ULL, 0xe8c7ecd3cbfd45aeULL, + 0xcbc462d6829b47dbULL, 0x4d9fb3c9f2c26dd3ULL, 0xd18fd9a797fa8b5dULL, + 0x9788c5ad05368fb6ULL, 0x9b3f6793e584dba7ULL, 0xa31fb34f2ff516baULL, + 0x2f118b5a0a6d1f6dULL, 0x367ecf27cb09b74fULL, 0x463f669e5fea2d75ULL, + 0x5e2316b414da3edaULL, 0x6cfd9e4f96136e9eULL, 0x8c7ecd3cbfd45aeaULL, + 0xbc462d6829b47db4ULL, 0xd9fb3c9f2c26dd3dULL, 0x18fd9a797fa8b5d4ULL, + 0x788c5ad05368fb69ULL, 0xb3f6793e584dba7aULL, 0x31fb34f2ff516ba9ULL, + 0xf118b5a0a6d1f6d3ULL, 0x67ecf27cb09b74f4ULL, 0x63f669e5fea2d752ULL, + 0xe2316b414da3eda6ULL, 0xcfd9e4f96136e9e8ULL, 0xc7ecd3cbfd45aea4ULL, + 0xc462d6829b47db4dULL, 0x9fb3c9f2c26dd3d1ULL, 0x8fd9a797fa8b5d49ULL, + 0x88c5ad05368fb69bULL, 0x3f6793e584dba7a3ULL, 0x1fb34f2ff516ba93ULL, + 0x118b5a0a6d1f6d36ULL, 0x7ecf27cb09b74f46ULL, 0x3f669e5fea2d7527ULL, + 0x2316b414da3eda6cULL, 0xfd9e4f96136e9e8cULL, 0x7ecd3cbfd45aea4fULL, + 0x462d6829b47db4d9ULL, 0xfb3c9f2c26dd3d18ULL, 0xfd9a797fa8b5d49eULL, + 0x8c5ad05368fb69b3ULL, 0xf6793e584dba7a31ULL, 0xfb34f2ff516ba93dULL, + 0x18b5a0a6d1f6d367ULL, 0xecf27cb09b74f463ULL, 0xf669e5fea2d7527bULL, + 0x316b414da3eda6cfULL, 0xd9e4f96136e9e8c7ULL, 0xecd3cbfd45aea4f7ULL, + 0x62d6829b47db4d9fULL, 0xb3c9f2c26dd3d18fULL, 0xd9a797fa8b5d49eeULL, + 0xc5ad05368fb69b3fULL, 0x6793e584dba7a31fULL, 0xb34f2ff516ba93ddULL, + 0x8b5a0a6d1f6d367eULL, 0xcf27cb09b74f463fULL, 0x669e5fea2d7527baULL, + 0x16b414da3eda6cfdULL, 0x9e4f96136e9e8c7eULL, 0xcd3cbfd45aea4f75ULL, + 0x2d6829b47db4d9fbULL, 0x3c9f2c26dd3d18fdULL, 0x9a797fa8b5d49eebULL, + 0x5ad05368fb69b3f6ULL, 0x793e584dba7a31fbULL, 0x34f2ff516ba93dd6ULL, + 0xb5a0a6d1f6d367ecULL, 0xf27cb09b74f463f6ULL, 0x69e5fea2d7527bacULL, + 0x6b414da3eda6cfd9ULL, 0xe4f96136e9e8c7ecULL, 0xd3cbfd45aea4f758ULL, + 0xd6829b47db4d9fb3ULL, 0xc9f2c26dd3d18fd9ULL, 0xa797fa8b5d49eeb1ULL, + 0xad05368fb69b3f67ULL, 0x93e584dba7a31fb3ULL, 0x4f2ff516ba93dd63ULL, + 0x5a0a6d1f6d367ecfULL, 0x27cb09b74f463f66ULL, 0x9e5fea2d7527bac7ULL, + 0xb414da3eda6cfd9eULL, 0x4f96136e9e8c7ecdULL, 0x3cbfd45aea4f758fULL, + 0x6829b47db4d9fb3cULL, 0x9f2c26dd3d18fd9aULL, 0x797fa8b5d49eeb1fULL, + 0xd05368fb69b3f679ULL, 0x3e584dba7a31fb34ULL, 0xf2ff516ba93dd63fULL, + 0xa0a6d1f6d367ecf2ULL, 0x7cb09b74f463f669ULL, 0xe5fea2d7527bac7eULL, + 0x414da3eda6cfd9e4ULL, 0xf96136e9e8c7ecd3ULL, 0xcbfd45aea4f758fdULL, + 0x829b47db4d9fb3c9ULL, 0xf2c26dd3d18fd9a7ULL, 0x97fa8b5d49eeb1faULL, + 0x5368fb69b3f6793ULL, 0xe584dba7a31fb34fULL, 0x2ff516ba93dd63f5ULL, + 0xa6d1f6d367ecf27ULL, 0xcb09b74f463f669eULL, 0x5fea2d7527bac7ebULL, + 0x14da3eda6cfd9e4fULL, 0x96136e9e8c7ecd3cULL, 0xbfd45aea4f758fd7ULL, + 0x29b47db4d9fb3c9fULL, 0x2c26dd3d18fd9a79ULL, 0x7fa8b5d49eeb1fafULL, + 0x5368fb69b3f6793eULL, 0x584dba7a31fb34f2ULL, 0xff516ba93dd63f5fULL, + 0xa6d1f6d367ecf27cULL, 0xb09b74f463f669e5ULL, 0xfea2d7527bac7ebeULL, + 0x4da3eda6cfd9e4f9ULL, 0x6136e9e8c7ecd3cbULL, 0xfd45aea4f758fd7cULL, + 0x9b47db4d9fb3c9f2ULL, 0xc26dd3d18fd9a797ULL, 0xfa8b5d49eeb1faf9ULL, + 0x368fb69b3f6793e5ULL, 0x84dba7a31fb34f2fULL, 0xf516ba93dd63f5f2ULL, + 0x6d1f6d367ecf27cbULL, 0x9b74f463f669e5fULL, 0xea2d7527bac7ebe5ULL, + 0xda3eda6cfd9e4f96ULL, 0x136e9e8c7ecd3cbfULL, 0xd45aea4f758fd7cbULL, + 0xb47db4d9fb3c9f2cULL, 0x26dd3d18fd9a797fULL, 0xa8b5d49eeb1faf97ULL, + 0x68fb69b3f6793e58ULL, 0x4dba7a31fb34f2ffULL, 0x516ba93dd63f5f2fULL, + 0xd1f6d367ecf27cb0ULL, 0x9b74f463f669e5feULL, 0xa2d7527bac7ebe5fULL, + 0xa3eda6cfd9e4f961ULL, 0x36e9e8c7ecd3cbfdULL, 0x45aea4f758fd7cbeULL, + 0x47db4d9fb3c9f2c2ULL, 0x6dd3d18fd9a797faULL, 0x8b5d49eeb1faf97cULL, + 0x8fb69b3f6793e584ULL, 0xdba7a31fb34f2ff5ULL, 0x16ba93dd63f5f2f8ULL, + 0x1f6d367ecf27cb09ULL, 0xb74f463f669e5feaULL, 0x2d7527bac7ebe5f1ULL, + 0x3eda6cfd9e4f9613ULL, 0x6e9e8c7ecd3cbfd4ULL, 0x5aea4f758fd7cbe2ULL, + 0x7db4d9fb3c9f2c26ULL, 0xdd3d18fd9a797fa8ULL, 0xb5d49eeb1faf97c5ULL, + 0xfb69b3f6793e584dULL, 0xba7a31fb34f2ff51ULL, 0x6ba93dd63f5f2f8bULL, + 0xf6d367ecf27cb09bULL, 0x74f463f669e5fea2ULL, 0xd7527bac7ebe5f17ULL, + 0xeda6cfd9e4f96136ULL, 0xe9e8c7ecd3cbfd45ULL, 0xaea4f758fd7cbe2fULL, + 0xdb4d9fb3c9f2c26dULL, 0xd3d18fd9a797fa8bULL, 0x5d49eeb1faf97c5eULL, + 0xb69b3f6793e584dbULL, 0xa7a31fb34f2ff516ULL, 0xba93dd63f5f2f8bdULL, + 0x6d367ecf27cb09b7ULL, 0x4f463f669e5fea2dULL, 0x7527bac7ebe5f17bULL, + 0xda6cfd9e4f96136eULL, 0x9e8c7ecd3cbfd45aULL, 0xea4f758fd7cbe2f6ULL, + 0xb4d9fb3c9f2c26ddULL, 0x3d18fd9a797fa8b5ULL, 0xd49eeb1faf97c5ecULL, + 0x69b3f6793e584dbaULL, 0x7a31fb34f2ff516bULL, 0xa93dd63f5f2f8bd9ULL, + 0xd367ecf27cb09b74ULL, 0xf463f669e5fea2d7ULL, 0x527bac7ebe5f17b3ULL, + 0xa6cfd9e4f96136e9ULL, 0xe8c7ecd3cbfd45aeULL, 0xa4f758fd7cbe2f67ULL, + 0x4d9fb3c9f2c26dd3ULL, 0xd18fd9a797fa8b5dULL, 0x49eeb1faf97c5ecfULL, + 0x9b3f6793e584dba7ULL, 0xa31fb34f2ff516baULL, 0x93dd63f5f2f8bd9eULL, + 0x367ecf27cb09b74fULL, 0x463f669e5fea2d75ULL, 0x27bac7ebe5f17b3dULL, + 0x6cfd9e4f96136e9eULL, 0x8c7ecd3cbfd45aeaULL, 0x4f758fd7cbe2f67aULL, + 0xd9fb3c9f2c26dd3dULL, 0x18fd9a797fa8b5d4ULL, 0x9eeb1faf97c5ecf4ULL, + 0xb3f6793e584dba7aULL, 0x31fb34f2ff516ba9ULL, 0x3dd63f5f2f8bd9e8ULL, + 0x67ecf27cb09b74f4ULL, 0x63f669e5fea2d752ULL, 0x7bac7ebe5f17b3d0ULL, + 0xcfd9e4f96136e9e8ULL, 0xc7ecd3cbfd45aea4ULL, 0xf758fd7cbe2f67a0ULL, + 0x9fb3c9f2c26dd3d1ULL, 0x8fd9a797fa8b5d49ULL, 0xeeb1faf97c5ecf41ULL, + 0x3f6793e584dba7a3ULL, 0x1fb34f2ff516ba93ULL, 0xdd63f5f2f8bd9e83ULL, + 0x7ecf27cb09b74f46ULL, 0x3f669e5fea2d7527ULL, 0xbac7ebe5f17b3d07ULL, + 0xfd9e4f96136e9e8cULL, 0x7ecd3cbfd45aea4fULL, 0x758fd7cbe2f67a0eULL, + 0xfb3c9f2c26dd3d18ULL, 0xfd9a797fa8b5d49eULL, 0xeb1faf97c5ecf41cULL, + 0xf6793e584dba7a31ULL, 0xfb34f2ff516ba93dULL, 0xd63f5f2f8bd9e839ULL, + 0xecf27cb09b74f463ULL, 0xf669e5fea2d7527bULL, 0xac7ebe5f17b3d073ULL, + 0xd9e4f96136e9e8c7ULL, 0xecd3cbfd45aea4f7ULL, 0x58fd7cbe2f67a0e7ULL, + 0xb3c9f2c26dd3d18fULL, 0xd9a797fa8b5d49eeULL, 0xb1faf97c5ecf41ceULL, + 0x6793e584dba7a31fULL, 0xb34f2ff516ba93ddULL, 0x63f5f2f8bd9e839cULL, + 0xcf27cb09b74f463fULL, 0x669e5fea2d7527baULL, 0xc7ebe5f17b3d0739ULL, + 0x9e4f96136e9e8c7eULL, 0xcd3cbfd45aea4f75ULL, 0x8fd7cbe2f67a0e73ULL, + 0x3c9f2c26dd3d18fdULL, 0x9a797fa8b5d49eebULL, 0x1faf97c5ecf41ce7ULL, + 0x793e584dba7a31fbULL, 0x34f2ff516ba93dd6ULL, 0x3f5f2f8bd9e839cfULL, + 0xf27cb09b74f463f6ULL, 0x69e5fea2d7527bacULL, 0x7ebe5f17b3d0739fULL, + 0xe4f96136e9e8c7ecULL, 0xd3cbfd45aea4f758ULL, 0xfd7cbe2f67a0e73eULL, + 0xc9f2c26dd3d18fd9ULL, 0xa797fa8b5d49eeb1ULL, 0xfaf97c5ecf41ce7dULL, + 0x93e584dba7a31fb3ULL, 0x4f2ff516ba93dd63ULL, 0xf5f2f8bd9e839cfbULL, + 0x27cb09b74f463f66ULL, 0x9e5fea2d7527bac7ULL, 0xebe5f17b3d0739f7ULL, + 0x4f96136e9e8c7ecdULL, 0x3cbfd45aea4f758fULL, 0xd7cbe2f67a0e73efULL, + 0x9f2c26dd3d18fd9aULL, 0x797fa8b5d49eeb1fULL, 0xaf97c5ecf41ce7deULL, + 0x3e584dba7a31fb34ULL, 0xf2ff516ba93dd63fULL, 0x5f2f8bd9e839cfbcULL, + 0x7cb09b74f463f669ULL, 0xe5fea2d7527bac7eULL, 0xbe5f17b3d0739f78ULL, + 0xf96136e9e8c7ecd3ULL, 0xcbfd45aea4f758fdULL, 0x7cbe2f67a0e73ef1ULL, + 0xf2c26dd3d18fd9a7ULL, 0x97fa8b5d49eeb1faULL, 0xf97c5ecf41ce7de2ULL, + 0xe584dba7a31fb34fULL, 0x2ff516ba93dd63f5ULL, 0xf2f8bd9e839cfbc5ULL, + 0xcb09b74f463f669eULL, 0x5fea2d7527bac7ebULL, 0xe5f17b3d0739f78aULL, + 0x96136e9e8c7ecd3cULL, 0xbfd45aea4f758fd7ULL, 0xcbe2f67a0e73ef14ULL, + 0x2c26dd3d18fd9a79ULL, 0x7fa8b5d49eeb1fafULL, 0x97c5ecf41ce7de29ULL, + 0x584dba7a31fb34f2ULL, 0xff516ba93dd63f5fULL, 0x2f8bd9e839cfbc52ULL, + 0xb09b74f463f669e5ULL, 0xfea2d7527bac7ebeULL, 0x5f17b3d0739f78a5ULL, + 0x6136e9e8c7ecd3cbULL, 0xfd45aea4f758fd7cULL, 0xbe2f67a0e73ef14aULL, + 0xc26dd3d18fd9a797ULL, 0xfa8b5d49eeb1faf9ULL, 0x7c5ecf41ce7de294ULL, + 0x84dba7a31fb34f2fULL, 0xf516ba93dd63f5f2ULL, 0xf8bd9e839cfbc529ULL, + 0x9b74f463f669e5fULL, 0xea2d7527bac7ebe5ULL, 0xf17b3d0739f78a52ULL, + 0x136e9e8c7ecd3cbfULL, 0xd45aea4f758fd7cbULL, 0xe2f67a0e73ef14a5ULL, + 0x26dd3d18fd9a797fULL, 0xa8b5d49eeb1faf97ULL, 0xc5ecf41ce7de294aULL, + 0x4dba7a31fb34f2ffULL, 0x516ba93dd63f5f2fULL, 0x8bd9e839cfbc5294ULL, + 0x9b74f463f669e5feULL, 0xa2d7527bac7ebe5fULL, 0x17b3d0739f78a529ULL, + 0x36e9e8c7ecd3cbfdULL, 0x45aea4f758fd7cbeULL, 0x2f67a0e73ef14a52ULL, + 0x6dd3d18fd9a797faULL, 0x8b5d49eeb1faf97cULL, 0x5ecf41ce7de294a4ULL, + 0xdba7a31fb34f2ff5ULL, 0x16ba93dd63f5f2f8ULL, 0xbd9e839cfbc52949ULL, + 0xb74f463f669e5feaULL, 0x2d7527bac7ebe5f1ULL, 0x7b3d0739f78a5292ULL, + 0x6e9e8c7ecd3cbfd4ULL, 0x5aea4f758fd7cbe2ULL, 0xf67a0e73ef14a525ULL, + 0xdd3d18fd9a797fa8ULL, 0xb5d49eeb1faf97c5ULL, 0xecf41ce7de294a4bULL, + 0xba7a31fb34f2ff51ULL, 0x6ba93dd63f5f2f8bULL, 0xd9e839cfbc529497ULL, + 0x74f463f669e5fea2ULL, 0xd7527bac7ebe5f17ULL, 0xb3d0739f78a5292eULL, + 0xe9e8c7ecd3cbfd45ULL, 0xaea4f758fd7cbe2fULL, 0x67a0e73ef14a525dULL, + 0xd3d18fd9a797fa8bULL, 0x5d49eeb1faf97c5eULL, 0xcf41ce7de294a4baULL, + 0xa7a31fb34f2ff516ULL, 0xba93dd63f5f2f8bdULL, 0x9e839cfbc5294975ULL, + 0x4f463f669e5fea2dULL, 0x7527bac7ebe5f17bULL, 0x3d0739f78a5292eaULL, + 0x9e8c7ecd3cbfd45aULL, 0xea4f758fd7cbe2f6ULL, 0x7a0e73ef14a525d4ULL, + 0x3d18fd9a797fa8b5ULL, 0xd49eeb1faf97c5ecULL, 0xf41ce7de294a4ba9ULL, + 0x7a31fb34f2ff516bULL, 0xa93dd63f5f2f8bd9ULL, 0xe839cfbc52949753ULL, + 0xf463f669e5fea2d7ULL, 0x527bac7ebe5f17b3ULL, 0xd0739f78a5292ea6ULL, + 0xe8c7ecd3cbfd45aeULL, 0xa4f758fd7cbe2f67ULL, 0xa0e73ef14a525d4dULL, + 0xd18fd9a797fa8b5dULL, 0x49eeb1faf97c5ecfULL, 0x41ce7de294a4ba9aULL, + 0xa31fb34f2ff516baULL, 0x93dd63f5f2f8bd9eULL, 0x839cfbc529497535ULL, + 0x463f669e5fea2d75ULL, 0x27bac7ebe5f17b3dULL, 0x739f78a5292ea6bULL, + 0x8c7ecd3cbfd45aeaULL, 0x4f758fd7cbe2f67aULL, 0xe73ef14a525d4d7ULL, + 0x18fd9a797fa8b5d4ULL, 0x9eeb1faf97c5ecf4ULL, 0x1ce7de294a4ba9afULL, + 0x31fb34f2ff516ba9ULL, 0x3dd63f5f2f8bd9e8ULL, 0x39cfbc529497535fULL, + 0x63f669e5fea2d752ULL, 0x7bac7ebe5f17b3d0ULL, 0x739f78a5292ea6bfULL, + 0xc7ecd3cbfd45aea4ULL, 0xf758fd7cbe2f67a0ULL, 0xe73ef14a525d4d7fULL, + 0x8fd9a797fa8b5d49ULL, 0xeeb1faf97c5ecf41ULL, 0xce7de294a4ba9afeULL, + 0x1fb34f2ff516ba93ULL, 0xdd63f5f2f8bd9e83ULL, 0x9cfbc529497535fdULL, + 0x3f669e5fea2d7527ULL, 0xbac7ebe5f17b3d07ULL, 0x39f78a5292ea6bfbULL, + 0x7ecd3cbfd45aea4fULL, 0x758fd7cbe2f67a0eULL, 0x73ef14a525d4d7f6ULL, + 0xfd9a797fa8b5d49eULL, 0xeb1faf97c5ecf41cULL, 0xe7de294a4ba9afedULL, + 0xfb34f2ff516ba93dULL, 0xd63f5f2f8bd9e839ULL, 0xcfbc529497535fdaULL, + 0xf669e5fea2d7527bULL, 0xac7ebe5f17b3d073ULL, 0x9f78a5292ea6bfb5ULL, + 0xecd3cbfd45aea4f7ULL, 0x58fd7cbe2f67a0e7ULL, 0x3ef14a525d4d7f6bULL, + 0xd9a797fa8b5d49eeULL, 0xb1faf97c5ecf41ceULL, 0x7de294a4ba9afed7ULL, + 0xb34f2ff516ba93ddULL, 0x63f5f2f8bd9e839cULL, 0xfbc529497535fdafULL, + 0x669e5fea2d7527baULL, 0xc7ebe5f17b3d0739ULL, 0xf78a5292ea6bfb5fULL, + 0xcd3cbfd45aea4f75ULL, 0x8fd7cbe2f67a0e73ULL, 0xef14a525d4d7f6bfULL, + 0x9a797fa8b5d49eebULL, 0x1faf97c5ecf41ce7ULL, 0xde294a4ba9afed7eULL, + 0x34f2ff516ba93dd6ULL, 0x3f5f2f8bd9e839cfULL, 0xbc529497535fdafdULL, + 0x69e5fea2d7527bacULL, 0x7ebe5f17b3d0739fULL, 0x78a5292ea6bfb5fbULL, + 0xd3cbfd45aea4f758ULL, 0xfd7cbe2f67a0e73eULL, 0xf14a525d4d7f6bf6ULL, + 0xa797fa8b5d49eeb1ULL, 0xfaf97c5ecf41ce7dULL, 0xe294a4ba9afed7ecULL, + 0x4f2ff516ba93dd63ULL, 0xf5f2f8bd9e839cfbULL, 0xc529497535fdafd8ULL, + 0x9e5fea2d7527bac7ULL, 0xebe5f17b3d0739f7ULL, 0x8a5292ea6bfb5fb1ULL, + 0x3cbfd45aea4f758fULL, 0xd7cbe2f67a0e73efULL, 0x14a525d4d7f6bf62ULL, + 0x797fa8b5d49eeb1fULL, 0xaf97c5ecf41ce7deULL, 0x294a4ba9afed7ec4ULL, + 0xf2ff516ba93dd63fULL, 0x5f2f8bd9e839cfbcULL, 0x529497535fdafd88ULL, + 0xe5fea2d7527bac7eULL, 0xbe5f17b3d0739f78ULL, 0xa5292ea6bfb5fb11ULL, + 0xcbfd45aea4f758fdULL, 0x7cbe2f67a0e73ef1ULL, 0x4a525d4d7f6bf623ULL, + 0x97fa8b5d49eeb1faULL, 0xf97c5ecf41ce7de2ULL, 0x94a4ba9afed7ec47ULL, + 0x2ff516ba93dd63f5ULL, 0xf2f8bd9e839cfbc5ULL, 0x29497535fdafd88fULL, + 0x5fea2d7527bac7ebULL, 0xe5f17b3d0739f78aULL, 0x5292ea6bfb5fb11fULL, + 0xbfd45aea4f758fd7ULL, 0xcbe2f67a0e73ef14ULL, 0xa525d4d7f6bf623fULL, + 0x7fa8b5d49eeb1fafULL, 0x97c5ecf41ce7de29ULL, 0x4a4ba9afed7ec47eULL, + 0xff516ba93dd63f5fULL, 0x2f8bd9e839cfbc52ULL, 0x9497535fdafd88fcULL, + 0xfea2d7527bac7ebeULL, 0x5f17b3d0739f78a5ULL, 0x292ea6bfb5fb11f8ULL, + 0xfd45aea4f758fd7cULL, 0xbe2f67a0e73ef14aULL, 0x525d4d7f6bf623f1ULL, + 0xfa8b5d49eeb1faf9ULL, 0x7c5ecf41ce7de294ULL, 0xa4ba9afed7ec47e3ULL, + 0xf516ba93dd63f5f2ULL, 0xf8bd9e839cfbc529ULL, 0x497535fdafd88fc6ULL, + 0xea2d7527bac7ebe5ULL, 0xf17b3d0739f78a52ULL, 0x92ea6bfb5fb11f8dULL, + 0xd45aea4f758fd7cbULL, 0xe2f67a0e73ef14a5ULL, 0x25d4d7f6bf623f1aULL, + 0xa8b5d49eeb1faf97ULL, 0xc5ecf41ce7de294aULL, 0x4ba9afed7ec47e35ULL, + 0x516ba93dd63f5f2fULL, 0x8bd9e839cfbc5294ULL, 0x97535fdafd88fc6aULL, + 0xa2d7527bac7ebe5fULL, 0x17b3d0739f78a529ULL, 0x2ea6bfb5fb11f8d5ULL, + 0x45aea4f758fd7cbeULL, 0x2f67a0e73ef14a52ULL, 0x5d4d7f6bf623f1abULL, + 0x8b5d49eeb1faf97cULL, 0x5ecf41ce7de294a4ULL, 0xba9afed7ec47e357ULL, + 0x16ba93dd63f5f2f8ULL, 0xbd9e839cfbc52949ULL, 0x7535fdafd88fc6aeULL, + 0x2d7527bac7ebe5f1ULL, 0x7b3d0739f78a5292ULL, 0xea6bfb5fb11f8d5dULL, + 0x5aea4f758fd7cbe2ULL, 0xf67a0e73ef14a525ULL, 0xd4d7f6bf623f1abaULL, + 0xb5d49eeb1faf97c5ULL, 0xecf41ce7de294a4bULL, 0xa9afed7ec47e3574ULL, + 0x6ba93dd63f5f2f8bULL, 0xd9e839cfbc529497ULL, 0x535fdafd88fc6ae8ULL, + 0xd7527bac7ebe5f17ULL, 0xb3d0739f78a5292eULL, 0xa6bfb5fb11f8d5d0ULL, + 0xaea4f758fd7cbe2fULL, 0x67a0e73ef14a525dULL, 0x4d7f6bf623f1aba1ULL, + 0x5d49eeb1faf97c5eULL, 0xcf41ce7de294a4baULL, 0x9afed7ec47e35742ULL, + 0xba93dd63f5f2f8bdULL, 0x9e839cfbc5294975ULL, 0x35fdafd88fc6ae84ULL, + 0x7527bac7ebe5f17bULL, 0x3d0739f78a5292eaULL, 0x6bfb5fb11f8d5d08ULL, + 0xea4f758fd7cbe2f6ULL, 0x7a0e73ef14a525d4ULL, 0xd7f6bf623f1aba10ULL, + 0xd49eeb1faf97c5ecULL, 0xf41ce7de294a4ba9ULL, 0xafed7ec47e357421ULL, + 0xa93dd63f5f2f8bd9ULL, 0xe839cfbc52949753ULL, 0x5fdafd88fc6ae842ULL, + 0x527bac7ebe5f17b3ULL, 0xd0739f78a5292ea6ULL, 0xbfb5fb11f8d5d085ULL, + 0xa4f758fd7cbe2f67ULL, 0xa0e73ef14a525d4dULL, 0x7f6bf623f1aba10aULL, + 0x49eeb1faf97c5ecfULL, 0x41ce7de294a4ba9aULL, 0xfed7ec47e3574215ULL, + 0x93dd63f5f2f8bd9eULL, 0x839cfbc529497535ULL, 0xfdafd88fc6ae842bULL, + 0x27bac7ebe5f17b3dULL, 0x739f78a5292ea6bULL, 0xfb5fb11f8d5d0856ULL, + 0x4f758fd7cbe2f67aULL, 0xe73ef14a525d4d7ULL, 0xf6bf623f1aba10acULL, + 0x9eeb1faf97c5ecf4ULL, 0x1ce7de294a4ba9afULL, 0xed7ec47e35742158ULL, +}; +}} // namespace {namespace} +#endif // NPSR_TRIG_DATA_LARGE_REDUCTION_H_PY diff --git a/npsr/trig/data/large-reduction.h.py b/npsr/trig/data/large-reduction.h.py new file mode 100644 index 0000000..6bb051b --- /dev/null +++ b/npsr/trig/data/large-reduction.h.py @@ -0,0 +1,51 @@ +#!/usr/bin/env python3 +""" +Precompute int(2^exp × 4/π) with ~96-bit precision (f32) or ~192-bit precision (f64) +and split them into three chunks: 32-bit chunks for single precision, 64-bit chunks for double precision. + +This generates a lookup table for large range reduction in trigonometric functions. +The table is used to compute mantissa × (2^exp × 4/π) using wider integer multiplications for precision: +- f32: 16×16 → 32-bit multiplications +- f64: 32×32 → 64-bit multiplications + +For input x = mantissa × 2^exp, the algorithm becomes: +x × 4/π = mantissa × table_lookup[exp], providing high precision without floating-point errors. + +Args: + float_size: 32 for f32 or 64 for f64 +""" +from generator import c_array, c_header, sollya + + +def gen_reduction(float_size=64): + exp = (1 << (8 if float_size == 32 else 11)) - 1 + offset = 70 if float_size == 32 else 137 + bias = exp >> 1 + sol = f""" + prec = {bias + offset + 1}; + four_over_pi = 4 / pi; + for e from 0 to {exp} do {{ + e_shift = e - {bias} + {offset}; + floor(four_over_pi * (2^e_shift)); + }}; + """ + ints = sollya(sol, as_int=10) + chunk_mask = (1 << float_size) - 1 + chunks = [ + hex((i >> shift) & chunk_mask) + for i in ints + for shift in [float_size * 2, float_size, 0] + ] + return chunks + + +print( + c_header( + "template constexpr T kLargeReductionTable[] = {};", + "template <> constexpr uint32_t kLargeReductionTable[] = " + + c_array(gen_reduction(32), col=3, sfx="U"), + "template <> constexpr uint64_t kLargeReductionTable[] = " + + c_array(gen_reduction(64), col=3, sfx="ULL"), + namespace="npsr::trig::data", + ) +) diff --git a/npsr/trig/data/small.h b/npsr/trig/data/small.h new file mode 100644 index 0000000..e94e130 --- /dev/null +++ b/npsr/trig/data/small.h @@ -0,0 +1,25 @@ +// Do not edit this file, it is generated by npsr/trig/data/small.h.py +// use `spin generate -f` to force regeneration +#ifndef NPSR_TRIG_DATA_SMALL_H_PY +#define NPSR_TRIG_DATA_SMALL_H_PY +namespace npsr::trig::data { namespace { +constexpr double kHiSinKPi16Table[] ={ + 0, 0x1.8f8b83c69a60bp-3, 0x1.87de2a6aea963p-2, 0x1.1c73b39ae68c8p-1, + 0x1.6a09e667f3bcdp-1, 0x1.a9b66290ea1a3p-1, 0x1.d906bcf328d46p-1, 0x1.f6297cff75cbp-1, + 0x1p0, 0x1.f6297cff75cbp-1, 0x1.d906bcf328d46p-1, 0x1.a9b66290ea1a3p-1, + 0x1.6a09e667f3bcdp-1, 0x1.1c73b39ae68c8p-1, 0x1.87de2a6aea963p-2, 0x1.8f8b83c69a60bp-3, +}; +constexpr double kHiCosKPi16Table[] ={ + 0x1p0, 0x1.f6297cff75cbp-1, 0x1.d906bcf328d46p-1, 0x1.a9b66290ea1a3p-1, + 0x1.6a09e667f3bcdp-1, 0x1.1c73b39ae68c8p-1, 0x1.87de2a6aea963p-2, 0x1.8f8b83c69a60bp-3, + 0, -0x1.8f8b83c69a60bp-3, -0x1.87de2a6aea963p-2, -0x1.1c73b39ae68c8p-1, + -0x1.6a09e667f3bcdp-1, -0x1.a9b66290ea1a3p-1, -0x1.d906bcf328d46p-1, -0x1.f6297cff75cbp-1, +}; +constexpr double kPackedLowSinCosKPi16Table[] ={ + 0, 0x1.56217bc626d19p-56, 0x1.457e6bc672cedp-56, 0x1.9f6303c8b25ddp-60, + -0x1.bdd34bc8bdd34p-55, 0x1.b25dd3c39f63p-55, -0x1.72ced3c7457e6p-57, -0x1.26d193c756217p-57, + 0, 0x1.26d193c756217p-57, 0x1.72ced3c7457e6p-57, -0x1.b25dd3c39f63p-55, + 0x1.bdd34bc8bdd34p-55, -0x1.9f6303c8b25ddp-60, -0x1.457e6bc672cedp-56, -0x1.56217bc626d19p-56, +}; +}} // namespace {namespace} +#endif // NPSR_TRIG_DATA_SMALL_H_PY diff --git a/npsr/trig/data/small.h.py b/npsr/trig/data/small.h.py new file mode 100644 index 0000000..de28d04 --- /dev/null +++ b/npsr/trig/data/small.h.py @@ -0,0 +1,64 @@ +from generator import c_array, c_header, sollya + + +def gen_kpi16(float_size, func): + cast = "single" if float_size == 32 else "double" + return sollya( + f""" + prec = {float_size*3}; + display = hexadecimal; + cast = {cast}(x); + func = {func}(x); + pi16 = pi / 16; + for k from 0 to 15 do {{ + cast(func(k * pi16)); + }}; + """ + ) + + +def gen_pack_func(clo, slo): + combined = (clo & 0xFFFFFFFF00000000) | ((slo >> 32) & 0xFFFFFFFF) + return f"0x{combined:016x}" + + +def gen_kpi16_low_pack(): + ints = sollya( + f""" + prec = {64*3}; + display = hexadecimal; + pi16 = pi / 16; + for k from 0 to 15 do {{ + shi = double(sin(k * pi16)); + chi = double(cos(k * pi16)); + slo = double(sin(k * pi16) - shi); + clo = double(cos(k * pi16) - chi); + printdouble(clo); + printdouble(slo); + }}; + """, + as_int=0x10, + ) + packed = [gen_pack_func(clo, slo) for clo, slo in zip(ints[::2], ints[1::2])] + ints = sollya( + f""" + prec = {64*3}; + display = hexadecimal; + packed = [|{','.join(packed)}|]; + for k from 0 to 15 do {{ + double(packed[k]); + }}; + """ + ) + return ints + + +print( + c_header( + "constexpr double kHiSinKPi16Table[] =" + c_array(gen_kpi16(64, "sin"), col=4), + "constexpr double kHiCosKPi16Table[] =" + c_array(gen_kpi16(64, "cos"), col=4), + "constexpr double kPackedLowSinCosKPi16Table[] =" + + c_array(gen_kpi16_low_pack(), col=4), + namespace="npsr::trig::data", + ) +) diff --git a/npsr/trig/lut-inl.h b/npsr/trig/lut-inl.h deleted file mode 100644 index 67b52f8..0000000 --- a/npsr/trig/lut-inl.h +++ /dev/null @@ -1,25437 +0,0 @@ -// auto generated by npsr/sincos/lut-inl.h.py -#include -#if defined(NPSR_TRIG_LUT_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT -#ifdef NPSR_TRIG_LUT_INL_H_ -#undef NPSR_TRIG_LUT_INL_H_ -#else -#define NPSR_TRIG_LUT_INL_H_ -#endif - -HWY_BEFORE_NAMESPACE(); - -namespace npsr::HWY_NAMESPACE::sincos { -HWY_API void DummySupressUnusedTargetWarn(); - - -template constexpr T kLargeReductionTable[] = {}; -template constexpr T kSinApproxTable[] = {}; -template constexpr T kCosApproxTable[] = {}; -template constexpr T kHiSinKPi16Table[] = {}; -template constexpr T kHiCosKPi16Table[] = {}; -template constexpr T kPackedLowSinCosKPi16Table[] = {}; - -template <> HWY_ALIGN constexpr double kHiSinKPi16Table[] = { -0, -0x1.8f8b83c69a60bp-3, -0x1.87de2a6aea963p-2, -0x1.1c73b39ae68c8p-1, -0x1.6a09e667f3bcdp-1, -0x1.a9b66290ea1a3p-1, -0x1.d906bcf328d46p-1, -0x1.f6297cff75cbp-1, -0x1p0, -0x1.f6297cff75cbp-1, -0x1.d906bcf328d46p-1, -0x1.a9b66290ea1a3p-1, -0x1.6a09e667f3bcdp-1, -0x1.1c73b39ae68c8p-1, -0x1.87de2a6aea963p-2, -0x1.8f8b83c69a60bp-3 -}; -template <> HWY_ALIGN constexpr double kHiCosKPi16Table[] = { -0x1p0, -0x1.f6297cff75cbp-1, -0x1.d906bcf328d46p-1, -0x1.a9b66290ea1a3p-1, -0x1.6a09e667f3bcdp-1, -0x1.1c73b39ae68c8p-1, -0x1.87de2a6aea963p-2, -0x1.8f8b83c69a60bp-3, -0, --0x1.8f8b83c69a60bp-3, --0x1.87de2a6aea963p-2, --0x1.1c73b39ae68c8p-1, --0x1.6a09e667f3bcdp-1, --0x1.a9b66290ea1a3p-1, --0x1.d906bcf328d46p-1, --0x1.f6297cff75cbp-1 -}; -template <> HWY_ALIGN constexpr double kPackedLowSinCosKPi16Table[] = { -0, -0x1.56217bc626d19p-56, -0x1.457e6bc672cedp-56, -0x1.9f6303c8b25ddp-60, --0x1.bdd34bc8bdd34p-55, -0x1.b25dd3c39f63p-55, --0x1.72ced3c7457e6p-57, --0x1.26d193c756217p-57, -0, -0x1.26d193c756217p-57, -0x1.72ced3c7457e6p-57, --0x1.b25dd3c39f63p-55, -0x1.bdd34bc8bdd34p-55, --0x1.9f6303c8b25ddp-60, --0x1.457e6bc672cedp-56, --0x1.56217bc626d19p-56 -}; -template <> HWY_ALIGN constexpr uint32_t kLargeReductionTable[] = { -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x0U, -0x1U, -0x0U, -0x0U, -0x2U, -0x0U, -0x0U, -0x5U, -0x0U, -0x0U, -0xaU, -0x0U, -0x0U, -0x14U, -0x0U, -0x0U, -0x28U, -0x0U, -0x0U, -0x51U, -0x0U, -0x0U, -0xa2U, -0x0U, -0x0U, -0x145U, -0x0U, -0x0U, -0x28bU, -0x0U, -0x0U, -0x517U, -0x0U, -0x0U, -0xa2fU, -0x0U, -0x0U, -0x145fU, -0x0U, -0x0U, -0x28beU, -0x0U, -0x0U, -0x517cU, -0x0U, -0x0U, -0xa2f9U, -0x0U, -0x0U, -0x145f3U, -0x0U, -0x0U, -0x28be6U, -0x0U, -0x0U, -0x517ccU, -0x0U, -0x0U, -0xa2f98U, -0x0U, -0x0U, -0x145f30U, -0x0U, -0x0U, -0x28be60U, -0x0U, -0x0U, -0x517cc1U, -0x0U, -0x0U, -0xa2f983U, -0x0U, -0x0U, -0x145f306U, -0x0U, -0x0U, -0x28be60dU, -0x0U, -0x0U, -0x517cc1bU, -0x0U, -0x0U, -0xa2f9836U, -0x0U, -0x0U, -0x145f306dU, -0x0U, -0x0U, -0x28be60dbU, -0x0U, -0x0U, -0x517cc1b7U, -0x0U, -0x0U, -0xa2f9836eU, -0x0U, -0x1U, -0x45f306dcU, -0x0U, -0x2U, -0x8be60db9U, -0x0U, -0x5U, -0x17cc1b72U, -0x0U, -0xaU, -0x2f9836e4U, -0x0U, -0x14U, -0x5f306dc9U, -0x0U, -0x28U, -0xbe60db93U, -0x0U, -0x51U, -0x7cc1b727U, -0x0U, -0xa2U, -0xf9836e4eU, -0x0U, -0x145U, -0xf306dc9cU, -0x0U, -0x28bU, -0xe60db939U, -0x0U, -0x517U, -0xcc1b7272U, -0x0U, -0xa2fU, -0x9836e4e4U, -0x0U, -0x145fU, -0x306dc9c8U, -0x0U, -0x28beU, -0x60db9391U, -0x0U, -0x517cU, -0xc1b72722U, -0x0U, -0xa2f9U, -0x836e4e44U, -0x0U, -0x145f3U, -0x6dc9c88U, -0x0U, -0x28be6U, -0xdb93910U, -0x0U, -0x517ccU, -0x1b727220U, -0x0U, -0xa2f98U, -0x36e4e441U, -0x0U, -0x145f30U, -0x6dc9c882U, -0x0U, -0x28be60U, -0xdb939105U, -0x0U, -0x517cc1U, -0xb727220aU, -0x0U, -0xa2f983U, -0x6e4e4415U, -0x0U, -0x145f306U, -0xdc9c882aU, -0x0U, -0x28be60dU, -0xb9391054U, -0x0U, -0x517cc1bU, -0x727220a9U, -0x0U, -0xa2f9836U, -0xe4e44152U, -0x0U, -0x145f306dU, -0xc9c882a5U, -0x0U, -0x28be60dbU, -0x9391054aU, -0x0U, -0x517cc1b7U, -0x27220a94U, -0x0U, -0xa2f9836eU, -0x4e441529U, -0x1U, -0x45f306dcU, -0x9c882a53U, -0x2U, -0x8be60db9U, -0x391054a7U, -0x5U, -0x17cc1b72U, -0x7220a94fU, -0xaU, -0x2f9836e4U, -0xe441529fU, -0x14U, -0x5f306dc9U, -0xc882a53fU, -0x28U, -0xbe60db93U, -0x91054a7fU, -0x51U, -0x7cc1b727U, -0x220a94feU, -0xa2U, -0xf9836e4eU, -0x441529fcU, -0x145U, -0xf306dc9cU, -0x882a53f8U, -0x28bU, -0xe60db939U, -0x1054a7f0U, -0x517U, -0xcc1b7272U, -0x20a94fe1U, -0xa2fU, -0x9836e4e4U, -0x41529fc2U, -0x145fU, -0x306dc9c8U, -0x82a53f84U, -0x28beU, -0x60db9391U, -0x54a7f09U, -0x517cU, -0xc1b72722U, -0xa94fe13U, -0xa2f9U, -0x836e4e44U, -0x1529fc27U, -0x145f3U, -0x6dc9c88U, -0x2a53f84eU, -0x28be6U, -0xdb93910U, -0x54a7f09dU, -0x517ccU, -0x1b727220U, -0xa94fe13aU, -0xa2f98U, -0x36e4e441U, -0x529fc275U, -0x145f30U, -0x6dc9c882U, -0xa53f84eaU, -0x28be60U, -0xdb939105U, -0x4a7f09d5U, -0x517cc1U, -0xb727220aU, -0x94fe13abU, -0xa2f983U, -0x6e4e4415U, -0x29fc2757U, -0x145f306U, -0xdc9c882aU, -0x53f84eafU, -0x28be60dU, -0xb9391054U, -0xa7f09d5fU, -0x517cc1bU, -0x727220a9U, -0x4fe13abeU, -0xa2f9836U, -0xe4e44152U, -0x9fc2757dU, -0x145f306dU, -0xc9c882a5U, -0x3f84eafaU, -0x28be60dbU, -0x9391054aU, -0x7f09d5f4U, -0x517cc1b7U, -0x27220a94U, -0xfe13abe8U, -0xa2f9836eU, -0x4e441529U, -0xfc2757d1U, -0x45f306dcU, -0x9c882a53U, -0xf84eafa3U, -0x8be60db9U, -0x391054a7U, -0xf09d5f47U, -0x17cc1b72U, -0x7220a94fU, -0xe13abe8fU, -0x2f9836e4U, -0xe441529fU, -0xc2757d1fU, -0x5f306dc9U, -0xc882a53fU, -0x84eafa3eU, -0xbe60db93U, -0x91054a7fU, -0x9d5f47dU, -0x7cc1b727U, -0x220a94feU, -0x13abe8faU, -0xf9836e4eU, -0x441529fcU, -0x2757d1f5U, -0xf306dc9cU, -0x882a53f8U, -0x4eafa3eaU, -0xe60db939U, -0x1054a7f0U, -0x9d5f47d4U, -0xcc1b7272U, -0x20a94fe1U, -0x3abe8fa9U, -0x9836e4e4U, -0x41529fc2U, -0x757d1f53U, -0x306dc9c8U, -0x82a53f84U, -0xeafa3ea6U, -0x60db9391U, -0x54a7f09U, -0xd5f47d4dU, -0xc1b72722U, -0xa94fe13U, -0xabe8fa9aU, -0x836e4e44U, -0x1529fc27U, -0x57d1f534U, -0x6dc9c88U, -0x2a53f84eU, -0xafa3ea69U, -0xdb93910U, -0x54a7f09dU, -0x5f47d4d3U, -0x1b727220U, -0xa94fe13aU, -0xbe8fa9a6U, -0x36e4e441U, -0x529fc275U, -0x7d1f534dU, -0x6dc9c882U, -0xa53f84eaU, -0xfa3ea69bU, -0xdb939105U, -0x4a7f09d5U, -0xf47d4d37U, -0xb727220aU, -0x94fe13abU, -0xe8fa9a6eU, -0x6e4e4415U, -0x29fc2757U, -0xd1f534ddU, -0xdc9c882aU, -0x53f84eafU, -0xa3ea69bbU, -0xb9391054U, -0xa7f09d5fU, -0x47d4d377U, -0x727220a9U, -0x4fe13abeU, -0x8fa9a6eeU, -0xe4e44152U, -0x9fc2757dU, -0x1f534ddcU, -0xc9c882a5U, -0x3f84eafaU, -0x3ea69bb8U, -0x9391054aU, -0x7f09d5f4U, -0x7d4d3770U, -0x27220a94U, -0xfe13abe8U, -0xfa9a6ee0U, -0x4e441529U, -0xfc2757d1U, -0xf534ddc0U, -0x9c882a53U, -0xf84eafa3U, -0xea69bb81U, -0x391054a7U, -0xf09d5f47U, -0xd4d37703U, -0x7220a94fU, -0xe13abe8fU, -0xa9a6ee06U, -0xe441529fU, -0xc2757d1fU, -0x534ddc0dU, -0xc882a53fU, -0x84eafa3eU, -0xa69bb81bU, -0x91054a7fU, -0x9d5f47dU, -0x4d377036U, -0x220a94feU, -0x13abe8faU, -0x9a6ee06dU, -0x441529fcU, -0x2757d1f5U, -0x34ddc0dbU, -0x882a53f8U, -0x4eafa3eaU, -0x69bb81b6U, -0x1054a7f0U, -0x9d5f47d4U, -0xd377036dU, -0x20a94fe1U, -0x3abe8fa9U, -0xa6ee06dbU, -0x41529fc2U, -0x757d1f53U, -0x4ddc0db6U, -0x82a53f84U, -0xeafa3ea6U, -0x9bb81b6cU, -0x54a7f09U, -0xd5f47d4dU, -0x377036d8U, -0xa94fe13U, -0xabe8fa9aU, -0x6ee06db1U, -0x1529fc27U, -0x57d1f534U, -0xddc0db62U, -0x2a53f84eU, -0xafa3ea69U, -0xbb81b6c5U, -0x54a7f09dU, -0x5f47d4d3U, -0x77036d8aU, -0xa94fe13aU, -0xbe8fa9a6U, -0xee06db14U, -0x529fc275U, -0x7d1f534dU, -0xdc0db629U, -0xa53f84eaU, -0xfa3ea69bU, -0xb81b6c52U, -0x4a7f09d5U, -0xf47d4d37U, -0x7036d8a5U, -0x94fe13abU, -0xe8fa9a6eU, -0xe06db14aU, -0x29fc2757U, -0xd1f534ddU, -0xc0db6295U, -0x53f84eafU, -0xa3ea69bbU, -0x81b6c52bU, -0xa7f09d5fU, -0x47d4d377U, -0x36d8a56U, -0x4fe13abeU, -0x8fa9a6eeU, -0x6db14acU, -0x9fc2757dU, -0x1f534ddcU, -0xdb62959U, -0x3f84eafaU, -0x3ea69bb8U, -0x1b6c52b3U, -0x7f09d5f4U, -0x7d4d3770U, -0x36d8a566U, -0xfe13abe8U, -0xfa9a6ee0U, -0x6db14accU, -0xfc2757d1U, -0xf534ddc0U, -0xdb629599U, -0xf84eafa3U, -0xea69bb81U, -0xb6c52b32U, -0xf09d5f47U, -0xd4d37703U, -0x6d8a5664U, -0xe13abe8fU, -0xa9a6ee06U, -0xdb14acc9U, -0xc2757d1fU, -0x534ddc0dU, -0xb6295993U, -0x84eafa3eU, -0xa69bb81bU, -0x6c52b327U, -0x9d5f47dU, -0x4d377036U, -0xd8a5664fU, -0x13abe8faU, -0x9a6ee06dU, -0xb14acc9eU, -0x2757d1f5U, -0x34ddc0dbU, -0x6295993cU, -0x4eafa3eaU, -0x69bb81b6U, -0xc52b3278U, -0x9d5f47d4U, -0xd377036dU, -0x8a5664f1U, -0x3abe8fa9U, -0xa6ee06dbU, -0x14acc9e2U, -0x757d1f53U, -0x4ddc0db6U, -0x295993c4U, -0xeafa3ea6U, -0x9bb81b6cU, -0x52b32788U, -0xd5f47d4dU, -0x377036d8U, -0xa5664f10U, -0xabe8fa9aU, -0x6ee06db1U, -0x4acc9e21U, -0x57d1f534U, -0xddc0db62U, -0x95993c43U, -0xafa3ea69U, -0xbb81b6c5U, -0x2b327887U, -0x5f47d4d3U, -0x77036d8aU, -0x5664f10eU, -0xbe8fa9a6U, -0xee06db14U, -0xacc9e21cU, -0x7d1f534dU, -0xdc0db629U, -0x5993c439U, -0xfa3ea69bU, -0xb81b6c52U, -0xb3278872U, -0xf47d4d37U, -0x7036d8a5U, -0x664f10e4U, -0xe8fa9a6eU, -0xe06db14aU, -0xcc9e21c8U, -0xd1f534ddU, -0xc0db6295U, -0x993c4390U, -0xa3ea69bbU, -0x81b6c52bU, -0x32788720U, -0x47d4d377U, -0x36d8a56U, -0x64f10e41U, -0x8fa9a6eeU, -0x6db14acU, -0xc9e21c82U, -0x1f534ddcU, -0xdb62959U, -0x93c43904U, -0x3ea69bb8U, -0x1b6c52b3U, -0x27887208U, -0x7d4d3770U, -0x36d8a566U, -0x4f10e410U, -0xfa9a6ee0U, -0x6db14accU, -0x9e21c820U, -0xf534ddc0U, -0xdb629599U, -0x3c439041U, -0xea69bb81U, -0xb6c52b32U, -0x78872083U, -0xd4d37703U, -0x6d8a5664U, -0xf10e4107U, -0xa9a6ee06U, -0xdb14acc9U, -0xe21c820fU, -0x534ddc0dU, -0xb6295993U, -0xc439041fU, -0xa69bb81bU, -0x6c52b327U, -0x8872083fU, -0x4d377036U, -0xd8a5664fU, -0x10e4107fU, -0x9a6ee06dU, -0xb14acc9eU, -0x21c820ffU -}; -template <> HWY_ALIGN constexpr float kSinApproxTable[] = { -0, -0, -0, -0x1p0, --0x1.3bcfbep-12, -0x1.92156p-6, --0x1.0b933p-31, -0x1p0, --0x1.3bc39p-10, -0x1.91f66p-5, --0x1.de44fep-30, -0x1p0, --0x1.63253p-9, -0x1.2d520ap-4, --0x1.a63cc2p-29, -0x1p0, --0x1.3b92e2p-8, -0x1.917a6cp-4, --0x1.eb25eap-31, -0x1p0, --0x1.ecdc78p-8, -0x1.f564e6p-4, --0x1.2ad19ep-29, -0x1p0, --0x1.62aa04p-7, -0x1.2c8106p-3, -0x1.d1cc28p-28, -0x1p0, --0x1.e26c16p-7, -0x1.5e2144p-3, -0x1.22cff2p-29, -0x1p0, --0x1.3ad06p-6, -0x1.8f8b84p-3, --0x1.cb2cfap-30, -0x1p0, --0x1.8e18a8p-6, -0x1.c0b826p-3, -0x1.4fc9ecp-28, -0x1p0, --0x1.eb0208p-6, -0x1.f19f98p-3, --0x1.37a83ap-29, -0x1p0, --0x1.28bf18p-5, -0x1.111d26p-2, -0x1.58fb3cp-29, -0x1p0, --0x1.60beaap-5, -0x1.294062p-2, -0x1.dab3ep-27, -0x1p0, --0x1.9d7714p-5, -0x1.4135cap-2, --0x1.7d134p-27, -0x1p0, --0x1.dedefcp-5, -0x1.58f9a8p-2, --0x1.4a9c04p-27, -0x1p0, --0x1.127624p-4, -0x1.708854p-2, --0x1.e0b74cp-27, -0x1p0, --0x1.37ca18p-4, -0x1.87de2ap-2, -0x1.abaa58p-28, -0x1p0, --0x1.5f6598p-4, -0x1.9ef794p-2, -0x1.d476c6p-29, -0x1p0, --0x1.894286p-4, -0x1.b5d1p-2, -0x1.3c2b98p-27, -0x1p0, --0x1.b55a7p-4, -0x1.cc66eap-2, --0x1.b38ee8p-28, -0x1p0, --0x1.e3a688p-4, -0x1.e2b5d4p-2, --0x1.fe4272p-28, -0x1p0, --0x1.0a0fd4p-3, -0x1.f8ba4ep-2, --0x1.01d952p-28, -0x1p0, --0x1.235f2ep-3, -0x1.07387ap-1, --0x1.b74004p-27, -0x1p0, --0x1.3dbd6ap-3, -0x1.11eb36p-1, --0x1.7c969cp-26, -0x1p0, --0x1.592676p-3, -0x1.1c73b4p-1, --0x1.9465cep-27, -0x1p0, --0x1.759618p-3, -0x1.26d054p-1, -0x1.9ba25cp-26, -0x1p0, --0x1.9307eep-3, -0x1.30ff8p-1, --0x1.8f47e6p-28, -0x1p0, --0x1.b1776ep-3, -0x1.3affa2p-1, -0x1.240a18p-26, -0x1p0, --0x1.d0dfe6p-3, -0x1.44cf32p-1, -0x1.424776p-27, -0x1p0, --0x1.f13c7ep-3, -0x1.4e6cacp-1, --0x1.070686p-27, -0x1p0, --0x1.09441cp-2, -0x1.57d694p-1, --0x1.6e626cp-26, -0x1p0, --0x1.1a5efap-2, -0x1.610b76p-1, --0x1.5c5a64p-26, -0x1p0, -0, -0x1.6a09e6p-1, -0x1.9fcef4p-27, -0, -0x1.842dd6p-3, -0x1.72d084p-1, --0x1.02000ep-26, -0x1p-1, -0x1.5f5a4ep-3, -0x1.7b5df2p-1, -0x1.3557d8p-28, -0x1p-1, -0x1.39b2aep-3, -0x1.83b0ep-1, -0x1.7ff2eep-26, -0x1p-1, -0x1.133ccap-3, -0x1.8bc806p-1, -0x1.62a2e8p-26, -0x1p-1, -0x1.d7fd14p-4, -0x1.93a224p-1, -0x1.324c8p-26, -0x1p-1, -0x1.87fbfep-4, -0x1.9b3e04p-1, -0x1.fce1dp-27, -0x1p-1, -0x1.3682a6p-4, -0x1.a29a7ap-1, -0x1.189e08p-31, -0x1p-1, -0x1.c73b3ap-5, -0x1.a9b662p-1, -0x1.21d434p-26, -0x1p-1, -0x1.1eb354p-5, -0x1.b090a6p-1, --0x1.fabf8p-27, -0x1p-1, -0x1.ce1e64p-7, -0x1.b72834p-1, -0x1.465b9p-27, -0x1p-1, --0x1.d16c9p-8, -0x1.bd7c0ap-1, -0x1.8df2a6p-26, -0x1p-1, --0x1.d4a2c8p-6, -0x1.c38b3p-1, --0x1.cfe84ap-26, -0x1p-1, --0x1.9cc8b4p-5, -0x1.c954b2p-1, -0x1.3411f4p-29, -0x1p-1, --0x1.28bbfep-4, -0x1.ced7bp-1, --0x1.786712p-26, -0x1p-1, --0x1.8421bp-4, -0x1.d4134ep-1, --0x1.d646d8p-26, -0x1p-1, --0x1.e08756p-4, -0x1.d906bcp-1, -0x1.e651a8p-26, -0x1p-1, --0x1.1eef5ap-3, -0x1.ddb13cp-1, --0x1.2667b8p-26, -0x1p-1, -0x1.63e69ep-4, -0x1.e2121p-1, -0x1.3da1bap-27, -0x1p-2, -0x1.04d726p-4, -0x1.e6288ep-1, -0x1.891c22p-26, -0x1p-2, -0x1.4a0318p-5, -0x1.e9f416p-1, --0x1.273a44p-26, -0x1p-2, -0x1.11d262p-6, -0x1.ed740ep-1, -0x1.da1258p-27, -0x1p-2, --0x1.cc0d0ap-8, -0x1.f0a7fp-1, --0x1.1b73cap-27, -0x1p-2, --0x1.fa3ecap-6, -0x1.f38f3ap-1, -0x1.8c9cb2p-26, -0x1p-2, --0x1.c1d1fp-5, -0x1.f6297cp-1, -0x1.feeb96p-26, -0x1p-2, -0x1.788512p-5, -0x1.f8765p-1, --0x1.63ad16p-27, -0x1p-3, -0x1.640838p-6, -0x1.fa7558p-1, --0x1.eeb5d2p-30, -0x1p-3, --0x1.536352p-9, -0x1.fc2648p-1, --0x1.e3cc06p-26, -0x1p-3, --0x1.ba165p-6, -0x1.fd88dap-1, -0x1.e89292p-28, -0x1p-3, -0x1.6a904ap-7, -0x1.fe9cdap-1, -0x1.a03108p-26, -0x1p-4, --0x1.b82684p-7, -0x1.ff621ep-1, -0x1.bcb6bep-28, -0x1p-4, --0x1.b7aa82p-8, -0x1.ffd886p-1, -0x1.099a1ap-30, -0x1p-5, -0, -0x1p0, -0, -0, -0x1.b7aa82p-8, -0x1.ffd886p-1, -0x1.099a1ap-30, --0x1p-5, -0x1.b82684p-7, -0x1.ff621ep-1, -0x1.bcb6bep-28, --0x1p-4, --0x1.6a904ap-7, -0x1.fe9cdap-1, -0x1.a03108p-26, --0x1p-4, -0x1.ba165p-6, -0x1.fd88dap-1, -0x1.e89292p-28, --0x1p-3, -0x1.536352p-9, -0x1.fc2648p-1, --0x1.e3cc06p-26, --0x1p-3, --0x1.640838p-6, -0x1.fa7558p-1, --0x1.eeb5d2p-30, --0x1p-3, --0x1.788512p-5, -0x1.f8765p-1, --0x1.63ad16p-27, --0x1p-3, -0x1.c1d1fp-5, -0x1.f6297cp-1, -0x1.feeb96p-26, --0x1p-2, -0x1.fa3ecap-6, -0x1.f38f3ap-1, -0x1.8c9cb2p-26, --0x1p-2, -0x1.cc0d0ap-8, -0x1.f0a7fp-1, --0x1.1b73cap-27, --0x1p-2, --0x1.11d262p-6, -0x1.ed740ep-1, -0x1.da1258p-27, --0x1p-2, --0x1.4a0318p-5, -0x1.e9f416p-1, --0x1.273a44p-26, --0x1p-2, --0x1.04d726p-4, -0x1.e6288ep-1, -0x1.891c22p-26, --0x1p-2, --0x1.63e69ep-4, -0x1.e2121p-1, -0x1.3da1bap-27, --0x1p-2, -0x1.1eef5ap-3, -0x1.ddb13cp-1, --0x1.2667b8p-26, --0x1p-1, -0x1.e08756p-4, -0x1.d906bcp-1, -0x1.e651a8p-26, --0x1p-1, -0x1.8421bp-4, -0x1.d4134ep-1, --0x1.d646d8p-26, --0x1p-1, -0x1.28bbfep-4, -0x1.ced7bp-1, --0x1.786712p-26, --0x1p-1, -0x1.9cc8b4p-5, -0x1.c954b2p-1, -0x1.3411f4p-29, --0x1p-1, -0x1.d4a2c8p-6, -0x1.c38b3p-1, --0x1.cfe84ap-26, --0x1p-1, -0x1.d16c9p-8, -0x1.bd7c0ap-1, -0x1.8df2a6p-26, --0x1p-1, --0x1.ce1e64p-7, -0x1.b72834p-1, -0x1.465b9p-27, --0x1p-1, --0x1.1eb354p-5, -0x1.b090a6p-1, --0x1.fabf8p-27, --0x1p-1, --0x1.c73b3ap-5, -0x1.a9b662p-1, -0x1.21d434p-26, --0x1p-1, --0x1.3682a6p-4, -0x1.a29a7ap-1, -0x1.189e08p-31, --0x1p-1, --0x1.87fbfep-4, -0x1.9b3e04p-1, -0x1.fce1dp-27, --0x1p-1, --0x1.d7fd14p-4, -0x1.93a224p-1, -0x1.324c8p-26, --0x1p-1, --0x1.133ccap-3, -0x1.8bc806p-1, -0x1.62a2e8p-26, --0x1p-1, --0x1.39b2aep-3, -0x1.83b0ep-1, -0x1.7ff2eep-26, --0x1p-1, --0x1.5f5a4ep-3, -0x1.7b5df2p-1, -0x1.3557d8p-28, --0x1p-1, --0x1.842dd6p-3, -0x1.72d084p-1, --0x1.02000ep-26, --0x1p-1, -0, -0x1.6a09e6p-1, -0x1.9fcef4p-27, -0, -0x1.1a5efap-2, -0x1.610b76p-1, --0x1.5c5a64p-26, --0x1p0, -0x1.09441cp-2, -0x1.57d694p-1, --0x1.6e626cp-26, --0x1p0, -0x1.f13c7ep-3, -0x1.4e6cacp-1, --0x1.070686p-27, --0x1p0, -0x1.d0dfe6p-3, -0x1.44cf32p-1, -0x1.424776p-27, --0x1p0, -0x1.b1776ep-3, -0x1.3affa2p-1, -0x1.240a18p-26, --0x1p0, -0x1.9307eep-3, -0x1.30ff8p-1, --0x1.8f47e6p-28, --0x1p0, -0x1.759618p-3, -0x1.26d054p-1, -0x1.9ba25cp-26, --0x1p0, -0x1.592676p-3, -0x1.1c73b4p-1, --0x1.9465cep-27, --0x1p0, -0x1.3dbd6ap-3, -0x1.11eb36p-1, --0x1.7c969cp-26, --0x1p0, -0x1.235f2ep-3, -0x1.07387ap-1, --0x1.b74004p-27, --0x1p0, -0x1.0a0fd4p-3, -0x1.f8ba4ep-2, --0x1.01d952p-28, --0x1p0, -0x1.e3a688p-4, -0x1.e2b5d4p-2, --0x1.fe4272p-28, --0x1p0, -0x1.b55a7p-4, -0x1.cc66eap-2, --0x1.b38ee8p-28, --0x1p0, -0x1.894286p-4, -0x1.b5d1p-2, -0x1.3c2b98p-27, --0x1p0, -0x1.5f6598p-4, -0x1.9ef794p-2, -0x1.d476c6p-29, --0x1p0, -0x1.37ca18p-4, -0x1.87de2ap-2, -0x1.abaa58p-28, --0x1p0, -0x1.127624p-4, -0x1.708854p-2, --0x1.e0b74cp-27, --0x1p0, -0x1.dedefcp-5, -0x1.58f9a8p-2, --0x1.4a9c04p-27, --0x1p0, -0x1.9d7714p-5, -0x1.4135cap-2, --0x1.7d134p-27, --0x1p0, -0x1.60beaap-5, -0x1.294062p-2, -0x1.dab3ep-27, --0x1p0, -0x1.28bf18p-5, -0x1.111d26p-2, -0x1.58fb3cp-29, --0x1p0, -0x1.eb0208p-6, -0x1.f19f98p-3, --0x1.37a83ap-29, --0x1p0, -0x1.8e18a8p-6, -0x1.c0b826p-3, -0x1.4fc9ecp-28, --0x1p0, -0x1.3ad06p-6, -0x1.8f8b84p-3, --0x1.cb2cfap-30, --0x1p0, -0x1.e26c16p-7, -0x1.5e2144p-3, -0x1.22cff2p-29, --0x1p0, -0x1.62aa04p-7, -0x1.2c8106p-3, -0x1.d1cc28p-28, --0x1p0, -0x1.ecdc78p-8, -0x1.f564e6p-4, --0x1.2ad19ep-29, --0x1p0, -0x1.3b92e2p-8, -0x1.917a6cp-4, --0x1.eb25eap-31, --0x1p0, -0x1.63253p-9, -0x1.2d520ap-4, --0x1.a63cc2p-29, --0x1p0, -0x1.3bc39p-10, -0x1.91f66p-5, --0x1.de44fep-30, --0x1p0, -0x1.3bcfbep-12, -0x1.92156p-6, --0x1.0b933p-31, --0x1p0, -0, -0, -0, --0x1p0, -0x1.3bcfbep-12, --0x1.92156p-6, -0x1.0b933p-31, --0x1p0, -0x1.3bc39p-10, --0x1.91f66p-5, -0x1.de44fep-30, --0x1p0, -0x1.63253p-9, --0x1.2d520ap-4, -0x1.a63cc2p-29, --0x1p0, -0x1.3b92e2p-8, --0x1.917a6cp-4, -0x1.eb25eap-31, --0x1p0, -0x1.ecdc78p-8, --0x1.f564e6p-4, -0x1.2ad19ep-29, --0x1p0, -0x1.62aa04p-7, --0x1.2c8106p-3, --0x1.d1cc28p-28, --0x1p0, -0x1.e26c16p-7, --0x1.5e2144p-3, --0x1.22cff2p-29, --0x1p0, -0x1.3ad06p-6, --0x1.8f8b84p-3, -0x1.cb2cfap-30, --0x1p0, -0x1.8e18a8p-6, --0x1.c0b826p-3, --0x1.4fc9ecp-28, --0x1p0, -0x1.eb0208p-6, --0x1.f19f98p-3, -0x1.37a83ap-29, --0x1p0, -0x1.28bf18p-5, --0x1.111d26p-2, --0x1.58fb3cp-29, --0x1p0, -0x1.60beaap-5, --0x1.294062p-2, --0x1.dab3ep-27, --0x1p0, -0x1.9d7714p-5, --0x1.4135cap-2, -0x1.7d134p-27, --0x1p0, -0x1.dedefcp-5, --0x1.58f9a8p-2, -0x1.4a9c04p-27, --0x1p0, -0x1.127624p-4, --0x1.708854p-2, -0x1.e0b74cp-27, --0x1p0, -0x1.37ca18p-4, --0x1.87de2ap-2, --0x1.abaa58p-28, --0x1p0, -0x1.5f6598p-4, --0x1.9ef794p-2, --0x1.d476c6p-29, --0x1p0, -0x1.894286p-4, --0x1.b5d1p-2, --0x1.3c2b98p-27, --0x1p0, -0x1.b55a7p-4, --0x1.cc66eap-2, -0x1.b38ee8p-28, --0x1p0, -0x1.e3a688p-4, --0x1.e2b5d4p-2, -0x1.fe4272p-28, --0x1p0, -0x1.0a0fd4p-3, --0x1.f8ba4ep-2, -0x1.01d952p-28, --0x1p0, -0x1.235f2ep-3, --0x1.07387ap-1, -0x1.b74004p-27, --0x1p0, -0x1.3dbd6ap-3, --0x1.11eb36p-1, -0x1.7c969cp-26, --0x1p0, -0x1.592676p-3, --0x1.1c73b4p-1, -0x1.9465cep-27, --0x1p0, -0x1.759618p-3, --0x1.26d054p-1, --0x1.9ba25cp-26, --0x1p0, -0x1.9307eep-3, --0x1.30ff8p-1, -0x1.8f47e6p-28, --0x1p0, -0x1.b1776ep-3, --0x1.3affa2p-1, --0x1.240a18p-26, --0x1p0, -0x1.d0dfe6p-3, --0x1.44cf32p-1, --0x1.424776p-27, --0x1p0, -0x1.f13c7ep-3, --0x1.4e6cacp-1, -0x1.070686p-27, --0x1p0, -0x1.09441cp-2, --0x1.57d694p-1, -0x1.6e626cp-26, --0x1p0, -0x1.1a5efap-2, --0x1.610b76p-1, -0x1.5c5a64p-26, --0x1p0, -0, --0x1.6a09e6p-1, --0x1.9fcef4p-27, -0, --0x1.842dd6p-3, --0x1.72d084p-1, -0x1.02000ep-26, --0x1p-1, --0x1.5f5a4ep-3, --0x1.7b5df2p-1, --0x1.3557d8p-28, --0x1p-1, --0x1.39b2aep-3, --0x1.83b0ep-1, --0x1.7ff2eep-26, --0x1p-1, --0x1.133ccap-3, --0x1.8bc806p-1, --0x1.62a2e8p-26, --0x1p-1, --0x1.d7fd14p-4, --0x1.93a224p-1, --0x1.324c8p-26, --0x1p-1, --0x1.87fbfep-4, --0x1.9b3e04p-1, --0x1.fce1dp-27, --0x1p-1, --0x1.3682a6p-4, --0x1.a29a7ap-1, --0x1.189e08p-31, --0x1p-1, --0x1.c73b3ap-5, --0x1.a9b662p-1, --0x1.21d434p-26, --0x1p-1, --0x1.1eb354p-5, --0x1.b090a6p-1, -0x1.fabf8p-27, --0x1p-1, --0x1.ce1e64p-7, --0x1.b72834p-1, --0x1.465b9p-27, --0x1p-1, -0x1.d16c9p-8, --0x1.bd7c0ap-1, --0x1.8df2a6p-26, --0x1p-1, -0x1.d4a2c8p-6, --0x1.c38b3p-1, -0x1.cfe84ap-26, --0x1p-1, -0x1.9cc8b4p-5, --0x1.c954b2p-1, --0x1.3411f4p-29, --0x1p-1, -0x1.28bbfep-4, --0x1.ced7bp-1, -0x1.786712p-26, --0x1p-1, -0x1.8421bp-4, --0x1.d4134ep-1, -0x1.d646d8p-26, --0x1p-1, -0x1.e08756p-4, --0x1.d906bcp-1, --0x1.e651a8p-26, --0x1p-1, -0x1.1eef5ap-3, --0x1.ddb13cp-1, -0x1.2667b8p-26, --0x1p-1, --0x1.63e69ep-4, --0x1.e2121p-1, --0x1.3da1bap-27, --0x1p-2, --0x1.04d726p-4, --0x1.e6288ep-1, --0x1.891c22p-26, --0x1p-2, --0x1.4a0318p-5, --0x1.e9f416p-1, -0x1.273a44p-26, --0x1p-2, --0x1.11d262p-6, --0x1.ed740ep-1, --0x1.da1258p-27, --0x1p-2, -0x1.cc0d0ap-8, --0x1.f0a7fp-1, -0x1.1b73cap-27, --0x1p-2, -0x1.fa3ecap-6, --0x1.f38f3ap-1, --0x1.8c9cb2p-26, --0x1p-2, -0x1.c1d1fp-5, --0x1.f6297cp-1, --0x1.feeb96p-26, --0x1p-2, --0x1.788512p-5, --0x1.f8765p-1, -0x1.63ad16p-27, --0x1p-3, --0x1.640838p-6, --0x1.fa7558p-1, -0x1.eeb5d2p-30, --0x1p-3, -0x1.536352p-9, --0x1.fc2648p-1, -0x1.e3cc06p-26, --0x1p-3, -0x1.ba165p-6, --0x1.fd88dap-1, --0x1.e89292p-28, --0x1p-3, --0x1.6a904ap-7, --0x1.fe9cdap-1, --0x1.a03108p-26, --0x1p-4, -0x1.b82684p-7, --0x1.ff621ep-1, --0x1.bcb6bep-28, --0x1p-4, -0x1.b7aa82p-8, --0x1.ffd886p-1, --0x1.099a1ap-30, --0x1p-5, -0, --0x1p0, -0, -0, --0x1.b7aa82p-8, --0x1.ffd886p-1, --0x1.099a1ap-30, -0x1p-5, --0x1.b82684p-7, --0x1.ff621ep-1, --0x1.bcb6bep-28, -0x1p-4, -0x1.6a904ap-7, --0x1.fe9cdap-1, --0x1.a03108p-26, -0x1p-4, --0x1.ba165p-6, --0x1.fd88dap-1, --0x1.e89292p-28, -0x1p-3, --0x1.536352p-9, --0x1.fc2648p-1, -0x1.e3cc06p-26, -0x1p-3, -0x1.640838p-6, --0x1.fa7558p-1, -0x1.eeb5d2p-30, -0x1p-3, -0x1.788512p-5, --0x1.f8765p-1, -0x1.63ad16p-27, -0x1p-3, --0x1.c1d1fp-5, --0x1.f6297cp-1, --0x1.feeb96p-26, -0x1p-2, --0x1.fa3ecap-6, --0x1.f38f3ap-1, --0x1.8c9cb2p-26, -0x1p-2, --0x1.cc0d0ap-8, --0x1.f0a7fp-1, -0x1.1b73cap-27, -0x1p-2, -0x1.11d262p-6, --0x1.ed740ep-1, --0x1.da1258p-27, -0x1p-2, -0x1.4a0318p-5, --0x1.e9f416p-1, -0x1.273a44p-26, -0x1p-2, -0x1.04d726p-4, --0x1.e6288ep-1, --0x1.891c22p-26, -0x1p-2, -0x1.63e69ep-4, --0x1.e2121p-1, --0x1.3da1bap-27, -0x1p-2, --0x1.1eef5ap-3, --0x1.ddb13cp-1, -0x1.2667b8p-26, -0x1p-1, --0x1.e08756p-4, --0x1.d906bcp-1, --0x1.e651a8p-26, -0x1p-1, --0x1.8421bp-4, --0x1.d4134ep-1, -0x1.d646d8p-26, -0x1p-1, --0x1.28bbfep-4, --0x1.ced7bp-1, -0x1.786712p-26, -0x1p-1, --0x1.9cc8b4p-5, --0x1.c954b2p-1, --0x1.3411f4p-29, -0x1p-1, --0x1.d4a2c8p-6, --0x1.c38b3p-1, -0x1.cfe84ap-26, -0x1p-1, --0x1.d16c9p-8, --0x1.bd7c0ap-1, --0x1.8df2a6p-26, -0x1p-1, -0x1.ce1e64p-7, --0x1.b72834p-1, --0x1.465b9p-27, -0x1p-1, -0x1.1eb354p-5, --0x1.b090a6p-1, -0x1.fabf8p-27, -0x1p-1, -0x1.c73b3ap-5, --0x1.a9b662p-1, --0x1.21d434p-26, -0x1p-1, -0x1.3682a6p-4, --0x1.a29a7ap-1, --0x1.189e08p-31, -0x1p-1, -0x1.87fbfep-4, --0x1.9b3e04p-1, --0x1.fce1dp-27, -0x1p-1, -0x1.d7fd14p-4, --0x1.93a224p-1, --0x1.324c8p-26, -0x1p-1, -0x1.133ccap-3, --0x1.8bc806p-1, --0x1.62a2e8p-26, -0x1p-1, -0x1.39b2aep-3, --0x1.83b0ep-1, --0x1.7ff2eep-26, -0x1p-1, -0x1.5f5a4ep-3, --0x1.7b5df2p-1, --0x1.3557d8p-28, -0x1p-1, -0x1.842dd6p-3, --0x1.72d084p-1, -0x1.02000ep-26, -0x1p-1, -0, --0x1.6a09e6p-1, --0x1.9fcef4p-27, -0, --0x1.1a5efap-2, --0x1.610b76p-1, -0x1.5c5a64p-26, -0x1p0, --0x1.09441cp-2, --0x1.57d694p-1, -0x1.6e626cp-26, -0x1p0, --0x1.f13c7ep-3, --0x1.4e6cacp-1, -0x1.070686p-27, -0x1p0, --0x1.d0dfe6p-3, --0x1.44cf32p-1, --0x1.424776p-27, -0x1p0, --0x1.b1776ep-3, --0x1.3affa2p-1, --0x1.240a18p-26, -0x1p0, --0x1.9307eep-3, --0x1.30ff8p-1, -0x1.8f47e6p-28, -0x1p0, --0x1.759618p-3, --0x1.26d054p-1, --0x1.9ba25cp-26, -0x1p0, --0x1.592676p-3, --0x1.1c73b4p-1, -0x1.9465cep-27, -0x1p0, --0x1.3dbd6ap-3, --0x1.11eb36p-1, -0x1.7c969cp-26, -0x1p0, --0x1.235f2ep-3, --0x1.07387ap-1, -0x1.b74004p-27, -0x1p0, --0x1.0a0fd4p-3, --0x1.f8ba4ep-2, -0x1.01d952p-28, -0x1p0, --0x1.e3a688p-4, --0x1.e2b5d4p-2, -0x1.fe4272p-28, -0x1p0, --0x1.b55a7p-4, --0x1.cc66eap-2, -0x1.b38ee8p-28, -0x1p0, --0x1.894286p-4, --0x1.b5d1p-2, --0x1.3c2b98p-27, -0x1p0, --0x1.5f6598p-4, --0x1.9ef794p-2, --0x1.d476c6p-29, -0x1p0, --0x1.37ca18p-4, --0x1.87de2ap-2, --0x1.abaa58p-28, -0x1p0, --0x1.127624p-4, --0x1.708854p-2, -0x1.e0b74cp-27, -0x1p0, --0x1.dedefcp-5, --0x1.58f9a8p-2, -0x1.4a9c04p-27, -0x1p0, --0x1.9d7714p-5, --0x1.4135cap-2, -0x1.7d134p-27, -0x1p0, --0x1.60beaap-5, --0x1.294062p-2, --0x1.dab3ep-27, -0x1p0, --0x1.28bf18p-5, --0x1.111d26p-2, --0x1.58fb3cp-29, -0x1p0, --0x1.eb0208p-6, --0x1.f19f98p-3, -0x1.37a83ap-29, -0x1p0, --0x1.8e18a8p-6, --0x1.c0b826p-3, --0x1.4fc9ecp-28, -0x1p0, --0x1.3ad06p-6, --0x1.8f8b84p-3, -0x1.cb2cfap-30, -0x1p0, --0x1.e26c16p-7, --0x1.5e2144p-3, --0x1.22cff2p-29, -0x1p0, --0x1.62aa04p-7, --0x1.2c8106p-3, --0x1.d1cc28p-28, -0x1p0, --0x1.ecdc78p-8, --0x1.f564e6p-4, -0x1.2ad19ep-29, -0x1p0, --0x1.3b92e2p-8, --0x1.917a6cp-4, -0x1.eb25eap-31, -0x1p0, --0x1.63253p-9, --0x1.2d520ap-4, -0x1.a63cc2p-29, -0x1p0, --0x1.3bc39p-10, --0x1.91f66p-5, -0x1.de44fep-30, -0x1p0, --0x1.3bcfbep-12, --0x1.92156p-6, -0x1.0b933p-31, -0x1p0 -}; -template <> HWY_ALIGN constexpr float kCosApproxTable[] = { -0, -0x1p0, -0, -0, -0x1.b7aa82p-8, -0x1.ffd886p-1, -0x1.099a1ap-30, --0x1p-5, -0x1.b82684p-7, -0x1.ff621ep-1, -0x1.bcb6bep-28, --0x1p-4, --0x1.6a904ap-7, -0x1.fe9cdap-1, -0x1.a03108p-26, --0x1p-4, -0x1.ba165p-6, -0x1.fd88dap-1, -0x1.e89292p-28, --0x1p-3, -0x1.536352p-9, -0x1.fc2648p-1, --0x1.e3cc06p-26, --0x1p-3, --0x1.640838p-6, -0x1.fa7558p-1, --0x1.eeb5d2p-30, --0x1p-3, --0x1.788512p-5, -0x1.f8765p-1, --0x1.63ad16p-27, --0x1p-3, -0x1.c1d1fp-5, -0x1.f6297cp-1, -0x1.feeb96p-26, --0x1p-2, -0x1.fa3ecap-6, -0x1.f38f3ap-1, -0x1.8c9cb2p-26, --0x1p-2, -0x1.cc0d0ap-8, -0x1.f0a7fp-1, --0x1.1b73cap-27, --0x1p-2, --0x1.11d262p-6, -0x1.ed740ep-1, -0x1.da1258p-27, --0x1p-2, --0x1.4a0318p-5, -0x1.e9f416p-1, --0x1.273a44p-26, --0x1p-2, --0x1.04d726p-4, -0x1.e6288ep-1, -0x1.891c22p-26, --0x1p-2, --0x1.63e69ep-4, -0x1.e2121p-1, -0x1.3da1bap-27, --0x1p-2, -0x1.1eef5ap-3, -0x1.ddb13cp-1, --0x1.2667b8p-26, --0x1p-1, -0x1.e08756p-4, -0x1.d906bcp-1, -0x1.e651a8p-26, --0x1p-1, -0x1.8421bp-4, -0x1.d4134ep-1, --0x1.d646d8p-26, --0x1p-1, -0x1.28bbfep-4, -0x1.ced7bp-1, --0x1.786712p-26, --0x1p-1, -0x1.9cc8b4p-5, -0x1.c954b2p-1, -0x1.3411f4p-29, --0x1p-1, -0x1.d4a2c8p-6, -0x1.c38b3p-1, --0x1.cfe84ap-26, --0x1p-1, -0x1.d16c9p-8, -0x1.bd7c0ap-1, -0x1.8df2a6p-26, --0x1p-1, --0x1.ce1e64p-7, -0x1.b72834p-1, -0x1.465b9p-27, --0x1p-1, --0x1.1eb354p-5, -0x1.b090a6p-1, --0x1.fabf8p-27, --0x1p-1, --0x1.c73b3ap-5, -0x1.a9b662p-1, -0x1.21d434p-26, --0x1p-1, --0x1.3682a6p-4, -0x1.a29a7ap-1, -0x1.189e08p-31, --0x1p-1, --0x1.87fbfep-4, -0x1.9b3e04p-1, -0x1.fce1dp-27, --0x1p-1, --0x1.d7fd14p-4, -0x1.93a224p-1, -0x1.324c8p-26, --0x1p-1, --0x1.133ccap-3, -0x1.8bc806p-1, -0x1.62a2e8p-26, --0x1p-1, --0x1.39b2aep-3, -0x1.83b0ep-1, -0x1.7ff2eep-26, --0x1p-1, --0x1.5f5a4ep-3, -0x1.7b5df2p-1, -0x1.3557d8p-28, --0x1p-1, --0x1.842dd6p-3, -0x1.72d084p-1, --0x1.02000ep-26, --0x1p-1, -0, -0x1.6a09e6p-1, -0x1.9fcef4p-27, -0, -0x1.1a5efap-2, -0x1.610b76p-1, --0x1.5c5a64p-26, --0x1p0, -0x1.09441cp-2, -0x1.57d694p-1, --0x1.6e626cp-26, --0x1p0, -0x1.f13c7ep-3, -0x1.4e6cacp-1, --0x1.070686p-27, --0x1p0, -0x1.d0dfe6p-3, -0x1.44cf32p-1, -0x1.424776p-27, --0x1p0, -0x1.b1776ep-3, -0x1.3affa2p-1, -0x1.240a18p-26, --0x1p0, -0x1.9307eep-3, -0x1.30ff8p-1, --0x1.8f47e6p-28, --0x1p0, -0x1.759618p-3, -0x1.26d054p-1, -0x1.9ba25cp-26, --0x1p0, -0x1.592676p-3, -0x1.1c73b4p-1, --0x1.9465cep-27, --0x1p0, -0x1.3dbd6ap-3, -0x1.11eb36p-1, --0x1.7c969cp-26, --0x1p0, -0x1.235f2ep-3, -0x1.07387ap-1, --0x1.b74004p-27, --0x1p0, -0x1.0a0fd4p-3, -0x1.f8ba4ep-2, --0x1.01d952p-28, --0x1p0, -0x1.e3a688p-4, -0x1.e2b5d4p-2, --0x1.fe4272p-28, --0x1p0, -0x1.b55a7p-4, -0x1.cc66eap-2, --0x1.b38ee8p-28, --0x1p0, -0x1.894286p-4, -0x1.b5d1p-2, -0x1.3c2b98p-27, --0x1p0, -0x1.5f6598p-4, -0x1.9ef794p-2, -0x1.d476c6p-29, --0x1p0, -0x1.37ca18p-4, -0x1.87de2ap-2, -0x1.abaa58p-28, --0x1p0, -0x1.127624p-4, -0x1.708854p-2, --0x1.e0b74cp-27, --0x1p0, -0x1.dedefcp-5, -0x1.58f9a8p-2, --0x1.4a9c04p-27, --0x1p0, -0x1.9d7714p-5, -0x1.4135cap-2, --0x1.7d134p-27, --0x1p0, -0x1.60beaap-5, -0x1.294062p-2, -0x1.dab3ep-27, --0x1p0, -0x1.28bf18p-5, -0x1.111d26p-2, -0x1.58fb3cp-29, --0x1p0, -0x1.eb0208p-6, -0x1.f19f98p-3, --0x1.37a83ap-29, --0x1p0, -0x1.8e18a8p-6, -0x1.c0b826p-3, -0x1.4fc9ecp-28, --0x1p0, -0x1.3ad06p-6, -0x1.8f8b84p-3, --0x1.cb2cfap-30, --0x1p0, -0x1.e26c16p-7, -0x1.5e2144p-3, -0x1.22cff2p-29, --0x1p0, -0x1.62aa04p-7, -0x1.2c8106p-3, -0x1.d1cc28p-28, --0x1p0, -0x1.ecdc78p-8, -0x1.f564e6p-4, --0x1.2ad19ep-29, --0x1p0, -0x1.3b92e2p-8, -0x1.917a6cp-4, --0x1.eb25eap-31, --0x1p0, -0x1.63253p-9, -0x1.2d520ap-4, --0x1.a63cc2p-29, --0x1p0, -0x1.3bc39p-10, -0x1.91f66p-5, --0x1.de44fep-30, --0x1p0, -0x1.3bcfbep-12, -0x1.92156p-6, --0x1.0b933p-31, --0x1p0, -0, -0, -0, --0x1p0, -0x1.3bcfbep-12, --0x1.92156p-6, -0x1.0b933p-31, --0x1p0, -0x1.3bc39p-10, --0x1.91f66p-5, -0x1.de44fep-30, --0x1p0, -0x1.63253p-9, --0x1.2d520ap-4, -0x1.a63cc2p-29, --0x1p0, -0x1.3b92e2p-8, --0x1.917a6cp-4, -0x1.eb25eap-31, --0x1p0, -0x1.ecdc78p-8, --0x1.f564e6p-4, -0x1.2ad19ep-29, --0x1p0, -0x1.62aa04p-7, --0x1.2c8106p-3, --0x1.d1cc28p-28, --0x1p0, -0x1.e26c16p-7, --0x1.5e2144p-3, --0x1.22cff2p-29, --0x1p0, -0x1.3ad06p-6, --0x1.8f8b84p-3, -0x1.cb2cfap-30, --0x1p0, -0x1.8e18a8p-6, --0x1.c0b826p-3, --0x1.4fc9ecp-28, --0x1p0, -0x1.eb0208p-6, --0x1.f19f98p-3, -0x1.37a83ap-29, --0x1p0, -0x1.28bf18p-5, --0x1.111d26p-2, --0x1.58fb3cp-29, --0x1p0, -0x1.60beaap-5, --0x1.294062p-2, --0x1.dab3ep-27, --0x1p0, -0x1.9d7714p-5, --0x1.4135cap-2, -0x1.7d134p-27, --0x1p0, -0x1.dedefcp-5, --0x1.58f9a8p-2, -0x1.4a9c04p-27, --0x1p0, -0x1.127624p-4, --0x1.708854p-2, -0x1.e0b74cp-27, --0x1p0, -0x1.37ca18p-4, --0x1.87de2ap-2, --0x1.abaa58p-28, --0x1p0, -0x1.5f6598p-4, --0x1.9ef794p-2, --0x1.d476c6p-29, --0x1p0, -0x1.894286p-4, --0x1.b5d1p-2, --0x1.3c2b98p-27, --0x1p0, -0x1.b55a7p-4, --0x1.cc66eap-2, -0x1.b38ee8p-28, --0x1p0, -0x1.e3a688p-4, --0x1.e2b5d4p-2, -0x1.fe4272p-28, --0x1p0, -0x1.0a0fd4p-3, --0x1.f8ba4ep-2, -0x1.01d952p-28, --0x1p0, -0x1.235f2ep-3, --0x1.07387ap-1, -0x1.b74004p-27, --0x1p0, -0x1.3dbd6ap-3, --0x1.11eb36p-1, -0x1.7c969cp-26, --0x1p0, -0x1.592676p-3, --0x1.1c73b4p-1, -0x1.9465cep-27, --0x1p0, -0x1.759618p-3, --0x1.26d054p-1, --0x1.9ba25cp-26, --0x1p0, -0x1.9307eep-3, --0x1.30ff8p-1, -0x1.8f47e6p-28, --0x1p0, -0x1.b1776ep-3, --0x1.3affa2p-1, --0x1.240a18p-26, --0x1p0, -0x1.d0dfe6p-3, --0x1.44cf32p-1, --0x1.424776p-27, --0x1p0, -0x1.f13c7ep-3, --0x1.4e6cacp-1, -0x1.070686p-27, --0x1p0, -0x1.09441cp-2, --0x1.57d694p-1, -0x1.6e626cp-26, --0x1p0, -0x1.1a5efap-2, --0x1.610b76p-1, -0x1.5c5a64p-26, --0x1p0, -0, --0x1.6a09e6p-1, --0x1.9fcef4p-27, -0, --0x1.842dd6p-3, --0x1.72d084p-1, -0x1.02000ep-26, --0x1p-1, --0x1.5f5a4ep-3, --0x1.7b5df2p-1, --0x1.3557d8p-28, --0x1p-1, --0x1.39b2aep-3, --0x1.83b0ep-1, --0x1.7ff2eep-26, --0x1p-1, --0x1.133ccap-3, --0x1.8bc806p-1, --0x1.62a2e8p-26, --0x1p-1, --0x1.d7fd14p-4, --0x1.93a224p-1, --0x1.324c8p-26, --0x1p-1, --0x1.87fbfep-4, --0x1.9b3e04p-1, --0x1.fce1dp-27, --0x1p-1, --0x1.3682a6p-4, --0x1.a29a7ap-1, --0x1.189e08p-31, --0x1p-1, --0x1.c73b3ap-5, --0x1.a9b662p-1, --0x1.21d434p-26, --0x1p-1, --0x1.1eb354p-5, --0x1.b090a6p-1, -0x1.fabf8p-27, --0x1p-1, --0x1.ce1e64p-7, --0x1.b72834p-1, --0x1.465b9p-27, --0x1p-1, -0x1.d16c9p-8, --0x1.bd7c0ap-1, --0x1.8df2a6p-26, --0x1p-1, -0x1.d4a2c8p-6, --0x1.c38b3p-1, -0x1.cfe84ap-26, --0x1p-1, -0x1.9cc8b4p-5, --0x1.c954b2p-1, --0x1.3411f4p-29, --0x1p-1, -0x1.28bbfep-4, --0x1.ced7bp-1, -0x1.786712p-26, --0x1p-1, -0x1.8421bp-4, --0x1.d4134ep-1, -0x1.d646d8p-26, --0x1p-1, -0x1.e08756p-4, --0x1.d906bcp-1, --0x1.e651a8p-26, --0x1p-1, -0x1.1eef5ap-3, --0x1.ddb13cp-1, -0x1.2667b8p-26, --0x1p-1, --0x1.63e69ep-4, --0x1.e2121p-1, --0x1.3da1bap-27, --0x1p-2, --0x1.04d726p-4, --0x1.e6288ep-1, --0x1.891c22p-26, --0x1p-2, --0x1.4a0318p-5, --0x1.e9f416p-1, -0x1.273a44p-26, --0x1p-2, --0x1.11d262p-6, --0x1.ed740ep-1, --0x1.da1258p-27, --0x1p-2, -0x1.cc0d0ap-8, --0x1.f0a7fp-1, -0x1.1b73cap-27, --0x1p-2, -0x1.fa3ecap-6, --0x1.f38f3ap-1, --0x1.8c9cb2p-26, --0x1p-2, -0x1.c1d1fp-5, --0x1.f6297cp-1, --0x1.feeb96p-26, --0x1p-2, --0x1.788512p-5, --0x1.f8765p-1, -0x1.63ad16p-27, --0x1p-3, --0x1.640838p-6, --0x1.fa7558p-1, -0x1.eeb5d2p-30, --0x1p-3, -0x1.536352p-9, --0x1.fc2648p-1, -0x1.e3cc06p-26, --0x1p-3, -0x1.ba165p-6, --0x1.fd88dap-1, --0x1.e89292p-28, --0x1p-3, --0x1.6a904ap-7, --0x1.fe9cdap-1, --0x1.a03108p-26, --0x1p-4, -0x1.b82684p-7, --0x1.ff621ep-1, --0x1.bcb6bep-28, --0x1p-4, -0x1.b7aa82p-8, --0x1.ffd886p-1, --0x1.099a1ap-30, --0x1p-5, -0, --0x1p0, -0, -0, --0x1.b7aa82p-8, --0x1.ffd886p-1, --0x1.099a1ap-30, -0x1p-5, --0x1.b82684p-7, --0x1.ff621ep-1, --0x1.bcb6bep-28, -0x1p-4, -0x1.6a904ap-7, --0x1.fe9cdap-1, --0x1.a03108p-26, -0x1p-4, --0x1.ba165p-6, --0x1.fd88dap-1, --0x1.e89292p-28, -0x1p-3, --0x1.536352p-9, --0x1.fc2648p-1, -0x1.e3cc06p-26, -0x1p-3, -0x1.640838p-6, --0x1.fa7558p-1, -0x1.eeb5d2p-30, -0x1p-3, -0x1.788512p-5, --0x1.f8765p-1, -0x1.63ad16p-27, -0x1p-3, --0x1.c1d1fp-5, --0x1.f6297cp-1, --0x1.feeb96p-26, -0x1p-2, --0x1.fa3ecap-6, --0x1.f38f3ap-1, --0x1.8c9cb2p-26, -0x1p-2, --0x1.cc0d0ap-8, --0x1.f0a7fp-1, -0x1.1b73cap-27, -0x1p-2, -0x1.11d262p-6, --0x1.ed740ep-1, --0x1.da1258p-27, -0x1p-2, -0x1.4a0318p-5, --0x1.e9f416p-1, -0x1.273a44p-26, -0x1p-2, -0x1.04d726p-4, --0x1.e6288ep-1, --0x1.891c22p-26, -0x1p-2, -0x1.63e69ep-4, --0x1.e2121p-1, --0x1.3da1bap-27, -0x1p-2, --0x1.1eef5ap-3, --0x1.ddb13cp-1, -0x1.2667b8p-26, -0x1p-1, --0x1.e08756p-4, --0x1.d906bcp-1, --0x1.e651a8p-26, -0x1p-1, --0x1.8421bp-4, --0x1.d4134ep-1, -0x1.d646d8p-26, -0x1p-1, --0x1.28bbfep-4, --0x1.ced7bp-1, -0x1.786712p-26, -0x1p-1, --0x1.9cc8b4p-5, --0x1.c954b2p-1, --0x1.3411f4p-29, -0x1p-1, --0x1.d4a2c8p-6, --0x1.c38b3p-1, -0x1.cfe84ap-26, -0x1p-1, --0x1.d16c9p-8, --0x1.bd7c0ap-1, --0x1.8df2a6p-26, -0x1p-1, -0x1.ce1e64p-7, --0x1.b72834p-1, --0x1.465b9p-27, -0x1p-1, -0x1.1eb354p-5, --0x1.b090a6p-1, -0x1.fabf8p-27, -0x1p-1, -0x1.c73b3ap-5, --0x1.a9b662p-1, --0x1.21d434p-26, -0x1p-1, -0x1.3682a6p-4, --0x1.a29a7ap-1, --0x1.189e08p-31, -0x1p-1, -0x1.87fbfep-4, --0x1.9b3e04p-1, --0x1.fce1dp-27, -0x1p-1, -0x1.d7fd14p-4, --0x1.93a224p-1, --0x1.324c8p-26, -0x1p-1, -0x1.133ccap-3, --0x1.8bc806p-1, --0x1.62a2e8p-26, -0x1p-1, -0x1.39b2aep-3, --0x1.83b0ep-1, --0x1.7ff2eep-26, -0x1p-1, -0x1.5f5a4ep-3, --0x1.7b5df2p-1, --0x1.3557d8p-28, -0x1p-1, -0x1.842dd6p-3, --0x1.72d084p-1, -0x1.02000ep-26, -0x1p-1, -0, --0x1.6a09e6p-1, --0x1.9fcef4p-27, -0, --0x1.1a5efap-2, --0x1.610b76p-1, -0x1.5c5a64p-26, -0x1p0, --0x1.09441cp-2, --0x1.57d694p-1, -0x1.6e626cp-26, -0x1p0, --0x1.f13c7ep-3, --0x1.4e6cacp-1, -0x1.070686p-27, -0x1p0, --0x1.d0dfe6p-3, --0x1.44cf32p-1, --0x1.424776p-27, -0x1p0, --0x1.b1776ep-3, --0x1.3affa2p-1, --0x1.240a18p-26, -0x1p0, --0x1.9307eep-3, --0x1.30ff8p-1, -0x1.8f47e6p-28, -0x1p0, --0x1.759618p-3, --0x1.26d054p-1, --0x1.9ba25cp-26, -0x1p0, --0x1.592676p-3, --0x1.1c73b4p-1, -0x1.9465cep-27, -0x1p0, --0x1.3dbd6ap-3, --0x1.11eb36p-1, -0x1.7c969cp-26, -0x1p0, --0x1.235f2ep-3, --0x1.07387ap-1, -0x1.b74004p-27, -0x1p0, --0x1.0a0fd4p-3, --0x1.f8ba4ep-2, -0x1.01d952p-28, -0x1p0, --0x1.e3a688p-4, --0x1.e2b5d4p-2, -0x1.fe4272p-28, -0x1p0, --0x1.b55a7p-4, --0x1.cc66eap-2, -0x1.b38ee8p-28, -0x1p0, --0x1.894286p-4, --0x1.b5d1p-2, --0x1.3c2b98p-27, -0x1p0, --0x1.5f6598p-4, --0x1.9ef794p-2, --0x1.d476c6p-29, -0x1p0, --0x1.37ca18p-4, --0x1.87de2ap-2, --0x1.abaa58p-28, -0x1p0, --0x1.127624p-4, --0x1.708854p-2, -0x1.e0b74cp-27, -0x1p0, --0x1.dedefcp-5, --0x1.58f9a8p-2, -0x1.4a9c04p-27, -0x1p0, --0x1.9d7714p-5, --0x1.4135cap-2, -0x1.7d134p-27, -0x1p0, --0x1.60beaap-5, --0x1.294062p-2, --0x1.dab3ep-27, -0x1p0, --0x1.28bf18p-5, --0x1.111d26p-2, --0x1.58fb3cp-29, -0x1p0, --0x1.eb0208p-6, --0x1.f19f98p-3, -0x1.37a83ap-29, -0x1p0, --0x1.8e18a8p-6, --0x1.c0b826p-3, --0x1.4fc9ecp-28, -0x1p0, --0x1.3ad06p-6, --0x1.8f8b84p-3, -0x1.cb2cfap-30, -0x1p0, --0x1.e26c16p-7, --0x1.5e2144p-3, --0x1.22cff2p-29, -0x1p0, --0x1.62aa04p-7, --0x1.2c8106p-3, --0x1.d1cc28p-28, -0x1p0, --0x1.ecdc78p-8, --0x1.f564e6p-4, -0x1.2ad19ep-29, -0x1p0, --0x1.3b92e2p-8, --0x1.917a6cp-4, -0x1.eb25eap-31, -0x1p0, --0x1.63253p-9, --0x1.2d520ap-4, -0x1.a63cc2p-29, -0x1p0, --0x1.3bc39p-10, --0x1.91f66p-5, -0x1.de44fep-30, -0x1p0, --0x1.3bcfbep-12, --0x1.92156p-6, -0x1.0b933p-31, -0x1p0, -0, -0, -0, -0x1p0, --0x1.3bcfbep-12, -0x1.92156p-6, --0x1.0b933p-31, -0x1p0, --0x1.3bc39p-10, -0x1.91f66p-5, --0x1.de44fep-30, -0x1p0, --0x1.63253p-9, -0x1.2d520ap-4, --0x1.a63cc2p-29, -0x1p0, --0x1.3b92e2p-8, -0x1.917a6cp-4, --0x1.eb25eap-31, -0x1p0, --0x1.ecdc78p-8, -0x1.f564e6p-4, --0x1.2ad19ep-29, -0x1p0, --0x1.62aa04p-7, -0x1.2c8106p-3, -0x1.d1cc28p-28, -0x1p0, --0x1.e26c16p-7, -0x1.5e2144p-3, -0x1.22cff2p-29, -0x1p0, --0x1.3ad06p-6, -0x1.8f8b84p-3, --0x1.cb2cfap-30, -0x1p0, --0x1.8e18a8p-6, -0x1.c0b826p-3, -0x1.4fc9ecp-28, -0x1p0, --0x1.eb0208p-6, -0x1.f19f98p-3, --0x1.37a83ap-29, -0x1p0, --0x1.28bf18p-5, -0x1.111d26p-2, -0x1.58fb3cp-29, -0x1p0, --0x1.60beaap-5, -0x1.294062p-2, -0x1.dab3ep-27, -0x1p0, --0x1.9d7714p-5, -0x1.4135cap-2, --0x1.7d134p-27, -0x1p0, --0x1.dedefcp-5, -0x1.58f9a8p-2, --0x1.4a9c04p-27, -0x1p0, --0x1.127624p-4, -0x1.708854p-2, --0x1.e0b74cp-27, -0x1p0, --0x1.37ca18p-4, -0x1.87de2ap-2, -0x1.abaa58p-28, -0x1p0, --0x1.5f6598p-4, -0x1.9ef794p-2, -0x1.d476c6p-29, -0x1p0, --0x1.894286p-4, -0x1.b5d1p-2, -0x1.3c2b98p-27, -0x1p0, --0x1.b55a7p-4, -0x1.cc66eap-2, --0x1.b38ee8p-28, -0x1p0, --0x1.e3a688p-4, -0x1.e2b5d4p-2, --0x1.fe4272p-28, -0x1p0, --0x1.0a0fd4p-3, -0x1.f8ba4ep-2, --0x1.01d952p-28, -0x1p0, --0x1.235f2ep-3, -0x1.07387ap-1, --0x1.b74004p-27, -0x1p0, --0x1.3dbd6ap-3, -0x1.11eb36p-1, --0x1.7c969cp-26, -0x1p0, --0x1.592676p-3, -0x1.1c73b4p-1, --0x1.9465cep-27, -0x1p0, --0x1.759618p-3, -0x1.26d054p-1, -0x1.9ba25cp-26, -0x1p0, --0x1.9307eep-3, -0x1.30ff8p-1, --0x1.8f47e6p-28, -0x1p0, --0x1.b1776ep-3, -0x1.3affa2p-1, -0x1.240a18p-26, -0x1p0, --0x1.d0dfe6p-3, -0x1.44cf32p-1, -0x1.424776p-27, -0x1p0, --0x1.f13c7ep-3, -0x1.4e6cacp-1, --0x1.070686p-27, -0x1p0, --0x1.09441cp-2, -0x1.57d694p-1, --0x1.6e626cp-26, -0x1p0, --0x1.1a5efap-2, -0x1.610b76p-1, --0x1.5c5a64p-26, -0x1p0, -0, -0x1.6a09e6p-1, -0x1.9fcef4p-27, -0, -0x1.842dd6p-3, -0x1.72d084p-1, --0x1.02000ep-26, -0x1p-1, -0x1.5f5a4ep-3, -0x1.7b5df2p-1, -0x1.3557d8p-28, -0x1p-1, -0x1.39b2aep-3, -0x1.83b0ep-1, -0x1.7ff2eep-26, -0x1p-1, -0x1.133ccap-3, -0x1.8bc806p-1, -0x1.62a2e8p-26, -0x1p-1, -0x1.d7fd14p-4, -0x1.93a224p-1, -0x1.324c8p-26, -0x1p-1, -0x1.87fbfep-4, -0x1.9b3e04p-1, -0x1.fce1dp-27, -0x1p-1, -0x1.3682a6p-4, -0x1.a29a7ap-1, -0x1.189e08p-31, -0x1p-1, -0x1.c73b3ap-5, -0x1.a9b662p-1, -0x1.21d434p-26, -0x1p-1, -0x1.1eb354p-5, -0x1.b090a6p-1, --0x1.fabf8p-27, -0x1p-1, -0x1.ce1e64p-7, -0x1.b72834p-1, -0x1.465b9p-27, -0x1p-1, --0x1.d16c9p-8, -0x1.bd7c0ap-1, -0x1.8df2a6p-26, -0x1p-1, --0x1.d4a2c8p-6, -0x1.c38b3p-1, --0x1.cfe84ap-26, -0x1p-1, --0x1.9cc8b4p-5, -0x1.c954b2p-1, -0x1.3411f4p-29, -0x1p-1, --0x1.28bbfep-4, -0x1.ced7bp-1, --0x1.786712p-26, -0x1p-1, --0x1.8421bp-4, -0x1.d4134ep-1, --0x1.d646d8p-26, -0x1p-1, --0x1.e08756p-4, -0x1.d906bcp-1, -0x1.e651a8p-26, -0x1p-1, --0x1.1eef5ap-3, -0x1.ddb13cp-1, --0x1.2667b8p-26, -0x1p-1, -0x1.63e69ep-4, -0x1.e2121p-1, -0x1.3da1bap-27, -0x1p-2, -0x1.04d726p-4, -0x1.e6288ep-1, -0x1.891c22p-26, -0x1p-2, -0x1.4a0318p-5, -0x1.e9f416p-1, --0x1.273a44p-26, -0x1p-2, -0x1.11d262p-6, -0x1.ed740ep-1, -0x1.da1258p-27, -0x1p-2, --0x1.cc0d0ap-8, -0x1.f0a7fp-1, --0x1.1b73cap-27, -0x1p-2, --0x1.fa3ecap-6, -0x1.f38f3ap-1, -0x1.8c9cb2p-26, -0x1p-2, --0x1.c1d1fp-5, -0x1.f6297cp-1, -0x1.feeb96p-26, -0x1p-2, -0x1.788512p-5, -0x1.f8765p-1, --0x1.63ad16p-27, -0x1p-3, -0x1.640838p-6, -0x1.fa7558p-1, --0x1.eeb5d2p-30, -0x1p-3, --0x1.536352p-9, -0x1.fc2648p-1, --0x1.e3cc06p-26, -0x1p-3, --0x1.ba165p-6, -0x1.fd88dap-1, -0x1.e89292p-28, -0x1p-3, -0x1.6a904ap-7, -0x1.fe9cdap-1, -0x1.a03108p-26, -0x1p-4, --0x1.b82684p-7, -0x1.ff621ep-1, -0x1.bcb6bep-28, -0x1p-4, --0x1.b7aa82p-8, -0x1.ffd886p-1, -0x1.099a1ap-30, -0x1p-5 -}; -template <> HWY_ALIGN constexpr uint64_t kLargeReductionTable[] = { -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x1ULL, -0x0ULL, -0x0ULL, -0x2ULL, -0x0ULL, -0x0ULL, -0x5ULL, -0x0ULL, -0x0ULL, -0xaULL, -0x0ULL, -0x0ULL, -0x14ULL, -0x0ULL, -0x0ULL, -0x28ULL, -0x0ULL, -0x0ULL, -0x51ULL, -0x0ULL, -0x0ULL, -0xa2ULL, -0x0ULL, -0x0ULL, -0x145ULL, -0x0ULL, -0x0ULL, -0x28bULL, -0x0ULL, -0x0ULL, -0x517ULL, -0x0ULL, -0x0ULL, -0xa2fULL, -0x0ULL, -0x0ULL, -0x145fULL, -0x0ULL, -0x0ULL, -0x28beULL, -0x0ULL, -0x0ULL, -0x517cULL, -0x0ULL, -0x0ULL, -0xa2f9ULL, -0x0ULL, -0x0ULL, -0x145f3ULL, -0x0ULL, -0x0ULL, -0x28be6ULL, -0x0ULL, -0x0ULL, -0x517ccULL, -0x0ULL, -0x0ULL, -0xa2f98ULL, -0x0ULL, -0x0ULL, -0x145f30ULL, -0x0ULL, -0x0ULL, -0x28be60ULL, -0x0ULL, -0x0ULL, -0x517cc1ULL, -0x0ULL, -0x0ULL, -0xa2f983ULL, -0x0ULL, -0x0ULL, -0x145f306ULL, -0x0ULL, -0x0ULL, -0x28be60dULL, -0x0ULL, -0x0ULL, -0x517cc1bULL, -0x0ULL, -0x0ULL, -0xa2f9836ULL, -0x0ULL, -0x0ULL, -0x145f306dULL, -0x0ULL, -0x0ULL, -0x28be60dbULL, -0x0ULL, -0x0ULL, -0x517cc1b7ULL, -0x0ULL, -0x0ULL, -0xa2f9836eULL, -0x0ULL, -0x0ULL, -0x145f306dcULL, -0x0ULL, -0x0ULL, -0x28be60db9ULL, -0x0ULL, -0x0ULL, -0x517cc1b72ULL, -0x0ULL, -0x0ULL, -0xa2f9836e4ULL, -0x0ULL, -0x0ULL, -0x145f306dc9ULL, -0x0ULL, -0x0ULL, -0x28be60db93ULL, -0x0ULL, -0x0ULL, -0x517cc1b727ULL, -0x0ULL, -0x0ULL, -0xa2f9836e4eULL, -0x0ULL, -0x0ULL, -0x145f306dc9cULL, -0x0ULL, -0x0ULL, -0x28be60db939ULL, -0x0ULL, -0x0ULL, -0x517cc1b7272ULL, -0x0ULL, -0x0ULL, -0xa2f9836e4e4ULL, -0x0ULL, -0x0ULL, -0x145f306dc9c8ULL, -0x0ULL, -0x0ULL, -0x28be60db9391ULL, -0x0ULL, -0x0ULL, -0x517cc1b72722ULL, -0x0ULL, -0x0ULL, -0xa2f9836e4e44ULL, -0x0ULL, -0x0ULL, -0x145f306dc9c88ULL, -0x0ULL, -0x0ULL, -0x28be60db93910ULL, -0x0ULL, -0x0ULL, -0x517cc1b727220ULL, -0x0ULL, -0x0ULL, -0xa2f9836e4e441ULL, -0x0ULL, -0x0ULL, -0x145f306dc9c882ULL, -0x0ULL, -0x0ULL, -0x28be60db939105ULL, -0x0ULL, -0x0ULL, -0x517cc1b727220aULL, -0x0ULL, -0x0ULL, -0xa2f9836e4e4415ULL, -0x0ULL, -0x0ULL, -0x145f306dc9c882aULL, -0x0ULL, -0x0ULL, -0x28be60db9391054ULL, -0x0ULL, -0x0ULL, -0x517cc1b727220a9ULL, -0x0ULL, -0x0ULL, -0xa2f9836e4e44152ULL, -0x0ULL, -0x0ULL, -0x145f306dc9c882a5ULL, -0x0ULL, -0x0ULL, -0x28be60db9391054aULL, -0x0ULL, -0x0ULL, -0x517cc1b727220a94ULL, -0x0ULL, -0x0ULL, -0xa2f9836e4e441529ULL, -0x0ULL, -0x1ULL, -0x45f306dc9c882a53ULL, -0x0ULL, -0x2ULL, -0x8be60db9391054a7ULL, -0x0ULL, -0x5ULL, -0x17cc1b727220a94fULL, -0x0ULL, -0xaULL, -0x2f9836e4e441529fULL, -0x0ULL, -0x14ULL, -0x5f306dc9c882a53fULL, -0x0ULL, -0x28ULL, -0xbe60db9391054a7fULL, -0x0ULL, -0x51ULL, -0x7cc1b727220a94feULL, -0x0ULL, -0xa2ULL, -0xf9836e4e441529fcULL, -0x0ULL, -0x145ULL, -0xf306dc9c882a53f8ULL, -0x0ULL, -0x28bULL, -0xe60db9391054a7f0ULL, -0x0ULL, -0x517ULL, -0xcc1b727220a94fe1ULL, -0x0ULL, -0xa2fULL, -0x9836e4e441529fc2ULL, -0x0ULL, -0x145fULL, -0x306dc9c882a53f84ULL, -0x0ULL, -0x28beULL, -0x60db9391054a7f09ULL, -0x0ULL, -0x517cULL, -0xc1b727220a94fe13ULL, -0x0ULL, -0xa2f9ULL, -0x836e4e441529fc27ULL, -0x0ULL, -0x145f3ULL, -0x6dc9c882a53f84eULL, -0x0ULL, -0x28be6ULL, -0xdb9391054a7f09dULL, -0x0ULL, -0x517ccULL, -0x1b727220a94fe13aULL, -0x0ULL, -0xa2f98ULL, -0x36e4e441529fc275ULL, -0x0ULL, -0x145f30ULL, -0x6dc9c882a53f84eaULL, -0x0ULL, -0x28be60ULL, -0xdb9391054a7f09d5ULL, -0x0ULL, -0x517cc1ULL, -0xb727220a94fe13abULL, -0x0ULL, -0xa2f983ULL, -0x6e4e441529fc2757ULL, -0x0ULL, -0x145f306ULL, -0xdc9c882a53f84eafULL, -0x0ULL, -0x28be60dULL, -0xb9391054a7f09d5fULL, -0x0ULL, -0x517cc1bULL, -0x727220a94fe13abeULL, -0x0ULL, -0xa2f9836ULL, -0xe4e441529fc2757dULL, -0x0ULL, -0x145f306dULL, -0xc9c882a53f84eafaULL, -0x0ULL, -0x28be60dbULL, -0x9391054a7f09d5f4ULL, -0x0ULL, -0x517cc1b7ULL, -0x27220a94fe13abe8ULL, -0x0ULL, -0xa2f9836eULL, -0x4e441529fc2757d1ULL, -0x0ULL, -0x145f306dcULL, -0x9c882a53f84eafa3ULL, -0x0ULL, -0x28be60db9ULL, -0x391054a7f09d5f47ULL, -0x0ULL, -0x517cc1b72ULL, -0x7220a94fe13abe8fULL, -0x0ULL, -0xa2f9836e4ULL, -0xe441529fc2757d1fULL, -0x0ULL, -0x145f306dc9ULL, -0xc882a53f84eafa3eULL, -0x0ULL, -0x28be60db93ULL, -0x91054a7f09d5f47dULL, -0x0ULL, -0x517cc1b727ULL, -0x220a94fe13abe8faULL, -0x0ULL, -0xa2f9836e4eULL, -0x441529fc2757d1f5ULL, -0x0ULL, -0x145f306dc9cULL, -0x882a53f84eafa3eaULL, -0x0ULL, -0x28be60db939ULL, -0x1054a7f09d5f47d4ULL, -0x0ULL, -0x517cc1b7272ULL, -0x20a94fe13abe8fa9ULL, -0x0ULL, -0xa2f9836e4e4ULL, -0x41529fc2757d1f53ULL, -0x0ULL, -0x145f306dc9c8ULL, -0x82a53f84eafa3ea6ULL, -0x0ULL, -0x28be60db9391ULL, -0x54a7f09d5f47d4dULL, -0x0ULL, -0x517cc1b72722ULL, -0xa94fe13abe8fa9aULL, -0x0ULL, -0xa2f9836e4e44ULL, -0x1529fc2757d1f534ULL, -0x0ULL, -0x145f306dc9c88ULL, -0x2a53f84eafa3ea69ULL, -0x0ULL, -0x28be60db93910ULL, -0x54a7f09d5f47d4d3ULL, -0x0ULL, -0x517cc1b727220ULL, -0xa94fe13abe8fa9a6ULL, -0x0ULL, -0xa2f9836e4e441ULL, -0x529fc2757d1f534dULL, -0x0ULL, -0x145f306dc9c882ULL, -0xa53f84eafa3ea69bULL, -0x0ULL, -0x28be60db939105ULL, -0x4a7f09d5f47d4d37ULL, -0x0ULL, -0x517cc1b727220aULL, -0x94fe13abe8fa9a6eULL, -0x0ULL, -0xa2f9836e4e4415ULL, -0x29fc2757d1f534ddULL, -0x0ULL, -0x145f306dc9c882aULL, -0x53f84eafa3ea69bbULL, -0x0ULL, -0x28be60db9391054ULL, -0xa7f09d5f47d4d377ULL, -0x0ULL, -0x517cc1b727220a9ULL, -0x4fe13abe8fa9a6eeULL, -0x0ULL, -0xa2f9836e4e44152ULL, -0x9fc2757d1f534ddcULL, -0x0ULL, -0x145f306dc9c882a5ULL, -0x3f84eafa3ea69bb8ULL, -0x0ULL, -0x28be60db9391054aULL, -0x7f09d5f47d4d3770ULL, -0x0ULL, -0x517cc1b727220a94ULL, -0xfe13abe8fa9a6ee0ULL, -0x0ULL, -0xa2f9836e4e441529ULL, -0xfc2757d1f534ddc0ULL, -0x1ULL, -0x45f306dc9c882a53ULL, -0xf84eafa3ea69bb81ULL, -0x2ULL, -0x8be60db9391054a7ULL, -0xf09d5f47d4d37703ULL, -0x5ULL, -0x17cc1b727220a94fULL, -0xe13abe8fa9a6ee06ULL, -0xaULL, -0x2f9836e4e441529fULL, -0xc2757d1f534ddc0dULL, -0x14ULL, -0x5f306dc9c882a53fULL, -0x84eafa3ea69bb81bULL, -0x28ULL, -0xbe60db9391054a7fULL, -0x9d5f47d4d377036ULL, -0x51ULL, -0x7cc1b727220a94feULL, -0x13abe8fa9a6ee06dULL, -0xa2ULL, -0xf9836e4e441529fcULL, -0x2757d1f534ddc0dbULL, -0x145ULL, -0xf306dc9c882a53f8ULL, -0x4eafa3ea69bb81b6ULL, -0x28bULL, -0xe60db9391054a7f0ULL, -0x9d5f47d4d377036dULL, -0x517ULL, -0xcc1b727220a94fe1ULL, -0x3abe8fa9a6ee06dbULL, -0xa2fULL, -0x9836e4e441529fc2ULL, -0x757d1f534ddc0db6ULL, -0x145fULL, -0x306dc9c882a53f84ULL, -0xeafa3ea69bb81b6cULL, -0x28beULL, -0x60db9391054a7f09ULL, -0xd5f47d4d377036d8ULL, -0x517cULL, -0xc1b727220a94fe13ULL, -0xabe8fa9a6ee06db1ULL, -0xa2f9ULL, -0x836e4e441529fc27ULL, -0x57d1f534ddc0db62ULL, -0x145f3ULL, -0x6dc9c882a53f84eULL, -0xafa3ea69bb81b6c5ULL, -0x28be6ULL, -0xdb9391054a7f09dULL, -0x5f47d4d377036d8aULL, -0x517ccULL, -0x1b727220a94fe13aULL, -0xbe8fa9a6ee06db14ULL, -0xa2f98ULL, -0x36e4e441529fc275ULL, -0x7d1f534ddc0db629ULL, -0x145f30ULL, -0x6dc9c882a53f84eaULL, -0xfa3ea69bb81b6c52ULL, -0x28be60ULL, -0xdb9391054a7f09d5ULL, -0xf47d4d377036d8a5ULL, -0x517cc1ULL, -0xb727220a94fe13abULL, -0xe8fa9a6ee06db14aULL, -0xa2f983ULL, -0x6e4e441529fc2757ULL, -0xd1f534ddc0db6295ULL, -0x145f306ULL, -0xdc9c882a53f84eafULL, -0xa3ea69bb81b6c52bULL, -0x28be60dULL, -0xb9391054a7f09d5fULL, -0x47d4d377036d8a56ULL, -0x517cc1bULL, -0x727220a94fe13abeULL, -0x8fa9a6ee06db14acULL, -0xa2f9836ULL, -0xe4e441529fc2757dULL, -0x1f534ddc0db62959ULL, -0x145f306dULL, -0xc9c882a53f84eafaULL, -0x3ea69bb81b6c52b3ULL, -0x28be60dbULL, -0x9391054a7f09d5f4ULL, -0x7d4d377036d8a566ULL, -0x517cc1b7ULL, -0x27220a94fe13abe8ULL, -0xfa9a6ee06db14accULL, -0xa2f9836eULL, -0x4e441529fc2757d1ULL, -0xf534ddc0db629599ULL, -0x145f306dcULL, -0x9c882a53f84eafa3ULL, -0xea69bb81b6c52b32ULL, -0x28be60db9ULL, -0x391054a7f09d5f47ULL, -0xd4d377036d8a5664ULL, -0x517cc1b72ULL, -0x7220a94fe13abe8fULL, -0xa9a6ee06db14acc9ULL, -0xa2f9836e4ULL, -0xe441529fc2757d1fULL, -0x534ddc0db6295993ULL, -0x145f306dc9ULL, -0xc882a53f84eafa3eULL, -0xa69bb81b6c52b327ULL, -0x28be60db93ULL, -0x91054a7f09d5f47dULL, -0x4d377036d8a5664fULL, -0x517cc1b727ULL, -0x220a94fe13abe8faULL, -0x9a6ee06db14acc9eULL, -0xa2f9836e4eULL, -0x441529fc2757d1f5ULL, -0x34ddc0db6295993cULL, -0x145f306dc9cULL, -0x882a53f84eafa3eaULL, -0x69bb81b6c52b3278ULL, -0x28be60db939ULL, -0x1054a7f09d5f47d4ULL, -0xd377036d8a5664f1ULL, -0x517cc1b7272ULL, -0x20a94fe13abe8fa9ULL, -0xa6ee06db14acc9e2ULL, -0xa2f9836e4e4ULL, -0x41529fc2757d1f53ULL, -0x4ddc0db6295993c4ULL, -0x145f306dc9c8ULL, -0x82a53f84eafa3ea6ULL, -0x9bb81b6c52b32788ULL, -0x28be60db9391ULL, -0x54a7f09d5f47d4dULL, -0x377036d8a5664f10ULL, -0x517cc1b72722ULL, -0xa94fe13abe8fa9aULL, -0x6ee06db14acc9e21ULL, -0xa2f9836e4e44ULL, -0x1529fc2757d1f534ULL, -0xddc0db6295993c43ULL, -0x145f306dc9c88ULL, -0x2a53f84eafa3ea69ULL, -0xbb81b6c52b327887ULL, -0x28be60db93910ULL, -0x54a7f09d5f47d4d3ULL, -0x77036d8a5664f10eULL, -0x517cc1b727220ULL, -0xa94fe13abe8fa9a6ULL, -0xee06db14acc9e21cULL, -0xa2f9836e4e441ULL, -0x529fc2757d1f534dULL, -0xdc0db6295993c439ULL, -0x145f306dc9c882ULL, -0xa53f84eafa3ea69bULL, -0xb81b6c52b3278872ULL, -0x28be60db939105ULL, -0x4a7f09d5f47d4d37ULL, -0x7036d8a5664f10e4ULL, -0x517cc1b727220aULL, -0x94fe13abe8fa9a6eULL, -0xe06db14acc9e21c8ULL, -0xa2f9836e4e4415ULL, -0x29fc2757d1f534ddULL, -0xc0db6295993c4390ULL, -0x145f306dc9c882aULL, -0x53f84eafa3ea69bbULL, -0x81b6c52b32788720ULL, -0x28be60db9391054ULL, -0xa7f09d5f47d4d377ULL, -0x36d8a5664f10e41ULL, -0x517cc1b727220a9ULL, -0x4fe13abe8fa9a6eeULL, -0x6db14acc9e21c82ULL, -0xa2f9836e4e44152ULL, -0x9fc2757d1f534ddcULL, -0xdb6295993c43904ULL, -0x145f306dc9c882a5ULL, -0x3f84eafa3ea69bb8ULL, -0x1b6c52b327887208ULL, -0x28be60db9391054aULL, -0x7f09d5f47d4d3770ULL, -0x36d8a5664f10e410ULL, -0x517cc1b727220a94ULL, -0xfe13abe8fa9a6ee0ULL, -0x6db14acc9e21c820ULL, -0xa2f9836e4e441529ULL, -0xfc2757d1f534ddc0ULL, -0xdb6295993c439041ULL, -0x45f306dc9c882a53ULL, -0xf84eafa3ea69bb81ULL, -0xb6c52b3278872083ULL, -0x8be60db9391054a7ULL, -0xf09d5f47d4d37703ULL, -0x6d8a5664f10e4107ULL, -0x17cc1b727220a94fULL, -0xe13abe8fa9a6ee06ULL, -0xdb14acc9e21c820fULL, -0x2f9836e4e441529fULL, -0xc2757d1f534ddc0dULL, -0xb6295993c439041fULL, -0x5f306dc9c882a53fULL, -0x84eafa3ea69bb81bULL, -0x6c52b3278872083fULL, -0xbe60db9391054a7fULL, -0x9d5f47d4d377036ULL, -0xd8a5664f10e4107fULL, -0x7cc1b727220a94feULL, -0x13abe8fa9a6ee06dULL, -0xb14acc9e21c820ffULL, -0xf9836e4e441529fcULL, -0x2757d1f534ddc0dbULL, -0x6295993c439041feULL, -0xf306dc9c882a53f8ULL, -0x4eafa3ea69bb81b6ULL, -0xc52b3278872083fcULL, -0xe60db9391054a7f0ULL, -0x9d5f47d4d377036dULL, -0x8a5664f10e4107f9ULL, -0xcc1b727220a94fe1ULL, -0x3abe8fa9a6ee06dbULL, -0x14acc9e21c820ff2ULL, -0x9836e4e441529fc2ULL, -0x757d1f534ddc0db6ULL, -0x295993c439041fe5ULL, -0x306dc9c882a53f84ULL, -0xeafa3ea69bb81b6cULL, -0x52b3278872083fcaULL, -0x60db9391054a7f09ULL, -0xd5f47d4d377036d8ULL, -0xa5664f10e4107f94ULL, -0xc1b727220a94fe13ULL, -0xabe8fa9a6ee06db1ULL, -0x4acc9e21c820ff28ULL, -0x836e4e441529fc27ULL, -0x57d1f534ddc0db62ULL, -0x95993c439041fe51ULL, -0x6dc9c882a53f84eULL, -0xafa3ea69bb81b6c5ULL, -0x2b3278872083fca2ULL, -0xdb9391054a7f09dULL, -0x5f47d4d377036d8aULL, -0x5664f10e4107f945ULL, -0x1b727220a94fe13aULL, -0xbe8fa9a6ee06db14ULL, -0xacc9e21c820ff28bULL, -0x36e4e441529fc275ULL, -0x7d1f534ddc0db629ULL, -0x5993c439041fe516ULL, -0x6dc9c882a53f84eaULL, -0xfa3ea69bb81b6c52ULL, -0xb3278872083fca2cULL, -0xdb9391054a7f09d5ULL, -0xf47d4d377036d8a5ULL, -0x664f10e4107f9458ULL, -0xb727220a94fe13abULL, -0xe8fa9a6ee06db14aULL, -0xcc9e21c820ff28b1ULL, -0x6e4e441529fc2757ULL, -0xd1f534ddc0db6295ULL, -0x993c439041fe5163ULL, -0xdc9c882a53f84eafULL, -0xa3ea69bb81b6c52bULL, -0x3278872083fca2c7ULL, -0xb9391054a7f09d5fULL, -0x47d4d377036d8a56ULL, -0x64f10e4107f9458eULL, -0x727220a94fe13abeULL, -0x8fa9a6ee06db14acULL, -0xc9e21c820ff28b1dULL, -0xe4e441529fc2757dULL, -0x1f534ddc0db62959ULL, -0x93c439041fe5163aULL, -0xc9c882a53f84eafaULL, -0x3ea69bb81b6c52b3ULL, -0x278872083fca2c75ULL, -0x9391054a7f09d5f4ULL, -0x7d4d377036d8a566ULL, -0x4f10e4107f9458eaULL, -0x27220a94fe13abe8ULL, -0xfa9a6ee06db14accULL, -0x9e21c820ff28b1d5ULL, -0x4e441529fc2757d1ULL, -0xf534ddc0db629599ULL, -0x3c439041fe5163abULL, -0x9c882a53f84eafa3ULL, -0xea69bb81b6c52b32ULL, -0x78872083fca2c757ULL, -0x391054a7f09d5f47ULL, -0xd4d377036d8a5664ULL, -0xf10e4107f9458eafULL, -0x7220a94fe13abe8fULL, -0xa9a6ee06db14acc9ULL, -0xe21c820ff28b1d5eULL, -0xe441529fc2757d1fULL, -0x534ddc0db6295993ULL, -0xc439041fe5163abdULL, -0xc882a53f84eafa3eULL, -0xa69bb81b6c52b327ULL, -0x8872083fca2c757bULL, -0x91054a7f09d5f47dULL, -0x4d377036d8a5664fULL, -0x10e4107f9458eaf7ULL, -0x220a94fe13abe8faULL, -0x9a6ee06db14acc9eULL, -0x21c820ff28b1d5efULL, -0x441529fc2757d1f5ULL, -0x34ddc0db6295993cULL, -0x439041fe5163abdeULL, -0x882a53f84eafa3eaULL, -0x69bb81b6c52b3278ULL, -0x872083fca2c757bdULL, -0x1054a7f09d5f47d4ULL, -0xd377036d8a5664f1ULL, -0xe4107f9458eaf7aULL, -0x20a94fe13abe8fa9ULL, -0xa6ee06db14acc9e2ULL, -0x1c820ff28b1d5ef5ULL, -0x41529fc2757d1f53ULL, -0x4ddc0db6295993c4ULL, -0x39041fe5163abdebULL, -0x82a53f84eafa3ea6ULL, -0x9bb81b6c52b32788ULL, -0x72083fca2c757bd7ULL, -0x54a7f09d5f47d4dULL, -0x377036d8a5664f10ULL, -0xe4107f9458eaf7aeULL, -0xa94fe13abe8fa9aULL, -0x6ee06db14acc9e21ULL, -0xc820ff28b1d5ef5dULL, -0x1529fc2757d1f534ULL, -0xddc0db6295993c43ULL, -0x9041fe5163abdebbULL, -0x2a53f84eafa3ea69ULL, -0xbb81b6c52b327887ULL, -0x2083fca2c757bd77ULL, -0x54a7f09d5f47d4d3ULL, -0x77036d8a5664f10eULL, -0x4107f9458eaf7aefULL, -0xa94fe13abe8fa9a6ULL, -0xee06db14acc9e21cULL, -0x820ff28b1d5ef5deULL, -0x529fc2757d1f534dULL, -0xdc0db6295993c439ULL, -0x41fe5163abdebbcULL, -0xa53f84eafa3ea69bULL, -0xb81b6c52b3278872ULL, -0x83fca2c757bd778ULL, -0x4a7f09d5f47d4d37ULL, -0x7036d8a5664f10e4ULL, -0x107f9458eaf7aef1ULL, -0x94fe13abe8fa9a6eULL, -0xe06db14acc9e21c8ULL, -0x20ff28b1d5ef5de2ULL, -0x29fc2757d1f534ddULL, -0xc0db6295993c4390ULL, -0x41fe5163abdebbc5ULL, -0x53f84eafa3ea69bbULL, -0x81b6c52b32788720ULL, -0x83fca2c757bd778aULL, -0xa7f09d5f47d4d377ULL, -0x36d8a5664f10e41ULL, -0x7f9458eaf7aef15ULL, -0x4fe13abe8fa9a6eeULL, -0x6db14acc9e21c82ULL, -0xff28b1d5ef5de2bULL, -0x9fc2757d1f534ddcULL, -0xdb6295993c43904ULL, -0x1fe5163abdebbc56ULL, -0x3f84eafa3ea69bb8ULL, -0x1b6c52b327887208ULL, -0x3fca2c757bd778acULL, -0x7f09d5f47d4d3770ULL, -0x36d8a5664f10e410ULL, -0x7f9458eaf7aef158ULL, -0xfe13abe8fa9a6ee0ULL, -0x6db14acc9e21c820ULL, -0xff28b1d5ef5de2b0ULL, -0xfc2757d1f534ddc0ULL, -0xdb6295993c439041ULL, -0xfe5163abdebbc561ULL, -0xf84eafa3ea69bb81ULL, -0xb6c52b3278872083ULL, -0xfca2c757bd778ac3ULL, -0xf09d5f47d4d37703ULL, -0x6d8a5664f10e4107ULL, -0xf9458eaf7aef1586ULL, -0xe13abe8fa9a6ee06ULL, -0xdb14acc9e21c820fULL, -0xf28b1d5ef5de2b0dULL, -0xc2757d1f534ddc0dULL, -0xb6295993c439041fULL, -0xe5163abdebbc561bULL, -0x84eafa3ea69bb81bULL, -0x6c52b3278872083fULL, -0xca2c757bd778ac36ULL, -0x9d5f47d4d377036ULL, -0xd8a5664f10e4107fULL, -0x9458eaf7aef1586dULL, -0x13abe8fa9a6ee06dULL, -0xb14acc9e21c820ffULL, -0x28b1d5ef5de2b0dbULL, -0x2757d1f534ddc0dbULL, -0x6295993c439041feULL, -0x5163abdebbc561b7ULL, -0x4eafa3ea69bb81b6ULL, -0xc52b3278872083fcULL, -0xa2c757bd778ac36eULL, -0x9d5f47d4d377036dULL, -0x8a5664f10e4107f9ULL, -0x458eaf7aef1586dcULL, -0x3abe8fa9a6ee06dbULL, -0x14acc9e21c820ff2ULL, -0x8b1d5ef5de2b0db9ULL, -0x757d1f534ddc0db6ULL, -0x295993c439041fe5ULL, -0x163abdebbc561b72ULL, -0xeafa3ea69bb81b6cULL, -0x52b3278872083fcaULL, -0x2c757bd778ac36e4ULL, -0xd5f47d4d377036d8ULL, -0xa5664f10e4107f94ULL, -0x58eaf7aef1586dc9ULL, -0xabe8fa9a6ee06db1ULL, -0x4acc9e21c820ff28ULL, -0xb1d5ef5de2b0db92ULL, -0x57d1f534ddc0db62ULL, -0x95993c439041fe51ULL, -0x63abdebbc561b724ULL, -0xafa3ea69bb81b6c5ULL, -0x2b3278872083fca2ULL, -0xc757bd778ac36e48ULL, -0x5f47d4d377036d8aULL, -0x5664f10e4107f945ULL, -0x8eaf7aef1586dc91ULL, -0xbe8fa9a6ee06db14ULL, -0xacc9e21c820ff28bULL, -0x1d5ef5de2b0db923ULL, -0x7d1f534ddc0db629ULL, -0x5993c439041fe516ULL, -0x3abdebbc561b7246ULL, -0xfa3ea69bb81b6c52ULL, -0xb3278872083fca2cULL, -0x757bd778ac36e48dULL, -0xf47d4d377036d8a5ULL, -0x664f10e4107f9458ULL, -0xeaf7aef1586dc91bULL, -0xe8fa9a6ee06db14aULL, -0xcc9e21c820ff28b1ULL, -0xd5ef5de2b0db9237ULL, -0xd1f534ddc0db6295ULL, -0x993c439041fe5163ULL, -0xabdebbc561b7246eULL, -0xa3ea69bb81b6c52bULL, -0x3278872083fca2c7ULL, -0x57bd778ac36e48dcULL, -0x47d4d377036d8a56ULL, -0x64f10e4107f9458eULL, -0xaf7aef1586dc91b8ULL, -0x8fa9a6ee06db14acULL, -0xc9e21c820ff28b1dULL, -0x5ef5de2b0db92371ULL, -0x1f534ddc0db62959ULL, -0x93c439041fe5163aULL, -0xbdebbc561b7246e3ULL, -0x3ea69bb81b6c52b3ULL, -0x278872083fca2c75ULL, -0x7bd778ac36e48dc7ULL, -0x7d4d377036d8a566ULL, -0x4f10e4107f9458eaULL, -0xf7aef1586dc91b8eULL, -0xfa9a6ee06db14accULL, -0x9e21c820ff28b1d5ULL, -0xef5de2b0db92371dULL, -0xf534ddc0db629599ULL, -0x3c439041fe5163abULL, -0xdebbc561b7246e3aULL, -0xea69bb81b6c52b32ULL, -0x78872083fca2c757ULL, -0xbd778ac36e48dc74ULL, -0xd4d377036d8a5664ULL, -0xf10e4107f9458eafULL, -0x7aef1586dc91b8e9ULL, -0xa9a6ee06db14acc9ULL, -0xe21c820ff28b1d5eULL, -0xf5de2b0db92371d2ULL, -0x534ddc0db6295993ULL, -0xc439041fe5163abdULL, -0xebbc561b7246e3a4ULL, -0xa69bb81b6c52b327ULL, -0x8872083fca2c757bULL, -0xd778ac36e48dc748ULL, -0x4d377036d8a5664fULL, -0x10e4107f9458eaf7ULL, -0xaef1586dc91b8e90ULL, -0x9a6ee06db14acc9eULL, -0x21c820ff28b1d5efULL, -0x5de2b0db92371d21ULL, -0x34ddc0db6295993cULL, -0x439041fe5163abdeULL, -0xbbc561b7246e3a42ULL, -0x69bb81b6c52b3278ULL, -0x872083fca2c757bdULL, -0x778ac36e48dc7484ULL, -0xd377036d8a5664f1ULL, -0xe4107f9458eaf7aULL, -0xef1586dc91b8e909ULL, -0xa6ee06db14acc9e2ULL, -0x1c820ff28b1d5ef5ULL, -0xde2b0db92371d212ULL, -0x4ddc0db6295993c4ULL, -0x39041fe5163abdebULL, -0xbc561b7246e3a424ULL, -0x9bb81b6c52b32788ULL, -0x72083fca2c757bd7ULL, -0x78ac36e48dc74849ULL, -0x377036d8a5664f10ULL, -0xe4107f9458eaf7aeULL, -0xf1586dc91b8e9093ULL, -0x6ee06db14acc9e21ULL, -0xc820ff28b1d5ef5dULL, -0xe2b0db92371d2126ULL, -0xddc0db6295993c43ULL, -0x9041fe5163abdebbULL, -0xc561b7246e3a424dULL, -0xbb81b6c52b327887ULL, -0x2083fca2c757bd77ULL, -0x8ac36e48dc74849bULL, -0x77036d8a5664f10eULL, -0x4107f9458eaf7aefULL, -0x1586dc91b8e90937ULL, -0xee06db14acc9e21cULL, -0x820ff28b1d5ef5deULL, -0x2b0db92371d2126eULL, -0xdc0db6295993c439ULL, -0x41fe5163abdebbcULL, -0x561b7246e3a424ddULL, -0xb81b6c52b3278872ULL, -0x83fca2c757bd778ULL, -0xac36e48dc74849baULL, -0x7036d8a5664f10e4ULL, -0x107f9458eaf7aef1ULL, -0x586dc91b8e909374ULL, -0xe06db14acc9e21c8ULL, -0x20ff28b1d5ef5de2ULL, -0xb0db92371d2126e9ULL, -0xc0db6295993c4390ULL, -0x41fe5163abdebbc5ULL, -0x61b7246e3a424dd2ULL, -0x81b6c52b32788720ULL, -0x83fca2c757bd778aULL, -0xc36e48dc74849ba5ULL, -0x36d8a5664f10e41ULL, -0x7f9458eaf7aef15ULL, -0x86dc91b8e909374bULL, -0x6db14acc9e21c82ULL, -0xff28b1d5ef5de2bULL, -0xdb92371d2126e97ULL, -0xdb6295993c43904ULL, -0x1fe5163abdebbc56ULL, -0x1b7246e3a424dd2eULL, -0x1b6c52b327887208ULL, -0x3fca2c757bd778acULL, -0x36e48dc74849ba5cULL, -0x36d8a5664f10e410ULL, -0x7f9458eaf7aef158ULL, -0x6dc91b8e909374b8ULL, -0x6db14acc9e21c820ULL, -0xff28b1d5ef5de2b0ULL, -0xdb92371d2126e970ULL, -0xdb6295993c439041ULL, -0xfe5163abdebbc561ULL, -0xb7246e3a424dd2e0ULL, -0xb6c52b3278872083ULL, -0xfca2c757bd778ac3ULL, -0x6e48dc74849ba5c0ULL, -0x6d8a5664f10e4107ULL, -0xf9458eaf7aef1586ULL, -0xdc91b8e909374b80ULL, -0xdb14acc9e21c820fULL, -0xf28b1d5ef5de2b0dULL, -0xb92371d2126e9700ULL, -0xb6295993c439041fULL, -0xe5163abdebbc561bULL, -0x7246e3a424dd2e00ULL, -0x6c52b3278872083fULL, -0xca2c757bd778ac36ULL, -0xe48dc74849ba5c00ULL, -0xd8a5664f10e4107fULL, -0x9458eaf7aef1586dULL, -0xc91b8e909374b801ULL, -0xb14acc9e21c820ffULL, -0x28b1d5ef5de2b0dbULL, -0x92371d2126e97003ULL, -0x6295993c439041feULL, -0x5163abdebbc561b7ULL, -0x246e3a424dd2e006ULL, -0xc52b3278872083fcULL, -0xa2c757bd778ac36eULL, -0x48dc74849ba5c00cULL, -0x8a5664f10e4107f9ULL, -0x458eaf7aef1586dcULL, -0x91b8e909374b8019ULL, -0x14acc9e21c820ff2ULL, -0x8b1d5ef5de2b0db9ULL, -0x2371d2126e970032ULL, -0x295993c439041fe5ULL, -0x163abdebbc561b72ULL, -0x46e3a424dd2e0064ULL, -0x52b3278872083fcaULL, -0x2c757bd778ac36e4ULL, -0x8dc74849ba5c00c9ULL, -0xa5664f10e4107f94ULL, -0x58eaf7aef1586dc9ULL, -0x1b8e909374b80192ULL, -0x4acc9e21c820ff28ULL, -0xb1d5ef5de2b0db92ULL, -0x371d2126e9700324ULL, -0x95993c439041fe51ULL, -0x63abdebbc561b724ULL, -0x6e3a424dd2e00649ULL, -0x2b3278872083fca2ULL, -0xc757bd778ac36e48ULL, -0xdc74849ba5c00c92ULL, -0x5664f10e4107f945ULL, -0x8eaf7aef1586dc91ULL, -0xb8e909374b801924ULL, -0xacc9e21c820ff28bULL, -0x1d5ef5de2b0db923ULL, -0x71d2126e97003249ULL, -0x5993c439041fe516ULL, -0x3abdebbc561b7246ULL, -0xe3a424dd2e006492ULL, -0xb3278872083fca2cULL, -0x757bd778ac36e48dULL, -0xc74849ba5c00c925ULL, -0x664f10e4107f9458ULL, -0xeaf7aef1586dc91bULL, -0x8e909374b801924bULL, -0xcc9e21c820ff28b1ULL, -0xd5ef5de2b0db9237ULL, -0x1d2126e970032497ULL, -0x993c439041fe5163ULL, -0xabdebbc561b7246eULL, -0x3a424dd2e006492eULL, -0x3278872083fca2c7ULL, -0x57bd778ac36e48dcULL, -0x74849ba5c00c925dULL, -0x64f10e4107f9458eULL, -0xaf7aef1586dc91b8ULL, -0xe909374b801924bbULL, -0xc9e21c820ff28b1dULL, -0x5ef5de2b0db92371ULL, -0xd2126e9700324977ULL, -0x93c439041fe5163aULL, -0xbdebbc561b7246e3ULL, -0xa424dd2e006492eeULL, -0x278872083fca2c75ULL, -0x7bd778ac36e48dc7ULL, -0x4849ba5c00c925ddULL, -0x4f10e4107f9458eaULL, -0xf7aef1586dc91b8eULL, -0x909374b801924bbaULL, -0x9e21c820ff28b1d5ULL, -0xef5de2b0db92371dULL, -0x2126e97003249775ULL, -0x3c439041fe5163abULL, -0xdebbc561b7246e3aULL, -0x424dd2e006492eeaULL, -0x78872083fca2c757ULL, -0xbd778ac36e48dc74ULL, -0x849ba5c00c925dd4ULL, -0xf10e4107f9458eafULL, -0x7aef1586dc91b8e9ULL, -0x9374b801924bba8ULL, -0xe21c820ff28b1d5eULL, -0xf5de2b0db92371d2ULL, -0x126e970032497750ULL, -0xc439041fe5163abdULL, -0xebbc561b7246e3a4ULL, -0x24dd2e006492eea0ULL, -0x8872083fca2c757bULL, -0xd778ac36e48dc748ULL, -0x49ba5c00c925dd41ULL, -0x10e4107f9458eaf7ULL, -0xaef1586dc91b8e90ULL, -0x9374b801924bba82ULL, -0x21c820ff28b1d5efULL, -0x5de2b0db92371d21ULL, -0x26e9700324977504ULL, -0x439041fe5163abdeULL, -0xbbc561b7246e3a42ULL, -0x4dd2e006492eea09ULL, -0x872083fca2c757bdULL, -0x778ac36e48dc7484ULL, -0x9ba5c00c925dd413ULL, -0xe4107f9458eaf7aULL, -0xef1586dc91b8e909ULL, -0x374b801924bba827ULL, -0x1c820ff28b1d5ef5ULL, -0xde2b0db92371d212ULL, -0x6e9700324977504eULL, -0x39041fe5163abdebULL, -0xbc561b7246e3a424ULL, -0xdd2e006492eea09dULL, -0x72083fca2c757bd7ULL, -0x78ac36e48dc74849ULL, -0xba5c00c925dd413aULL, -0xe4107f9458eaf7aeULL, -0xf1586dc91b8e9093ULL, -0x74b801924bba8274ULL, -0xc820ff28b1d5ef5dULL, -0xe2b0db92371d2126ULL, -0xe9700324977504e8ULL, -0x9041fe5163abdebbULL, -0xc561b7246e3a424dULL, -0xd2e006492eea09d1ULL, -0x2083fca2c757bd77ULL, -0x8ac36e48dc74849bULL, -0xa5c00c925dd413a3ULL, -0x4107f9458eaf7aefULL, -0x1586dc91b8e90937ULL, -0x4b801924bba82746ULL, -0x820ff28b1d5ef5deULL, -0x2b0db92371d2126eULL, -0x9700324977504e8cULL, -0x41fe5163abdebbcULL, -0x561b7246e3a424ddULL, -0x2e006492eea09d19ULL, -0x83fca2c757bd778ULL, -0xac36e48dc74849baULL, -0x5c00c925dd413a32ULL, -0x107f9458eaf7aef1ULL, -0x586dc91b8e909374ULL, -0xb801924bba827464ULL, -0x20ff28b1d5ef5de2ULL, -0xb0db92371d2126e9ULL, -0x700324977504e8c9ULL, -0x41fe5163abdebbc5ULL, -0x61b7246e3a424dd2ULL, -0xe006492eea09d192ULL, -0x83fca2c757bd778aULL, -0xc36e48dc74849ba5ULL, -0xc00c925dd413a324ULL, -0x7f9458eaf7aef15ULL, -0x86dc91b8e909374bULL, -0x801924bba8274648ULL, -0xff28b1d5ef5de2bULL, -0xdb92371d2126e97ULL, -0x324977504e8c90ULL, -0x1fe5163abdebbc56ULL, -0x1b7246e3a424dd2eULL, -0x6492eea09d1921ULL, -0x3fca2c757bd778acULL, -0x36e48dc74849ba5cULL, -0xc925dd413a3243ULL, -0x7f9458eaf7aef158ULL, -0x6dc91b8e909374b8ULL, -0x1924bba82746487ULL, -0xff28b1d5ef5de2b0ULL, -0xdb92371d2126e970ULL, -0x324977504e8c90eULL, -0xfe5163abdebbc561ULL, -0xb7246e3a424dd2e0ULL, -0x6492eea09d1921cULL, -0xfca2c757bd778ac3ULL, -0x6e48dc74849ba5c0ULL, -0xc925dd413a32439ULL, -0xf9458eaf7aef1586ULL, -0xdc91b8e909374b80ULL, -0x1924bba827464873ULL, -0xf28b1d5ef5de2b0dULL, -0xb92371d2126e9700ULL, -0x324977504e8c90e7ULL, -0xe5163abdebbc561bULL, -0x7246e3a424dd2e00ULL, -0x6492eea09d1921cfULL, -0xca2c757bd778ac36ULL, -0xe48dc74849ba5c00ULL, -0xc925dd413a32439fULL, -0x9458eaf7aef1586dULL, -0xc91b8e909374b801ULL, -0x924bba827464873fULL, -0x28b1d5ef5de2b0dbULL, -0x92371d2126e97003ULL, -0x24977504e8c90e7fULL, -0x5163abdebbc561b7ULL, -0x246e3a424dd2e006ULL, -0x492eea09d1921cfeULL, -0xa2c757bd778ac36eULL, -0x48dc74849ba5c00cULL, -0x925dd413a32439fcULL, -0x458eaf7aef1586dcULL, -0x91b8e909374b8019ULL, -0x24bba827464873f8ULL, -0x8b1d5ef5de2b0db9ULL, -0x2371d2126e970032ULL, -0x4977504e8c90e7f0ULL, -0x163abdebbc561b72ULL, -0x46e3a424dd2e0064ULL, -0x92eea09d1921cfe1ULL, -0x2c757bd778ac36e4ULL, -0x8dc74849ba5c00c9ULL, -0x25dd413a32439fc3ULL, -0x58eaf7aef1586dc9ULL, -0x1b8e909374b80192ULL, -0x4bba827464873f87ULL, -0xb1d5ef5de2b0db92ULL, -0x371d2126e9700324ULL, -0x977504e8c90e7f0eULL, -0x63abdebbc561b724ULL, -0x6e3a424dd2e00649ULL, -0x2eea09d1921cfe1dULL, -0xc757bd778ac36e48ULL, -0xdc74849ba5c00c92ULL, -0x5dd413a32439fc3bULL, -0x8eaf7aef1586dc91ULL, -0xb8e909374b801924ULL, -0xbba827464873f877ULL, -0x1d5ef5de2b0db923ULL, -0x71d2126e97003249ULL, -0x77504e8c90e7f0efULL, -0x3abdebbc561b7246ULL, -0xe3a424dd2e006492ULL, -0xeea09d1921cfe1deULL, -0x757bd778ac36e48dULL, -0xc74849ba5c00c925ULL, -0xdd413a32439fc3bdULL, -0xeaf7aef1586dc91bULL, -0x8e909374b801924bULL, -0xba827464873f877aULL, -0xd5ef5de2b0db9237ULL, -0x1d2126e970032497ULL, -0x7504e8c90e7f0ef5ULL, -0xabdebbc561b7246eULL, -0x3a424dd2e006492eULL, -0xea09d1921cfe1debULL, -0x57bd778ac36e48dcULL, -0x74849ba5c00c925dULL, -0xd413a32439fc3bd6ULL, -0xaf7aef1586dc91b8ULL, -0xe909374b801924bbULL, -0xa827464873f877acULL, -0x5ef5de2b0db92371ULL, -0xd2126e9700324977ULL, -0x504e8c90e7f0ef58ULL, -0xbdebbc561b7246e3ULL, -0xa424dd2e006492eeULL, -0xa09d1921cfe1deb1ULL, -0x7bd778ac36e48dc7ULL, -0x4849ba5c00c925ddULL, -0x413a32439fc3bd63ULL, -0xf7aef1586dc91b8eULL, -0x909374b801924bbaULL, -0x827464873f877ac7ULL, -0xef5de2b0db92371dULL, -0x2126e97003249775ULL, -0x4e8c90e7f0ef58eULL, -0xdebbc561b7246e3aULL, -0x424dd2e006492eeaULL, -0x9d1921cfe1deb1cULL, -0xbd778ac36e48dc74ULL, -0x849ba5c00c925dd4ULL, -0x13a32439fc3bd639ULL, -0x7aef1586dc91b8e9ULL, -0x9374b801924bba8ULL, -0x27464873f877ac72ULL, -0xf5de2b0db92371d2ULL, -0x126e970032497750ULL, -0x4e8c90e7f0ef58e5ULL, -0xebbc561b7246e3a4ULL, -0x24dd2e006492eea0ULL, -0x9d1921cfe1deb1cbULL, -0xd778ac36e48dc748ULL, -0x49ba5c00c925dd41ULL, -0x3a32439fc3bd6396ULL, -0xaef1586dc91b8e90ULL, -0x9374b801924bba82ULL, -0x7464873f877ac72cULL, -0x5de2b0db92371d21ULL, -0x26e9700324977504ULL, -0xe8c90e7f0ef58e58ULL, -0xbbc561b7246e3a42ULL, -0x4dd2e006492eea09ULL, -0xd1921cfe1deb1cb1ULL, -0x778ac36e48dc7484ULL, -0x9ba5c00c925dd413ULL, -0xa32439fc3bd63962ULL, -0xef1586dc91b8e909ULL, -0x374b801924bba827ULL, -0x464873f877ac72c4ULL, -0xde2b0db92371d212ULL, -0x6e9700324977504eULL, -0x8c90e7f0ef58e589ULL, -0xbc561b7246e3a424ULL, -0xdd2e006492eea09dULL, -0x1921cfe1deb1cb12ULL, -0x78ac36e48dc74849ULL, -0xba5c00c925dd413aULL, -0x32439fc3bd639625ULL, -0xf1586dc91b8e9093ULL, -0x74b801924bba8274ULL, -0x64873f877ac72c4aULL, -0xe2b0db92371d2126ULL, -0xe9700324977504e8ULL, -0xc90e7f0ef58e5894ULL, -0xc561b7246e3a424dULL, -0xd2e006492eea09d1ULL, -0x921cfe1deb1cb129ULL, -0x8ac36e48dc74849bULL, -0xa5c00c925dd413a3ULL, -0x2439fc3bd6396253ULL, -0x1586dc91b8e90937ULL, -0x4b801924bba82746ULL, -0x4873f877ac72c4a6ULL, -0x2b0db92371d2126eULL, -0x9700324977504e8cULL, -0x90e7f0ef58e5894dULL, -0x561b7246e3a424ddULL, -0x2e006492eea09d19ULL, -0x21cfe1deb1cb129aULL, -0xac36e48dc74849baULL, -0x5c00c925dd413a32ULL, -0x439fc3bd63962534ULL, -0x586dc91b8e909374ULL, -0xb801924bba827464ULL, -0x873f877ac72c4a69ULL, -0xb0db92371d2126e9ULL, -0x700324977504e8c9ULL, -0xe7f0ef58e5894d3ULL, -0x61b7246e3a424dd2ULL, -0xe006492eea09d192ULL, -0x1cfe1deb1cb129a7ULL, -0xc36e48dc74849ba5ULL, -0xc00c925dd413a324ULL, -0x39fc3bd63962534eULL, -0x86dc91b8e909374bULL, -0x801924bba8274648ULL, -0x73f877ac72c4a69cULL, -0xdb92371d2126e97ULL, -0x324977504e8c90ULL, -0xe7f0ef58e5894d39ULL, -0x1b7246e3a424dd2eULL, -0x6492eea09d1921ULL, -0xcfe1deb1cb129a73ULL, -0x36e48dc74849ba5cULL, -0xc925dd413a3243ULL, -0x9fc3bd63962534e7ULL, -0x6dc91b8e909374b8ULL, -0x1924bba82746487ULL, -0x3f877ac72c4a69cfULL, -0xdb92371d2126e970ULL, -0x324977504e8c90eULL, -0x7f0ef58e5894d39fULL, -0xb7246e3a424dd2e0ULL, -0x6492eea09d1921cULL, -0xfe1deb1cb129a73eULL, -0x6e48dc74849ba5c0ULL, -0xc925dd413a32439ULL, -0xfc3bd63962534e7dULL, -0xdc91b8e909374b80ULL, -0x1924bba827464873ULL, -0xf877ac72c4a69cfbULL, -0xb92371d2126e9700ULL, -0x324977504e8c90e7ULL, -0xf0ef58e5894d39f7ULL, -0x7246e3a424dd2e00ULL, -0x6492eea09d1921cfULL, -0xe1deb1cb129a73eeULL, -0xe48dc74849ba5c00ULL, -0xc925dd413a32439fULL, -0xc3bd63962534e7ddULL, -0xc91b8e909374b801ULL, -0x924bba827464873fULL, -0x877ac72c4a69cfbaULL, -0x92371d2126e97003ULL, -0x24977504e8c90e7fULL, -0xef58e5894d39f74ULL, -0x246e3a424dd2e006ULL, -0x492eea09d1921cfeULL, -0x1deb1cb129a73ee8ULL, -0x48dc74849ba5c00cULL, -0x925dd413a32439fcULL, -0x3bd63962534e7dd1ULL, -0x91b8e909374b8019ULL, -0x24bba827464873f8ULL, -0x77ac72c4a69cfba2ULL, -0x2371d2126e970032ULL, -0x4977504e8c90e7f0ULL, -0xef58e5894d39f744ULL, -0x46e3a424dd2e0064ULL, -0x92eea09d1921cfe1ULL, -0xdeb1cb129a73ee88ULL, -0x8dc74849ba5c00c9ULL, -0x25dd413a32439fc3ULL, -0xbd63962534e7dd10ULL, -0x1b8e909374b80192ULL, -0x4bba827464873f87ULL, -0x7ac72c4a69cfba20ULL, -0x371d2126e9700324ULL, -0x977504e8c90e7f0eULL, -0xf58e5894d39f7441ULL, -0x6e3a424dd2e00649ULL, -0x2eea09d1921cfe1dULL, -0xeb1cb129a73ee882ULL, -0xdc74849ba5c00c92ULL, -0x5dd413a32439fc3bULL, -0xd63962534e7dd104ULL, -0xb8e909374b801924ULL, -0xbba827464873f877ULL, -0xac72c4a69cfba208ULL, -0x71d2126e97003249ULL, -0x77504e8c90e7f0efULL, -0x58e5894d39f74411ULL, -0xe3a424dd2e006492ULL, -0xeea09d1921cfe1deULL, -0xb1cb129a73ee8823ULL, -0xc74849ba5c00c925ULL, -0xdd413a32439fc3bdULL, -0x63962534e7dd1046ULL, -0x8e909374b801924bULL, -0xba827464873f877aULL, -0xc72c4a69cfba208dULL, -0x1d2126e970032497ULL, -0x7504e8c90e7f0ef5ULL, -0x8e5894d39f74411aULL, -0x3a424dd2e006492eULL, -0xea09d1921cfe1debULL, -0x1cb129a73ee88235ULL, -0x74849ba5c00c925dULL, -0xd413a32439fc3bd6ULL, -0x3962534e7dd1046bULL, -0xe909374b801924bbULL, -0xa827464873f877acULL, -0x72c4a69cfba208d7ULL, -0xd2126e9700324977ULL, -0x504e8c90e7f0ef58ULL, -0xe5894d39f74411afULL, -0xa424dd2e006492eeULL, -0xa09d1921cfe1deb1ULL, -0xcb129a73ee88235fULL, -0x4849ba5c00c925ddULL, -0x413a32439fc3bd63ULL, -0x962534e7dd1046beULL, -0x909374b801924bbaULL, -0x827464873f877ac7ULL, -0x2c4a69cfba208d7dULL, -0x2126e97003249775ULL, -0x4e8c90e7f0ef58eULL, -0x5894d39f74411afaULL, -0x424dd2e006492eeaULL, -0x9d1921cfe1deb1cULL, -0xb129a73ee88235f5ULL, -0x849ba5c00c925dd4ULL, -0x13a32439fc3bd639ULL, -0x62534e7dd1046beaULL, -0x9374b801924bba8ULL, -0x27464873f877ac72ULL, -0xc4a69cfba208d7d4ULL, -0x126e970032497750ULL, -0x4e8c90e7f0ef58e5ULL, -0x894d39f74411afa9ULL, -0x24dd2e006492eea0ULL, -0x9d1921cfe1deb1cbULL, -0x129a73ee88235f52ULL, -0x49ba5c00c925dd41ULL, -0x3a32439fc3bd6396ULL, -0x2534e7dd1046bea5ULL, -0x9374b801924bba82ULL, -0x7464873f877ac72cULL, -0x4a69cfba208d7d4bULL, -0x26e9700324977504ULL, -0xe8c90e7f0ef58e58ULL, -0x94d39f74411afa97ULL, -0x4dd2e006492eea09ULL, -0xd1921cfe1deb1cb1ULL, -0x29a73ee88235f52eULL, -0x9ba5c00c925dd413ULL, -0xa32439fc3bd63962ULL, -0x534e7dd1046bea5dULL, -0x374b801924bba827ULL, -0x464873f877ac72c4ULL, -0xa69cfba208d7d4baULL, -0x6e9700324977504eULL, -0x8c90e7f0ef58e589ULL, -0x4d39f74411afa975ULL, -0xdd2e006492eea09dULL, -0x1921cfe1deb1cb12ULL, -0x9a73ee88235f52ebULL, -0xba5c00c925dd413aULL, -0x32439fc3bd639625ULL, -0x34e7dd1046bea5d7ULL, -0x74b801924bba8274ULL, -0x64873f877ac72c4aULL, -0x69cfba208d7d4baeULL, -0xe9700324977504e8ULL, -0xc90e7f0ef58e5894ULL, -0xd39f74411afa975dULL, -0xd2e006492eea09d1ULL, -0x921cfe1deb1cb129ULL, -0xa73ee88235f52ebbULL, -0xa5c00c925dd413a3ULL, -0x2439fc3bd6396253ULL, -0x4e7dd1046bea5d76ULL, -0x4b801924bba82746ULL, -0x4873f877ac72c4a6ULL, -0x9cfba208d7d4baedULL, -0x9700324977504e8cULL, -0x90e7f0ef58e5894dULL, -0x39f74411afa975daULL, -0x2e006492eea09d19ULL, -0x21cfe1deb1cb129aULL, -0x73ee88235f52ebb4ULL, -0x5c00c925dd413a32ULL, -0x439fc3bd63962534ULL, -0xe7dd1046bea5d768ULL, -0xb801924bba827464ULL, -0x873f877ac72c4a69ULL, -0xcfba208d7d4baed1ULL, -0x700324977504e8c9ULL, -0xe7f0ef58e5894d3ULL, -0x9f74411afa975da2ULL, -0xe006492eea09d192ULL, -0x1cfe1deb1cb129a7ULL, -0x3ee88235f52ebb44ULL, -0xc00c925dd413a324ULL, -0x39fc3bd63962534eULL, -0x7dd1046bea5d7689ULL, -0x801924bba8274648ULL, -0x73f877ac72c4a69cULL, -0xfba208d7d4baed12ULL, -0x324977504e8c90ULL, -0xe7f0ef58e5894d39ULL, -0xf74411afa975da24ULL, -0x6492eea09d1921ULL, -0xcfe1deb1cb129a73ULL, -0xee88235f52ebb448ULL, -0xc925dd413a3243ULL, -0x9fc3bd63962534e7ULL, -0xdd1046bea5d76890ULL, -0x1924bba82746487ULL, -0x3f877ac72c4a69cfULL, -0xba208d7d4baed121ULL, -0x324977504e8c90eULL, -0x7f0ef58e5894d39fULL, -0x74411afa975da242ULL, -0x6492eea09d1921cULL, -0xfe1deb1cb129a73eULL, -0xe88235f52ebb4484ULL, -0xc925dd413a32439ULL, -0xfc3bd63962534e7dULL, -0xd1046bea5d768909ULL, -0x1924bba827464873ULL, -0xf877ac72c4a69cfbULL, -0xa208d7d4baed1213ULL, -0x324977504e8c90e7ULL, -0xf0ef58e5894d39f7ULL, -0x4411afa975da2427ULL, -0x6492eea09d1921cfULL, -0xe1deb1cb129a73eeULL, -0x88235f52ebb4484eULL, -0xc925dd413a32439fULL, -0xc3bd63962534e7ddULL, -0x1046bea5d768909dULL, -0x924bba827464873fULL, -0x877ac72c4a69cfbaULL, -0x208d7d4baed1213aULL, -0x24977504e8c90e7fULL, -0xef58e5894d39f74ULL, -0x411afa975da24274ULL, -0x492eea09d1921cfeULL, -0x1deb1cb129a73ee8ULL, -0x8235f52ebb4484e9ULL, -0x925dd413a32439fcULL, -0x3bd63962534e7dd1ULL, -0x46bea5d768909d3ULL, -0x24bba827464873f8ULL, -0x77ac72c4a69cfba2ULL, -0x8d7d4baed1213a6ULL, -0x4977504e8c90e7f0ULL, -0xef58e5894d39f744ULL, -0x11afa975da24274cULL, -0x92eea09d1921cfe1ULL, -0xdeb1cb129a73ee88ULL, -0x235f52ebb4484e99ULL, -0x25dd413a32439fc3ULL, -0xbd63962534e7dd10ULL, -0x46bea5d768909d33ULL, -0x4bba827464873f87ULL, -0x7ac72c4a69cfba20ULL, -0x8d7d4baed1213a67ULL, -0x977504e8c90e7f0eULL, -0xf58e5894d39f7441ULL, -0x1afa975da24274ceULL, -0x2eea09d1921cfe1dULL, -0xeb1cb129a73ee882ULL, -0x35f52ebb4484e99cULL, -0x5dd413a32439fc3bULL, -0xd63962534e7dd104ULL, -0x6bea5d768909d338ULL, -0xbba827464873f877ULL, -0xac72c4a69cfba208ULL, -0xd7d4baed1213a671ULL, -0x77504e8c90e7f0efULL, -0x58e5894d39f74411ULL, -0xafa975da24274ce3ULL, -0xeea09d1921cfe1deULL, -0xb1cb129a73ee8823ULL, -0x5f52ebb4484e99c7ULL, -0xdd413a32439fc3bdULL, -0x63962534e7dd1046ULL, -0xbea5d768909d338eULL, -0xba827464873f877aULL, -0xc72c4a69cfba208dULL, -0x7d4baed1213a671cULL, -0x7504e8c90e7f0ef5ULL, -0x8e5894d39f74411aULL, -0xfa975da24274ce38ULL, -0xea09d1921cfe1debULL, -0x1cb129a73ee88235ULL, -0xf52ebb4484e99c70ULL, -0xd413a32439fc3bd6ULL, -0x3962534e7dd1046bULL, -0xea5d768909d338e0ULL, -0xa827464873f877acULL, -0x72c4a69cfba208d7ULL, -0xd4baed1213a671c0ULL, -0x504e8c90e7f0ef58ULL, -0xe5894d39f74411afULL, -0xa975da24274ce381ULL, -0xa09d1921cfe1deb1ULL, -0xcb129a73ee88235fULL, -0x52ebb4484e99c702ULL, -0x413a32439fc3bd63ULL, -0x962534e7dd1046beULL, -0xa5d768909d338e04ULL, -0x827464873f877ac7ULL, -0x2c4a69cfba208d7dULL, -0x4baed1213a671c09ULL, -0x4e8c90e7f0ef58eULL, -0x5894d39f74411afaULL, -0x975da24274ce3813ULL, -0x9d1921cfe1deb1cULL, -0xb129a73ee88235f5ULL, -0x2ebb4484e99c7026ULL, -0x13a32439fc3bd639ULL, -0x62534e7dd1046beaULL, -0x5d768909d338e04dULL, -0x27464873f877ac72ULL, -0xc4a69cfba208d7d4ULL, -0xbaed1213a671c09aULL, -0x4e8c90e7f0ef58e5ULL, -0x894d39f74411afa9ULL, -0x75da24274ce38135ULL, -0x9d1921cfe1deb1cbULL, -0x129a73ee88235f52ULL, -0xebb4484e99c7026bULL, -0x3a32439fc3bd6396ULL, -0x2534e7dd1046bea5ULL, -0xd768909d338e04d6ULL, -0x7464873f877ac72cULL, -0x4a69cfba208d7d4bULL, -0xaed1213a671c09adULL, -0xe8c90e7f0ef58e58ULL, -0x94d39f74411afa97ULL, -0x5da24274ce38135aULL, -0xd1921cfe1deb1cb1ULL, -0x29a73ee88235f52eULL, -0xbb4484e99c7026b4ULL, -0xa32439fc3bd63962ULL, -0x534e7dd1046bea5dULL, -0x768909d338e04d68ULL, -0x464873f877ac72c4ULL, -0xa69cfba208d7d4baULL, -0xed1213a671c09ad1ULL, -0x8c90e7f0ef58e589ULL, -0x4d39f74411afa975ULL, -0xda24274ce38135a2ULL, -0x1921cfe1deb1cb12ULL, -0x9a73ee88235f52ebULL, -0xb4484e99c7026b45ULL, -0x32439fc3bd639625ULL, -0x34e7dd1046bea5d7ULL, -0x68909d338e04d68bULL, -0x64873f877ac72c4aULL, -0x69cfba208d7d4baeULL, -0xd1213a671c09ad17ULL, -0xc90e7f0ef58e5894ULL, -0xd39f74411afa975dULL, -0xa24274ce38135a2fULL, -0x921cfe1deb1cb129ULL, -0xa73ee88235f52ebbULL, -0x4484e99c7026b45fULL, -0x2439fc3bd6396253ULL, -0x4e7dd1046bea5d76ULL, -0x8909d338e04d68beULL, -0x4873f877ac72c4a6ULL, -0x9cfba208d7d4baedULL, -0x1213a671c09ad17dULL, -0x90e7f0ef58e5894dULL, -0x39f74411afa975daULL, -0x24274ce38135a2fbULL, -0x21cfe1deb1cb129aULL, -0x73ee88235f52ebb4ULL, -0x484e99c7026b45f7ULL, -0x439fc3bd63962534ULL, -0xe7dd1046bea5d768ULL, -0x909d338e04d68befULL, -0x873f877ac72c4a69ULL, -0xcfba208d7d4baed1ULL, -0x213a671c09ad17dfULL, -0xe7f0ef58e5894d3ULL, -0x9f74411afa975da2ULL, -0x4274ce38135a2fbfULL, -0x1cfe1deb1cb129a7ULL, -0x3ee88235f52ebb44ULL, -0x84e99c7026b45f7eULL, -0x39fc3bd63962534eULL, -0x7dd1046bea5d7689ULL, -0x9d338e04d68befcULL, -0x73f877ac72c4a69cULL, -0xfba208d7d4baed12ULL, -0x13a671c09ad17df9ULL, -0xe7f0ef58e5894d39ULL, -0xf74411afa975da24ULL, -0x274ce38135a2fbf2ULL, -0xcfe1deb1cb129a73ULL, -0xee88235f52ebb448ULL, -0x4e99c7026b45f7e4ULL, -0x9fc3bd63962534e7ULL, -0xdd1046bea5d76890ULL, -0x9d338e04d68befc8ULL, -0x3f877ac72c4a69cfULL, -0xba208d7d4baed121ULL, -0x3a671c09ad17df90ULL, -0x7f0ef58e5894d39fULL, -0x74411afa975da242ULL, -0x74ce38135a2fbf20ULL, -0xfe1deb1cb129a73eULL, -0xe88235f52ebb4484ULL, -0xe99c7026b45f7e41ULL, -0xfc3bd63962534e7dULL, -0xd1046bea5d768909ULL, -0xd338e04d68befc82ULL, -0xf877ac72c4a69cfbULL, -0xa208d7d4baed1213ULL, -0xa671c09ad17df904ULL, -0xf0ef58e5894d39f7ULL, -0x4411afa975da2427ULL, -0x4ce38135a2fbf208ULL, -0xe1deb1cb129a73eeULL, -0x88235f52ebb4484eULL, -0x99c7026b45f7e410ULL, -0xc3bd63962534e7ddULL, -0x1046bea5d768909dULL, -0x338e04d68befc820ULL, -0x877ac72c4a69cfbaULL, -0x208d7d4baed1213aULL, -0x671c09ad17df9040ULL, -0xef58e5894d39f74ULL, -0x411afa975da24274ULL, -0xce38135a2fbf2080ULL, -0x1deb1cb129a73ee8ULL, -0x8235f52ebb4484e9ULL, -0x9c7026b45f7e4100ULL, -0x3bd63962534e7dd1ULL, -0x46bea5d768909d3ULL, -0x38e04d68befc8200ULL, -0x77ac72c4a69cfba2ULL, -0x8d7d4baed1213a6ULL, -0x71c09ad17df90400ULL, -0xef58e5894d39f744ULL, -0x11afa975da24274cULL, -0xe38135a2fbf20800ULL, -0xdeb1cb129a73ee88ULL, -0x235f52ebb4484e99ULL, -0xc7026b45f7e41000ULL, -0xbd63962534e7dd10ULL, -0x46bea5d768909d33ULL, -0x8e04d68befc82000ULL, -0x7ac72c4a69cfba20ULL, -0x8d7d4baed1213a67ULL, -0x1c09ad17df904000ULL, -0xf58e5894d39f7441ULL, -0x1afa975da24274ceULL, -0x38135a2fbf208000ULL, -0xeb1cb129a73ee882ULL, -0x35f52ebb4484e99cULL, -0x7026b45f7e410000ULL, -0xd63962534e7dd104ULL, -0x6bea5d768909d338ULL, -0xe04d68befc820000ULL, -0xac72c4a69cfba208ULL, -0xd7d4baed1213a671ULL, -0xc09ad17df9040000ULL, -0x58e5894d39f74411ULL, -0xafa975da24274ce3ULL, -0x8135a2fbf2080000ULL, -0xb1cb129a73ee8823ULL, -0x5f52ebb4484e99c7ULL, -0x26b45f7e4100000ULL, -0x63962534e7dd1046ULL, -0xbea5d768909d338eULL, -0x4d68befc8200000ULL, -0xc72c4a69cfba208dULL, -0x7d4baed1213a671cULL, -0x9ad17df90400000ULL, -0x8e5894d39f74411aULL, -0xfa975da24274ce38ULL, -0x135a2fbf20800000ULL, -0x1cb129a73ee88235ULL, -0xf52ebb4484e99c70ULL, -0x26b45f7e41000000ULL, -0x3962534e7dd1046bULL, -0xea5d768909d338e0ULL, -0x4d68befc82000000ULL, -0x72c4a69cfba208d7ULL, -0xd4baed1213a671c0ULL, -0x9ad17df904000000ULL, -0xe5894d39f74411afULL, -0xa975da24274ce381ULL, -0x35a2fbf208000000ULL, -0xcb129a73ee88235fULL, -0x52ebb4484e99c702ULL, -0x6b45f7e410000000ULL, -0x962534e7dd1046beULL, -0xa5d768909d338e04ULL, -0xd68befc820000000ULL, -0x2c4a69cfba208d7dULL, -0x4baed1213a671c09ULL, -0xad17df9040000000ULL, -0x5894d39f74411afaULL, -0x975da24274ce3813ULL, -0x5a2fbf2080000000ULL, -0xb129a73ee88235f5ULL, -0x2ebb4484e99c7026ULL, -0xb45f7e4100000000ULL, -0x62534e7dd1046beaULL, -0x5d768909d338e04dULL, -0x68befc8200000000ULL, -0xc4a69cfba208d7d4ULL, -0xbaed1213a671c09aULL, -0xd17df90400000000ULL, -0x894d39f74411afa9ULL, -0x75da24274ce38135ULL, -0xa2fbf20800000000ULL, -0x129a73ee88235f52ULL, -0xebb4484e99c7026bULL, -0x45f7e41000000000ULL, -0x2534e7dd1046bea5ULL, -0xd768909d338e04d6ULL, -0x8befc82000000000ULL, -0x4a69cfba208d7d4bULL, -0xaed1213a671c09adULL, -0x17df904000000000ULL, -0x94d39f74411afa97ULL, -0x5da24274ce38135aULL, -0x2fbf208000000000ULL, -0x29a73ee88235f52eULL, -0xbb4484e99c7026b4ULL, -0x5f7e410000000000ULL, -0x534e7dd1046bea5dULL, -0x768909d338e04d68ULL, -0xbefc820000000000ULL, -0xa69cfba208d7d4baULL, -0xed1213a671c09ad1ULL, -0x7df9040000000000ULL, -0x4d39f74411afa975ULL, -0xda24274ce38135a2ULL, -0xfbf2080000000000ULL, -0x9a73ee88235f52ebULL, -0xb4484e99c7026b45ULL, -0xf7e4100000000000ULL, -0x34e7dd1046bea5d7ULL, -0x68909d338e04d68bULL, -0xefc8200000000000ULL, -0x69cfba208d7d4baeULL, -0xd1213a671c09ad17ULL, -0xdf90400000000000ULL, -0xd39f74411afa975dULL, -0xa24274ce38135a2fULL, -0xbf20800000000000ULL, -0xa73ee88235f52ebbULL, -0x4484e99c7026b45fULL, -0x7e41000000000000ULL, -0x4e7dd1046bea5d76ULL, -0x8909d338e04d68beULL, -0xfc82000000000000ULL, -0x9cfba208d7d4baedULL, -0x1213a671c09ad17dULL, -0xf904000000000000ULL, -0x39f74411afa975daULL, -0x24274ce38135a2fbULL, -0xf208000000000000ULL, -0x73ee88235f52ebb4ULL, -0x484e99c7026b45f7ULL, -0xe410000000000000ULL, -0xe7dd1046bea5d768ULL, -0x909d338e04d68befULL, -0xc820000000000000ULL, -0xcfba208d7d4baed1ULL, -0x213a671c09ad17dfULL, -0x9040000000000000ULL, -0x9f74411afa975da2ULL, -0x4274ce38135a2fbfULL, -0x2080000000000000ULL, -0x3ee88235f52ebb44ULL, -0x84e99c7026b45f7eULL, -0x4100000000000000ULL, -0x7dd1046bea5d7689ULL, -0x9d338e04d68befcULL, -0x8200000000000000ULL, -0xfba208d7d4baed12ULL, -0x13a671c09ad17df9ULL, -0x400000000000000ULL, -0xf74411afa975da24ULL, -0x274ce38135a2fbf2ULL, -0x800000000000000ULL, -0xee88235f52ebb448ULL, -0x4e99c7026b45f7e4ULL, -0x1000000000000000ULL, -0xdd1046bea5d76890ULL, -0x9d338e04d68befc8ULL, -0x2000000000000000ULL, -0xba208d7d4baed121ULL, -0x3a671c09ad17df90ULL, -0x4000000000000000ULL, -0x74411afa975da242ULL, -0x74ce38135a2fbf20ULL, -0x8000000000000000ULL, -0xe88235f52ebb4484ULL, -0xe99c7026b45f7e41ULL, -0x0ULL, -0xd1046bea5d768909ULL, -0xd338e04d68befc82ULL, -0x0ULL, -0xa208d7d4baed1213ULL, -0xa671c09ad17df904ULL, -0x0ULL, -0x4411afa975da2427ULL, -0x4ce38135a2fbf208ULL, -0x0ULL, -0x88235f52ebb4484eULL, -0x99c7026b45f7e410ULL, -0x0ULL, -0x1046bea5d768909dULL, -0x338e04d68befc820ULL, -0x0ULL, -0x208d7d4baed1213aULL, -0x671c09ad17df9040ULL, -0x0ULL, -0x411afa975da24274ULL, -0xce38135a2fbf2080ULL, -0x0ULL, -0x8235f52ebb4484e9ULL, -0x9c7026b45f7e4100ULL, -0x0ULL, -0x46bea5d768909d3ULL, -0x38e04d68befc8200ULL, -0x0ULL, -0x8d7d4baed1213a6ULL, -0x71c09ad17df90400ULL, -0x0ULL, -0x11afa975da24274cULL, -0xe38135a2fbf20800ULL, -0x0ULL, -0x235f52ebb4484e99ULL, -0xc7026b45f7e41000ULL, -0x0ULL, -0x46bea5d768909d33ULL, -0x8e04d68befc82000ULL, -0x0ULL, -0x8d7d4baed1213a67ULL, -0x1c09ad17df904000ULL, -0x0ULL, -0x1afa975da24274ceULL, -0x38135a2fbf208000ULL, -0x0ULL, -0x35f52ebb4484e99cULL, -0x7026b45f7e410000ULL, -0x0ULL, -0x6bea5d768909d338ULL, -0xe04d68befc820000ULL, -0x0ULL, -0xd7d4baed1213a671ULL, -0xc09ad17df9040000ULL, -0x0ULL, -0xafa975da24274ce3ULL, -0x8135a2fbf2080000ULL, -0x0ULL, -0x5f52ebb4484e99c7ULL, -0x26b45f7e4100000ULL, -0x0ULL, -0xbea5d768909d338eULL, -0x4d68befc8200000ULL, -0x0ULL, -0x7d4baed1213a671cULL, -0x9ad17df90400000ULL, -0x0ULL, -0xfa975da24274ce38ULL, -0x135a2fbf20800000ULL, -0x0ULL, -0xf52ebb4484e99c70ULL, -0x26b45f7e41000000ULL, -0x0ULL, -0xea5d768909d338e0ULL, -0x4d68befc82000000ULL, -0x0ULL, -0xd4baed1213a671c0ULL, -0x9ad17df904000000ULL, -0x0ULL, -0xa975da24274ce381ULL, -0x35a2fbf208000000ULL, -0x0ULL, -0x52ebb4484e99c702ULL, -0x6b45f7e410000000ULL, -0x0ULL, -0xa5d768909d338e04ULL, -0xd68befc820000000ULL, -0x0ULL, -0x4baed1213a671c09ULL, -0xad17df9040000000ULL, -0x0ULL, -0x975da24274ce3813ULL, -0x5a2fbf2080000000ULL, -0x0ULL, -0x2ebb4484e99c7026ULL, -0xb45f7e4100000000ULL, -0x0ULL, -0x5d768909d338e04dULL, -0x68befc8200000000ULL, -0x0ULL, -0xbaed1213a671c09aULL, -0xd17df90400000000ULL, -0x0ULL, -0x75da24274ce38135ULL, -0xa2fbf20800000000ULL, -0x0ULL, -0xebb4484e99c7026bULL, -0x45f7e41000000000ULL, -0x0ULL, -0xd768909d338e04d6ULL, -0x8befc82000000000ULL, -0x0ULL, -0xaed1213a671c09adULL, -0x17df904000000000ULL, -0x0ULL, -0x5da24274ce38135aULL, -0x2fbf208000000000ULL, -0x0ULL, -0xbb4484e99c7026b4ULL, -0x5f7e410000000000ULL, -0x0ULL, -0x768909d338e04d68ULL, -0xbefc820000000000ULL, -0x0ULL, -0xed1213a671c09ad1ULL, -0x7df9040000000000ULL, -0x0ULL, -0xda24274ce38135a2ULL, -0xfbf2080000000000ULL, -0x0ULL, -0xb4484e99c7026b45ULL, -0xf7e4100000000000ULL, -0x0ULL, -0x68909d338e04d68bULL, -0xefc8200000000000ULL, -0x0ULL, -0xd1213a671c09ad17ULL, -0xdf90400000000000ULL, -0x0ULL, -0xa24274ce38135a2fULL, -0xbf20800000000000ULL, -0x0ULL, -0x4484e99c7026b45fULL, -0x7e41000000000000ULL, -0x0ULL, -0x8909d338e04d68beULL, -0xfc82000000000000ULL, -0x0ULL, -0x1213a671c09ad17dULL, -0xf904000000000000ULL, -0x0ULL, -0x24274ce38135a2fbULL, -0xf208000000000000ULL, -0x0ULL, -0x484e99c7026b45f7ULL, -0xe410000000000000ULL, -0x0ULL, -0x909d338e04d68befULL, -0xc820000000000000ULL, -0x0ULL, -0x213a671c09ad17dfULL, -0x9040000000000000ULL, -0x0ULL, -0x4274ce38135a2fbfULL, -0x2080000000000000ULL, -0x0ULL, -0x84e99c7026b45f7eULL, -0x4100000000000000ULL, -0x0ULL, -0x9d338e04d68befcULL, -0x8200000000000000ULL, -0x0ULL, -0x13a671c09ad17df9ULL, -0x400000000000000ULL, -0x0ULL, -0x274ce38135a2fbf2ULL, -0x800000000000000ULL, -0x0ULL, -0x4e99c7026b45f7e4ULL, -0x1000000000000000ULL, -0x0ULL, -0x9d338e04d68befc8ULL, -0x2000000000000000ULL, -0x0ULL, -0x3a671c09ad17df90ULL, -0x4000000000000000ULL, -0x0ULL, -0x74ce38135a2fbf20ULL, -0x8000000000000000ULL, -0x0ULL, -0xe99c7026b45f7e41ULL, -0x0ULL, -0x0ULL, -0xd338e04d68befc82ULL, -0x0ULL, -0x0ULL, -0xa671c09ad17df904ULL, -0x0ULL, -0x0ULL, -0x4ce38135a2fbf208ULL, -0x0ULL, -0x0ULL, -0x99c7026b45f7e410ULL, -0x0ULL, -0x0ULL, -0x338e04d68befc820ULL, -0x0ULL, -0x0ULL, -0x671c09ad17df9040ULL, -0x0ULL, -0x0ULL, -0xce38135a2fbf2080ULL, -0x0ULL, -0x0ULL, -0x9c7026b45f7e4100ULL, -0x0ULL, -0x0ULL, -0x38e04d68befc8200ULL, -0x0ULL, -0x0ULL, -0x71c09ad17df90400ULL, -0x0ULL, -0x0ULL, -0xe38135a2fbf20800ULL, -0x0ULL, -0x0ULL, -0xc7026b45f7e41000ULL, -0x0ULL, -0x0ULL, -0x8e04d68befc82000ULL, -0x0ULL, -0x0ULL, -0x1c09ad17df904000ULL, -0x0ULL, -0x0ULL, -0x38135a2fbf208000ULL, -0x0ULL, -0x0ULL, -0x7026b45f7e410000ULL, -0x0ULL, -0x0ULL, -0xe04d68befc820000ULL, -0x0ULL, -0x0ULL, -0xc09ad17df9040000ULL, -0x0ULL, -0x0ULL, -0x8135a2fbf2080000ULL, -0x0ULL, -0x0ULL, -0x26b45f7e4100000ULL, -0x0ULL, -0x0ULL, -0x4d68befc8200000ULL, -0x0ULL, -0x0ULL, -0x9ad17df90400000ULL, -0x0ULL, -0x0ULL, -0x135a2fbf20800000ULL, -0x0ULL, -0x0ULL, -0x26b45f7e41000000ULL, -0x0ULL, -0x0ULL, -0x4d68befc82000000ULL, -0x0ULL, -0x0ULL, -0x9ad17df904000000ULL, -0x0ULL, -0x0ULL, -0x35a2fbf208000000ULL, -0x0ULL, -0x0ULL, -0x6b45f7e410000000ULL, -0x0ULL, -0x0ULL, -0xd68befc820000000ULL, -0x0ULL, -0x0ULL, -0xad17df9040000000ULL, -0x0ULL, -0x0ULL, -0x5a2fbf2080000000ULL, -0x0ULL, -0x0ULL, -0xb45f7e4100000000ULL, -0x0ULL, -0x0ULL, -0x68befc8200000000ULL, -0x0ULL, -0x0ULL, -0xd17df90400000000ULL, -0x0ULL, -0x0ULL, -0xa2fbf20800000000ULL, -0x0ULL, -0x0ULL, -0x45f7e41000000000ULL, -0x0ULL, -0x0ULL, -0x8befc82000000000ULL, -0x0ULL, -0x0ULL, -0x17df904000000000ULL, -0x0ULL, -0x0ULL, -0x2fbf208000000000ULL, -0x0ULL, -0x0ULL, -0x5f7e410000000000ULL, -0x0ULL, -0x0ULL, -0xbefc820000000000ULL, -0x0ULL, -0x0ULL, -0x7df9040000000000ULL, -0x0ULL, -0x0ULL, -0xfbf2080000000000ULL, -0x0ULL, -0x0ULL, -0xf7e4100000000000ULL, -0x0ULL, -0x0ULL, -0xefc8200000000000ULL, -0x0ULL, -0x0ULL, -0xdf90400000000000ULL, -0x0ULL, -0x0ULL, -0xbf20800000000000ULL, -0x0ULL, -0x0ULL, -0x7e41000000000000ULL, -0x0ULL, -0x0ULL, -0xfc82000000000000ULL, -0x0ULL, -0x0ULL, -0xf904000000000000ULL, -0x0ULL, -0x0ULL, -0xf208000000000000ULL, -0x0ULL, -0x0ULL, -0xe410000000000000ULL, -0x0ULL, -0x0ULL, -0xc820000000000000ULL, -0x0ULL, -0x0ULL, -0x9040000000000000ULL, -0x0ULL, -0x0ULL, -0x2080000000000000ULL, -0x0ULL, -0x0ULL, -0x4100000000000000ULL, -0x0ULL, -0x0ULL, -0x8200000000000000ULL, -0x0ULL, -0x0ULL, -0x400000000000000ULL, -0x0ULL, -0x0ULL, -0x800000000000000ULL, -0x0ULL, -0x0ULL, -0x1000000000000000ULL, -0x0ULL, -0x0ULL, -0x2000000000000000ULL, -0x0ULL, -0x0ULL, -0x4000000000000000ULL, -0x0ULL, -0x0ULL, -0x8000000000000000ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL, -0x0ULL -}; -template <> HWY_ALIGN constexpr double kSinApproxTable[] = { -0, -0, -0, -0x1p0, --0x1.3bd3bc5fc5ab4p-18, -0x1.921f8becca4bap-9, -0x1.2ba407bcab5b2p-63, -0x1p0, --0x1.3bd38bab6d94cp-16, -0x1.921f0fe670071p-8, -0x1.ab967fe6b7a9bp-64, -0x1p0, --0x1.634da1cec522dp-15, -0x1.2d96b0e509703p-7, --0x1.1e9131ff52dc9p-63, -0x1p0, --0x1.3bd2c8da49511p-14, -0x1.921d1fcdec784p-7, -0x1.9878ebe836d9dp-61, -0x1p0, --0x1.ed7875885ea3ap-14, -0x1.f6a296ab997cbp-7, --0x1.f2943d8fe7033p-61, -0x1p0, --0x1.634bb4ae5ed49p-13, -0x1.2d936bbe30efdp-6, -0x1.b5f91ee371d64p-61, -0x1p0, --0x1.e3978f34889d9p-13, -0x1.5fd4d21fab226p-6, --0x1.0c0a91c37851cp-61, -0x1p0, --0x1.3bcfbd9979a27p-12, -0x1.92155f7a3667ep-6, --0x1.b1d63091a013p-64, -0x1p0, --0x1.8fb18eacc3af8p-12, -0x1.c454f4ce53b1dp-6, --0x1.d63d7fef0e36cp-60, -0x1p0, --0x1.ed71071603e86p-12, -0x1.f693731d1cf01p-6, --0x1.3fe9bc66286c7p-66, -0x1p0, --0x1.2a86f68094692p-11, -0x1.14685db42c17fp-5, --0x1.2890d277cb974p-59, -0x1p0, --0x1.6344004228d8bp-11, -0x1.2d865759455cdp-5, -0x1.686f65ba93acp-61, -0x1p0, --0x1.a0ef7dcffafabp-11, -0x1.46a396ff86179p-5, -0x1.136ac00fa2da9p-61, -0x1p0, --0x1.e389491f8833ap-11, -0x1.5fc00d290cd43p-5, -0x1.a2669a693a8e1p-59, -0x1p0, --0x1.15889c8dd385fp-10, -0x1.78dbaa5874686p-5, --0x1.4a0ef4035c29cp-60, -0x1p0, --0x1.3bc390d250439p-10, -0x1.91f65f10dd814p-5, --0x1.912bd0d569a9p-61, -0x1p0, --0x1.647569c825ae1p-10, -0x1.ab101bd5f8317p-5, --0x1.65c6175c6dc68p-59, -0x1p0, --0x1.8f9e0e5514865p-10, -0x1.c428d12c0d7e3p-5, --0x1.89bc74b58c513p-60, -0x1p0, --0x1.bd3d63d9c26efp-10, -0x1.dd406f9808ec9p-5, -0x1.1313a4b4068bdp-62, -0x1p0, --0x1.ed534e31ca57fp-10, -0x1.f656e79f820ep-5, --0x1.2e1ebe392bffep-61, -0x1p0, --0x1.0fefd7d9e6ed8p-9, -0x1.07b614e463064p-4, --0x1.384f8c3ee7605p-58, -0x1p0, --0x1.2a713498c3c3dp-9, -0x1.1440134d709b3p-4, --0x1.fec446daea6adp-58, -0x1p0, --0x1.462dacfbef0f3p-9, -0x1.20c9674ed444dp-4, --0x1.f9d48faba7974p-58, -0x1p0, --0x1.63252fe77c5ebp-9, -0x1.2d52092ce19f6p-4, --0x1.9a088a8bf6b2cp-59, -0x1p0, --0x1.8157ab7d29fd9p-9, -0x1.39d9f12c5a299p-4, -0x1.1287ff27ae554p-62, -0x1p0, --0x1.a0c50d1c6bf93p-9, -0x1.4661179272096p-4, --0x1.4b109f2406c4cp-58, -0x1p0, --0x1.c16d4162779e5p-9, -0x1.52e774a4d4d0ap-4, -0x1.b2edf18c730cbp-60, -0x1p0, --0x1.e350342a4f6e6p-9, -0x1.5f6d00a9aa419p-4, --0x1.f4022d03f6c9ap-59, -0x1p0, --0x1.0336e84667c66p-8, -0x1.6bf1b3e79b129p-4, --0x1.14b6da08765p-58, -0x1p0, --0x1.156300705d51bp-8, -0x1.787586a5d5b21p-4, -0x1.5f7589f083399p-58, -0x1p0, --0x1.282c575d639fcp-8, -0x1.84f8712c130a1p-4, --0x1.e626ebafe374ep-58, -0x1p0, --0x1.3b92e176d6d31p-8, -0x1.917a6bc29b42cp-4, --0x1.e2718d26ed688p-60, -0x1p0, --0x1.4f9692c51b0fbp-8, -0x1.9dfb6eb24a85cp-4, -0x1.e96b47b8c44e6p-59, -0x1p0, --0x1.64375eefa3dd6p-8, -0x1.aa7b724495c03p-4, -0x1.e5399ba0967b8p-58, -0x1p0, --0x1.7975393cfbc4dp-8, -0x1.b6fa6ec38f64cp-4, -0x1.db5d943691f09p-58, -0x1p0, --0x1.8f501492cc296p-8, -0x1.c3785c79ec2d5p-4, --0x1.4f39df133fb21p-61, -0x1p0, --0x1.a5c7e375e55dep-8, -0x1.cff533b307dc1p-4, -0x1.8feeb8f9c3334p-59, -0x1p0, --0x1.bcdc980a46f5ap-8, -0x1.dc70ecbae9fc9p-4, -0x1.2fda2d73295eep-60, -0x1p0, --0x1.d48e24132851p-8, -0x1.e8eb7fde4aa3fp-4, --0x1.23758f2d5bb8bp-58, -0x1p0, --0x1.ecdc78f30165cp-8, -0x1.f564e56a9730ep-4, -0x1.a2704729ae56dp-59, -0x1p0, --0x1.02e3c3d5c9e17p-7, -0x1.00ee8ad6fb85bp-3, -0x1.673eac8308f11p-58, -0x1p0, --0x1.0fa7a06ef9e81p-7, -0x1.072a047ba831dp-3, -0x1.19db1f70118cap-58, -0x1p0, --0x1.1cb9ca654924fp-7, -0x1.0d64dbcb26786p-3, --0x1.713a562132055p-58, -0x1p0, --0x1.2a1a39a8a2fb7p-7, -0x1.139f0cedaf577p-3, --0x1.523434d1b3cfap-57, -0x1p0, --0x1.37c8e5f8aacep-7, -0x1.19d8940be24e7p-3, -0x1.e8dcdca90cc74p-58, -0x1p0, --0x1.45c5c6e4c114ap-7, -0x1.20116d4ec7bcfp-3, --0x1.242c8e1053452p-57, -0x1p0, --0x1.5410d3cc0891ep-7, -0x1.264994dfd3409p-3, -0x1.a744ce26f39cp-57, -0x1p0, --0x1.62aa03dd6ba58p-7, -0x1.2c8106e8e613ap-3, -0x1.13000a89a11ep-58, -0x1p0, --0x1.71914e17a1bc6p-7, -0x1.32b7bf94516a7p-3, -0x1.2a24e2431ef29p-57, -0x1p0, --0x1.80c6a94934dfp-7, -0x1.38edbb0cd8d14p-3, --0x1.198c21fbf7718p-57, -0x1p0, --0x1.904a0c10875cep-7, -0x1.3f22f57db4893p-3, -0x1.bfe7ff2274956p-59, -0x1p0, --0x1.a01b6cdbd995ep-7, -0x1.45576b1293e5ap-3, --0x1.285a24119f7b1p-58, -0x1p0, --0x1.b03ac1e94fe1dp-7, -0x1.4b8b17f79fa88p-3, -0x1.b534fe588f0dp-57, -0x1p0, --0x1.c0a80146f894cp-7, -0x1.51bdf8597c5f2p-3, --0x1.9f9976af04aa5p-61, -0x1p0, --0x1.d16320d2d221ep-7, -0x1.57f008654cbdep-3, -0x1.908c95c4c9118p-58, -0x1p0, --0x1.e26c163ad15b3p-7, -0x1.5e214448b3fc6p-3, -0x1.531ff779ddac6p-57, -0x1p0, --0x1.f3c2d6fce7cfap-7, -0x1.6451a831d830dp-3, -0x1.ad16031a34d5p-58, -0x1p0, --0x1.02b3ac3385232p-6, -0x1.6a81304f64ab2p-3, -0x1.f0cd73fb5d8d4p-58, -0x1p0, --0x1.0bacc7cb9babap-6, -0x1.70afd8d08c4ffp-3, -0x1.260c3f1369484p-57, -0x1p0, --0x1.14ccb8bdbf114p-6, -0x1.76dd9de50bf31p-3, -0x1.1d5eeec501b2fp-57, -0x1p0, --0x1.1e1379690291cp-6, -0x1.7d0a7bbd2cb1cp-3, --0x1.cf900f27c58efp-57, -0x1p0, --0x1.278104148891ap-6, -0x1.83366e89c64c6p-3, --0x1.192952df10db8p-57, -0x1p0, --0x1.311552ef8623cp-6, -0x1.8961727c41804p-3, -0x1.3fdab4e42640ap-58, -0x1p0, --0x1.3ad06011469fbp-6, -0x1.8f8b83c69a60bp-3, --0x1.26d19b9ff8d82p-57, -0x1p0, --0x1.44b225792f46bp-6, -0x1.95b49e9b62afap-3, --0x1.100b3d1dbfeaap-59, -0x1p0, --0x1.4eba9d0ec2f7cp-6, -0x1.9bdcbf2dc4366p-3, -0x1.9632d189956fep-57, -0x1p0, --0x1.58e9c0a1a5f21p-6, -0x1.a203e1b1831dap-3, -0x1.c1aadb580a1ecp-58, -0x1p0, --0x1.633f89e9a1a66p-6, -0x1.a82a025b00451p-3, --0x1.87905ffd084adp-57, -0x1p0, --0x1.6dbbf286a8971p-6, -0x1.ae4f1d5f3b9abp-3, -0x1.aa8bbcef9b68ep-57, -0x1p0, --0x1.785ef400da46cp-6, -0x1.b4732ef3d6722p-3, -0x1.bbe5d5d75cbd8p-57, -0x1p0, --0x1.832887c88735dp-6, -0x1.ba96334f15dadp-3, --0x1.75098c05dd18ap-57, -0x1p0, --0x1.8e18a73634ee7p-6, -0x1.c0b826a7e4f63p-3, --0x1.af1439e521935p-62, -0x1p0, --0x1.992f4b8aa21f8p-6, -0x1.c6d90535d74ddp-3, --0x1.bfb2be2264962p-59, -0x1p0, --0x1.a46c6deecac5fp-6, -0x1.ccf8cb312b286p-3, -0x1.2382b0aecadf8p-58, -0x1p0, --0x1.afd00773ec64fp-6, -0x1.d31774d2cbdeep-3, -0x1.2fdc8e5791a0bp-57, -0x1p0, --0x1.bb5a11138a4c9p-6, -0x1.d934fe5454311p-3, -0x1.75b92277107adp-57, -0x1p0, --0x1.c70a83af71ef5p-6, -0x1.df5163f01099ap-3, --0x1.01f7d79906e86p-57, -0x1p0, --0x1.d2e15811bf462p-6, -0x1.e56ca1e101a1bp-3, -0x1.46ac3f9fd0227p-57, -0x1p0, --0x1.dede86ece142ep-6, -0x1.eb86b462de348p-3, --0x1.bfcde46f90b62p-57, -0x1p0, --0x1.eb0208db9e51bp-6, -0x1.f19f97b215f1bp-3, --0x1.42deef11da2c4p-57, -0x1p0, --0x1.f74bd66118e8dp-6, -0x1.f7b7480bd3802p-3, --0x1.9a96d967ee12ep-57, -0x1p0, --0x1.01ddf3f46a139p-5, -0x1.fdcdc1adfedf9p-3, --0x1.2dba4580ed7bbp-57, -0x1p0, --0x1.08291ae35c407p-5, -0x1.01f1806b9fdd2p-2, --0x1.448135394b8bap-56, -0x1p0, --0x1.0e875c1b8c3dap-5, -0x1.04fb80e37fdaep-2, --0x1.412cdb72583ccp-63, -0x1p0, --0x1.14f8b3af5abb9p-5, -0x1.0804e05eb661ep-2, -0x1.54e583d92d3d8p-56, -0x1p0, --0x1.1b7d1da562443p-5, -0x1.0b0d9cfdbdb9p-2, -0x1.3b3a7b8d1200dp-58, -0x1p0, --0x1.221495f879af5p-5, -0x1.0e15b4e1749cep-2, --0x1.5b7fb156c550ap-56, -0x1p0, --0x1.28bf1897b69ccp-5, -0x1.111d262b1f677p-2, -0x1.824c20ab7aa9ap-56, -0x1p0, --0x1.2f7ca1666ff6fp-5, -0x1.1423eefc69378p-2, -0x1.22d3368ec9b62p-56, -0x1p0, --0x1.364d2c3c407bep-5, -0x1.172a0d7765177p-2, -0x1.22575f33366bep-57, -0x1p0, --0x1.3d30b4e5094ep-5, -0x1.1a2f7fbe8f243p-2, -0x1.6465ac86ba7b2p-56, -0x1p0, --0x1.44273720f48bcp-5, -0x1.1d3443f4cdb3ep-2, --0x1.720d41c13519ep-57, -0x1p0, --0x1.4b30aea477eeep-5, -0x1.2038583d727bep-2, --0x1.c69cd46300a3p-57, -0x1p0, --0x1.524d171857726p-5, -0x1.233bbabc3bb71p-2, -0x1.99b04e23259efp-56, -0x1p0, --0x1.597c6c19a8003p-5, -0x1.263e6995554bap-2, -0x1.1d350ffc5ff32p-56, -0x1p0, --0x1.60bea939d225ap-5, -0x1.294062ed59f06p-2, --0x1.5d28da2c4612dp-56, -0x1p0, --0x1.6813c9fe94cfbp-5, -0x1.2c41a4e95452p-2, -0x1.9cf0354aad2dcp-56, -0x1p0, --0x1.6f7bc9e2080d9p-5, -0x1.2f422daec0387p-2, --0x1.7501ba473da6fp-56, -0x1p0, --0x1.76f6a4529fdb5p-5, -0x1.3241fb638baafp-2, -0x1.ecee8f76f8c51p-60, -0x1p0, --0x1.7e8454b32ef34p-5, -0x1.35410c2e18152p-2, --0x1.3cb002f96e062p-56, -0x1p0, --0x1.8624d65ae9a63p-5, -0x1.383f5e353b6abp-2, --0x1.a812a4a5c3d44p-56, -0x1p0, --0x1.8dd8249568bbbp-5, -0x1.3b3cefa0414b7p-2, -0x1.f36dc4a9c2294p-56, -0x1p0, --0x1.959e3aa2ac58dp-5, -0x1.3e39be96ec271p-2, -0x1.814c6de9aaaf6p-56, -0x1p0, --0x1.9d7713b71eee1p-5, -0x1.4135c94176601p-2, -0x1.0c97c4afa2518p-56, -0x1p0, --0x1.a562aafb982cdp-5, -0x1.44310dc8936fp-2, -0x1.8b694e91d3125p-56, -0x1p0, --0x1.ad60fb8d6003ap-5, -0x1.472b8a5571054p-2, --0x1.01ea0fe4dff23p-56, -0x1p0, --0x1.b572007e31a1bp-5, -0x1.4a253d11b82f3p-2, --0x1.2afa4d6d42a55p-58, -0x1p0, --0x1.bd95b4d43e819p-5, -0x1.4d1e24278e76ap-2, -0x1.2417218792858p-57, -0x1p0, --0x1.c5cc138a317afp-5, -0x1.50163dc197048p-2, --0x1.ec66cb05c7ea4p-56, -0x1p0, --0x1.ce15178f31db3p-5, -0x1.530d880af3c24p-2, --0x1.fab8e2103fbd6p-56, -0x1p0, --0x1.d670bbc6e685ep-5, -0x1.5604012f467b4p-2, -0x1.a0e0b2a5b25p-56, -0x1p0, --0x1.dedefb09791b4p-5, -0x1.58f9a75ab1fddp-2, --0x1.efdc0d58cf62p-62, -0x1p0, --0x1.e75fd0239926cp-5, -0x1.5bee78b9db3b6p-2, -0x1.e734a63158dfdp-58, -0x1p0, --0x1.eff335d67f541p-5, -0x1.5ee27379ea693p-2, -0x1.634ff2fa75245p-56, -0x1p0, --0x1.f89926d7f0ab8p-5, -0x1.61d595c88c202p-2, -0x1.f6b1e333415d7p-56, -0x1p0, --0x1.00a8cee920eabp-4, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4a664121p-58, -0x1p0, --0x1.050e4ab22d321p-4, -0x1.67b949cad63cbp-2, --0x1.a23369348d7efp-56, -0x1p0, --0x1.097d0410dc132p-4, -0x1.6aa9d7dc77e17p-2, --0x1.38b470592c7b3p-56, -0x1p0, --0x1.0df4f849393f5p-4, -0x1.6d998638a0cb6p-2, --0x1.1ca14532860dfp-61, -0x1p0, --0x1.127624999ee1dp-4, -0x1.7088530fa459fp-2, --0x1.44b19e0864c5dp-56, -0x1p0, --0x1.1700863ab7533p-4, -0x1.73763c9261092p-2, --0x1.52324face3b1ap-57, -0x1p0, --0x1.1b941a5f7ecffp-4, -0x1.766340f2418f6p-2, -0x1.2b2adc9041b2cp-56, -0x1p0, --0x1.2030de354532cp-4, -0x1.794f5e613dfaep-2, -0x1.820a4b0d21fc5p-57, -0x1p0, --0x1.24d6cee3afb2ap-4, -0x1.7c3a9311dcce7p-2, -0x1.9a3f21ef3e8d9p-62, -0x1p0, --0x1.2985e98cbaa3ap-4, -0x1.7f24dd37341e4p-2, -0x1.2791a1b5eb796p-57, -0x1p0, --0x1.2e3e2b4cbb3c3p-4, -0x1.820e3b04eaac4p-2, --0x1.92379eb01c6b6p-59, -0x1p0, --0x1.32ff913a615dp-4, -0x1.84f6aaaf3903fp-2, -0x1.6dcdc2bd47067p-57, -0x1p0, --0x1.37ca1866b95cfp-4, -0x1.87de2a6aea963p-2, --0x1.72cedd3d5a61p-57, -0x1p0, --0x1.3c9dbddd2dd84p-4, -0x1.8ac4b86d5ed44p-2, -0x1.17fa7f944ad5bp-56, -0x1p0, --0x1.417a7ea389835p-4, -0x1.8daa52ec8a4bp-2, --0x1.72eb2db8c621ep-57, -0x1p0, --0x1.466057b9f900ap-4, -0x1.908ef81ef7bd1p-2, -0x1.4c00267012357p-56, -0x1p0, --0x1.4b4f461b0cbaap-4, -0x1.9372a63bc93d7p-2, -0x1.684319e5ad5b1p-57, -0x1p0, --0x1.504746bbbac0bp-4, -0x1.96555b7ab948fp-2, -0x1.7afd51eff33adp-56, -0x1p0, --0x1.5548568b60a7bp-4, -0x1.993716141bdffp-2, --0x1.15e8cce261c55p-56, -0x1p0, --0x1.5a527273c56e1p-4, -0x1.9c17d440df9f2p-2, -0x1.923c540a9eec4p-57, -0x1p0, --0x1.5f6597591b633p-4, -0x1.9ef7943a8ed8ap-2, -0x1.6da81290bdbabp-57, -0x1p0, --0x1.6481c21a02123p-4, -0x1.a1d6543b50acp-2, --0x1.0246cfd8779fbp-57, -0x1p0, --0x1.69a6ef8f8830ap-4, -0x1.a4b4127dea1e5p-2, --0x1.bec6f01bc22f1p-56, -0x1p0, --0x1.6ed51c8d2d8fcp-4, -0x1.a790cd3dbf31bp-2, --0x1.7f786986d9023p-57, -0x1p0, --0x1.740c45e0e512p-4, -0x1.aa6c82b6d3fcap-2, --0x1.d5f106ee5ccf7p-56, -0x1p0, --0x1.794c685316a3cp-4, -0x1.ad473125cdc09p-2, --0x1.379ede57649dap-58, -0x1p0, --0x1.7e9580a6a136ep-4, -0x1.b020d6c7f4009p-2, -0x1.414ae7e555208p-58, -0x1p0, --0x1.83e78b98dcc2bp-4, -0x1.b2f971db31972p-2, -0x1.fa971a4a41f2p-56, -0x1p0, --0x1.894285e19c468p-4, -0x1.b5d1009e15ccp-2, -0x1.5b362cb974183p-57, -0x1p0, --0x1.8ea66c332fd01p-4, -0x1.b8a7814fd5693p-2, -0x1.9a9e6651cc119p-56, -0x1p0, --0x1.94133b3a66851p-4, -0x1.bb7cf2304bd01p-2, -0x1.9e1a5bd9269d4p-57, -0x1p0, --0x1.9988ef9e90b04p-4, -0x1.be51517ffc0d9p-2, -0x1.2b667131a5f16p-56, -0x1p0, --0x1.9f07860181d1ep-4, -0x1.c1249d8011ee7p-2, --0x1.813aabb515206p-56, -0x1p0, --0x1.a48efaff92b3bp-4, -0x1.c3f6d47263129p-2, -0x1.9c7bd0fcdecddp-56, -0x1p0, --0x1.aa1f4b2fa37fcp-4, -0x1.c6c7f4997000bp-2, --0x1.bec2669c68e74p-56, -0x1p0, --0x1.afb873231ddb9p-4, -0x1.c997fc3865389p-2, --0x1.6295f8b0ca33bp-56, -0x1p0, --0x1.b55a6f65f7058p-4, -0x1.cc66e9931c45ep-2, -0x1.6850e59c37f8fp-58, -0x1p0, --0x1.bb053c7eb1f68p-4, -0x1.cf34baee1cd21p-2, --0x1.118724d19d014p-56, -0x1p0, --0x1.c0b8d6ee61867p-4, -0x1.d2016e8e9db5bp-2, --0x1.c8bce9d93efb8p-57, -0x1p0, --0x1.c6753b30aa949p-4, -0x1.d4cd02ba8609dp-2, --0x1.37f33c63033d6p-57, -0x1p0, --0x1.cc3a65bbc6327p-4, -0x1.d79775b86e389p-2, -0x1.550ec87bc0575p-56, -0x1p0, --0x1.d208530083d3p-4, -0x1.da60c5cfa10d9p-2, --0x1.0f38e2143c8d5p-57, -0x1p0, --0x1.d7deff6a4b7c9p-4, -0x1.dd28f1481cc58p-2, --0x1.e7576fa6c944ep-59, -0x1p0, --0x1.ddbe675f1ffdfp-4, -0x1.dfeff66a941dep-2, --0x1.a756c6e625f96p-56, -0x1p0, --0x1.e3a6873fa1279p-4, -0x1.e2b5d3806f63bp-2, -0x1.e0d891d3c6841p-58, -0x1p0, --0x1.e9975b670e077p-4, -0x1.e57a86d3cd825p-2, --0x1.2c80dcd511e87p-57, -0x1p0, --0x1.ef90e02b47283p-4, -0x1.e83e0eaf85114p-2, --0x1.7bc380ef24ba7p-57, -0x1p0, --0x1.f59311dcd0d44p-4, -0x1.eb00695f2562p-2, -0x1.53c9fd3083e22p-56, -0x1p0, --0x1.fb9decc6d55b8p-4, -0x1.edc1952ef78d6p-2, --0x1.dd0f7c33edee6p-56, -0x1p0, --0x1.00d8b69793ae4p-3, -0x1.f081906bff7fep-2, --0x1.4cab2d4ff6fccp-56, -0x1p0, --0x1.03e6c7ab2208cp-3, -0x1.f3405963fd067p-2, -0x1.06846d44a238fp-56, -0x1p0, --0x1.06f927bbaacfep-3, -0x1.f5fdee656cda3p-2, --0x1.7bf9780816b05p-58, -0x1p0, --0x1.0a0fd4e41ab5ap-3, -0x1.f8ba4dbf89abap-2, --0x1.2ec1fc1b776b8p-60, -0x1p0, --0x1.0d2acd3cb7364p-3, -0x1.fb7575c24d2dep-2, --0x1.5bfdc883c8664p-57, -0x1p0, --0x1.104a0edb1fc58p-3, -0x1.fe2f64be7121p-2, --0x1.297ab1ca2d7dbp-56, -0x1p0, --0x1.136d97d24efccp-3, -0x1.00740c82b82e1p-1, --0x1.6d48563c60e87p-55, -0x1p0, --0x1.169566329bcb7p-3, -0x1.01cfc874c3eb7p-1, --0x1.34a35e7c2368cp-56, -0x1p0, --0x1.19c17809baa87p-3, -0x1.032ae55edbd96p-1, --0x1.bdb022b40107ap-55, -0x1p0, --0x1.1cf1cb62bec5dp-3, -0x1.0485626ae221ap-1, -0x1.b937d9091ff7p-55, -0x1p0, --0x1.20265e461b45ap-3, -0x1.05df3ec31b8b7p-1, --0x1.e2dcad34d9c1dp-57, -0x1p0, --0x1.235f2eb9a470ap-3, -0x1.073879922ffeep-1, --0x1.a5a014347406cp-55, -0x1p0, --0x1.269c3ac090ee4p-3, -0x1.089112032b08cp-1, -0x1.3248ddf9fe619p-57, -0x1p0, --0x1.29dd805b7afecp-3, -0x1.09e907417c5e1p-1, --0x1.fe573741a9bd4p-55, -0x1p0, --0x1.2d22fd8861b6bp-3, -0x1.0b405878f85ecp-1, --0x1.ad66c3bb80da5p-55, -0x1p0, --0x1.306cb042aa3bap-3, -0x1.0c9704d5d898fp-1, --0x1.8d3d7de6ee9b2p-55, -0x1p0, --0x1.33ba968321032p-3, -0x1.0ded0b84bc4b6p-1, --0x1.8540fa327c55cp-55, -0x1p0, --0x1.370cae3ffb12fp-3, -0x1.0f426bb2a8e7ep-1, --0x1.bb58fb774f8eep-55, -0x1p0, --0x1.3a62f56cd742ep-3, -0x1.1097248d0a957p-1, --0x1.7a58759ba80ddp-55, -0x1p0, --0x1.3dbd69fabf802p-3, -0x1.11eb3541b4b23p-1, --0x1.ef23b69abe4f1p-55, -0x1p0, --0x1.411c09d82a128p-3, -0x1.133e9cfee254fp-1, --0x1.a1377cfd5ce5p-56, -0x1p0, --0x1.447ed2f0fae31p-3, -0x1.14915af336cebp-1, -0x1.f3660558a0213p-56, -0x1p0, --0x1.47e5c32e84c45p-3, -0x1.15e36e4dbe2bcp-1, -0x1.3c545f7d79eaep-56, -0x1p0, --0x1.4b50d8778abbdp-3, -0x1.1734d63dedb49p-1, --0x1.7eef2ccc50575p-55, -0x1p0, --0x1.4ec010b0414e1p-3, -0x1.188591f3a46e5p-1, --0x1.bbefe5a524346p-56, -0x1p0, --0x1.523369ba4fcaep-3, -0x1.19d5a09f2b9b8p-1, --0x1.33656c68a1d4ap-57, -0x1p0, --0x1.55aae174d19c8p-3, -0x1.1b250171373bfp-1, --0x1.b210e95e1ca4cp-55, -0x1p0, --0x1.592675bc57974p-3, -0x1.1c73b39ae68c8p-1, -0x1.b25dd267f66p-55, -0x1p0, --0x1.5ca6246ae94b8p-3, -0x1.1dc1b64dc4872p-1, -0x1.f15e1c468be78p-57, -0x1p0, --0x1.6029eb580658ep-3, -0x1.1f0f08bbc861bp-1, --0x1.10d9dcafb74cbp-57, -0x1p0, --0x1.63b1c858a7c2ep-3, -0x1.205baa17560d6p-1, -0x1.b7b144016c7a3p-56, -0x1p0, --0x1.673db93f41479p-3, -0x1.21a799933eb59p-1, --0x1.3a7b177c68fb2p-55, -0x1p0, --0x1.6acdbbdbc2b73p-3, -0x1.22f2d662c13e2p-1, --0x1.d5cc7580cb6d2p-55, -0x1p0, --0x1.6e61cdfb994dfp-3, -0x1.243d5fb98ac1fp-1, -0x1.c533d0a284a8dp-56, -0x1p0, --0x1.71f9ed69b10eap-3, -0x1.258734cbb711p-1, -0x1.3a3f0903ce09dp-57, -0x1p0, --0x1.759617ee761f9p-3, -0x1.26d054cdd12dfp-1, --0x1.5da743ef3770cp-55, -0x1p0, --0x1.79364b4fd6288p-3, -0x1.2818bef4d3cbap-1, --0x1.e3fffeb76568ap-56, -0x1p0, --0x1.7cda855141b26p-3, -0x1.2960727629ca8p-1, -0x1.56d6c7af02d5cp-56, -0x1p0, --0x1.8082c3b3ad887p-3, -0x1.2aa76e87aeb58p-1, -0x1.fd600833287a7p-59, -0x1p0, --0x1.842f0435941afp-3, -0x1.2bedb25faf3eap-1, --0x1.14981c796ee46p-58, -0x1p0, --0x1.87df4492f6e38p-3, -0x1.2d333d34e9bb8p-1, --0x1.0e2c2c5549e26p-55, -0x1p0, --0x1.8b9382855fcaap-3, -0x1.2e780e3e8ea17p-1, --0x1.b19fafe36587ap-55, -0x1p0, --0x1.8f4bbbc3e28f6p-3, -0x1.2fbc24b441015p-1, -0x1.dba4875410874p-57, -0x1p0, --0x1.9307ee031e2fdp-3, -0x1.30ff7fce17035p-1, --0x1.efcc626f74a6fp-57, -0x1p0, --0x1.96c816f53e539p-3, -0x1.32421ec49a61fp-1, -0x1.65e25cc951bfep-55, -0x1p0, --0x1.9a8c3449fcb77p-3, -0x1.338400d0c8e57p-1, --0x1.abf2a5e95e6e5p-55, -0x1p0, --0x1.9e5443aea29b2p-3, -0x1.34c5252c14de1p-1, -0x1.583f49632ab2bp-55, -0x1p0, --0x1.a22042ce0a2f9p-3, -0x1.36058b10659f3p-1, --0x1.1fcb3a35857e7p-55, -0x1p0, --0x1.a5f02f50a007cp-3, -0x1.374531b817f8dp-1, -0x1.444d2b0a747fep-55, -0x1p0, --0x1.a9c406dc648a5p-3, -0x1.3884185dfeb22p-1, --0x1.a038026abe6b2p-56, -0x1p0, --0x1.ad9bc714ed64fp-3, -0x1.39c23e3d63029p-1, --0x1.3b05b276085c1p-58, -0x1p0, --0x1.b1776d9b67013p-3, -0x1.3affa292050b9p-1, -0x1.e3e25e3954964p-56, -0x1p0, --0x1.b556f80e95facp-3, -0x1.3c3c44981c518p-1, --0x1.b5e9a9644151bp-55, -0x1p0, --0x1.b93a640ad8978p-3, -0x1.3d78238c58344p-1, --0x1.0219f5f0f79cep-55, -0x1p0, --0x1.bd21af2a28408p-3, -0x1.3eb33eabe068p-1, -0x1.86a2357d1a0d3p-58, -0x1p0, --0x1.c10cd7041afccp-3, -0x1.3fed9534556d4p-1, -0x1.36916608c5061p-55, -0x1p0, --0x1.c4fbd92de4eddp-3, -0x1.41272663d108cp-1, -0x1.1bbe7636fadf5p-55, -0x1p0, --0x1.c8eeb33a59cdp-3, -0x1.425ff178e6bb1p-1, -0x1.7b38d675140cap-55, -0x1p0, --0x1.cce562b9ee6aep-3, -0x1.4397f5b2a438p-1, --0x1.7274c9e48c226p-55, -0x1p0, --0x1.d0dfe53aba2fdp-3, -0x1.44cf325091dd6p-1, -0x1.8076a2cfdc6b3p-57, -0x1p0, --0x1.d4de3848789e2p-3, -0x1.4605a692b32a2p-1, -0x1.21ca219b97107p-55, -0x1p0, --0x1.d8e0596c8ad56p-3, -0x1.473b51b987347p-1, -0x1.ca1953514e41bp-57, -0x1p0, --0x1.dce6462df917dp-3, -0x1.48703306091ffp-1, --0x1.70813b86159fdp-57, -0x1p0, --0x1.e0effc1174505p-3, -0x1.49a449b9b0939p-1, --0x1.27ee16d719b94p-55, -0x1p0, --0x1.e4fd7899579acp-3, -0x1.4ad79516722f1p-1, --0x1.1273b163000f7p-55, -0x1p0, --0x1.e90eb945a9ccfp-3, -0x1.4c0a145ec0004p-1, -0x1.2630cfafceaa1p-58, -0x1p0, --0x1.ed23bb941f019p-3, -0x1.4d3bc6d589f7fp-1, -0x1.6e4d9d6b72011p-55, -0x1p0, --0x1.f13c7d001a249p-3, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293edceb327p-57, -0x1p0, --0x1.f558fb02ae805p-3, -0x1.4f9cc25cca486p-1, -0x1.48b5951cfc2b5p-55, -0x1p0, --0x1.f9793312a14d1p-3, -0x1.50cc09f59a09bp-1, -0x1.693463a2c2e6fp-56, -0x1p0, --0x1.fd9d22a46b416p-3, -0x1.51fa81cd99aa6p-1, --0x1.499f59d8560e9p-63, -0x1p0, --0x1.00e263951d11fp-2, -0x1.5328292a35596p-1, --0x1.a12eb89da0257p-56, -0x1p0, --0x1.02f80f09f92f4p-2, -0x1.5454ff5159dfcp-1, --0x1.4e247588bf256p-55, -0x1p0, --0x1.050f92679849cp-2, -0x1.5581038975137p-1, -0x1.4570d9efe26dfp-55, -0x1p0, --0x1.0728ec63a599ap-2, -0x1.56ac35197649fp-1, --0x1.f7874188cb279p-55, -0x1p0, --0x1.09441bb2aa0a2p-2, -0x1.57d69348cecap-1, --0x1.75720992bfbb2p-55, -0x1p0, --0x1.0b611f080d05bp-2, -0x1.59001d5f723dfp-1, -0x1.a9f86ba0dde98p-56, -0x1p0, --0x1.0d7ff51615437p-2, -0x1.5a28d2a5d725p-1, -0x1.57a25f8b1343p-55, -0x1p0, --0x1.0fa09c8de994bp-2, -0x1.5b50b264f7448p-1, -0x1.519d30d4cfebp-56, -0x1p0, --0x1.11c3141f91b3ep-2, -0x1.5c77bbe65018cp-1, -0x1.069ea9c0bc32ap-55, -0x1p0, --0x1.13e75a79f7139p-2, -0x1.5d9dee73e345cp-1, --0x1.de1165ecdf7a3p-57, -0x1p0, --0x1.160d6e4ae5ae6p-2, -0x1.5ec3495837074p-1, -0x1.dea89a9b8f727p-56, -0x1p0, --0x1.18354e3f0cd7dp-2, -0x1.5fe7cbde56a1p-1, --0x1.fcb9cc30cc01ep-55, -0x1p0, --0x1.1a5ef902000d3p-2, -0x1.610b7551d2cdfp-1, --0x1.251b352ff2a37p-56, -0x1p0, --0x1.1c8a6d3e37c82p-2, -0x1.622e44fec22ffp-1, -0x1.f98d8be132d57p-56, -0x1p0, --0x1.1eb7a99d1250cp-2, -0x1.63503a31c1be9p-1, -0x1.1248f09e6587cp-57, -0x1p0, --0x1.20e6acc6d4916p-2, -0x1.64715437f535bp-1, --0x1.7c399c15a17dp-55, -0x1p0, --0x1.23177562aaea3p-2, -0x1.6591925f0783dp-1, -0x1.c3d64fbf5de23p-55, -0x1p0, --0x1.254a0216aa067p-2, -0x1.66b0f3f52b386p-1, -0x1.1e2eb31a8848bp-55, -0x1p0, --0x1.277e5187cfb16p-2, -0x1.67cf78491af1p-1, -0x1.750ab23477b61p-59, -0x1p0, --0x1.29b4625a03ac9p-2, -0x1.68ed1eaa19c71p-1, -0x1.fd4a85350f69p-56, -0x1p0, -0, -0x1.6a09e667f3bcdp-1, --0x1.bdd3413b26456p-55, -0, -0x1.a3b47aa8671c5p-3, -0x1.6b25ced2fe29cp-1, --0x1.5ac64116beda5p-55, -0x1p-1, -0x1.9f3de1246bc4p-3, -0x1.6c40d73c18275p-1, -0x1.25d4f802be257p-57, -0x1p-1, -0x1.9ac3cfd4ace19p-3, -0x1.6d5afef4aafcdp-1, --0x1.868a696b8835ep-55, -0x1p-1, -0x1.9646497c1e0f6p-3, -0x1.6e74454eaa8afp-1, --0x1.dbc03c84e226ep-55, -0x1p-1, -0x1.91c550dfd4d6bp-3, -0x1.6f8ca99c95b75p-1, -0x1.f22e7a35723f4p-56, -0x1p-1, -0x1.8d40e8c706fa4p-3, -0x1.70a42b3176d7ap-1, --0x1.d9e3fbe2e15ap-56, -0x1p-1, -0x1.88b913fb08bfdp-3, -0x1.71bac960e41bfp-1, --0x1.b858d90b0f7d8p-56, -0x1p-1, -0x1.842dd5474b37bp-3, -0x1.72d0837efff96p-1, -0x1.0d4ef0f1d915cp-55, -0x1p-1, -0x1.7f9f2f795a83ep-3, -0x1.73e558e079942p-1, --0x1.2663126697f5ep-55, -0x1p-1, -0x1.7b0d2560dc1d1p-3, -0x1.74f948da8d28dp-1, -0x1.19900a3b9a3a2p-63, -0x1p-1, -0x1.7677b9cf8d17p-3, -0x1.760c52c304764p-1, --0x1.11d76f8e50f1fp-55, -0x1p-1, -0x1.71deef9940631p-3, -0x1.771e75f037261p-1, -0x1.5cfce8d84068fp-56, -0x1p-1, -0x1.6d42c993dd121p-3, -0x1.782fb1b90b35bp-1, --0x1.3e46c1dfd001cp-55, -0x1p-1, -0x1.68a34a975c941p-3, -0x1.79400574f55e5p-1, --0x1.0adadbdb4c65ap-55, -0x1p-1, -0x1.6400757dc8f7dp-3, -0x1.7a4f707bf97d2p-1, -0x1.3c9751b491eafp-55, -0x1p-1, -0x1.5f5a4d233b27fp-3, -0x1.7b5df226aafafp-1, --0x1.0f537acdf0ad7p-56, -0x1p-1, -0x1.5ab0d465d927ap-3, -0x1.7c6b89ce2d333p-1, --0x1.cfd628084982cp-56, -0x1p-1, -0x1.56040e25d44ddp-3, -0x1.7d7836cc33db2p-1, -0x1.162715ef03f85p-56, -0x1p-1, -0x1.5153fd45677efp-3, -0x1.7e83f87b03686p-1, -0x1.b61a8ccabad6p-57, -0x1p-1, -0x1.4ca0a4a8d5657p-3, -0x1.7f8ece3571771p-1, --0x1.9c8d8ce93c917p-55, -0x1p-1, -0x1.47ea073666a98p-3, -0x1.8098b756e52fap-1, -0x1.9136e834b4707p-55, -0x1p-1, -0x1.433027d66826dp-3, -0x1.81a1b33b57accp-1, --0x1.5dea12d66bb66p-55, -0x1p-1, -0x1.3e73097329219p-3, -0x1.82a9c13f545ffp-1, --0x1.65e87a7a8cde9p-56, -0x1p-1, -0x1.39b2aef8f97a4p-3, -0x1.83b0e0bff976ep-1, --0x1.6f420f8ea3475p-56, -0x1p-1, -0x1.34ef1b5627dfdp-3, -0x1.84b7111af83fap-1, --0x1.63a47df0b21bap-55, -0x1p-1, -0x1.3028517b0001p-3, -0x1.85bc51ae958ccp-1, -0x1.45ba6478086ccp-55, -0x1p-1, -0x1.2b5e5459c8bc3p-3, -0x1.86c0a1d9aa195p-1, -0x1.84564f09c3726p-59, -0x1p-1, -0x1.269126e6c24e3p-3, -0x1.87c400fba2ebfp-1, --0x1.2dabc0c3f64cdp-55, -0x1p-1, -0x1.21c0cc18247fcp-3, -0x1.88c66e7481ba1p-1, --0x1.5c6228970cf35p-56, -0x1p-1, -0x1.1ced46e61cd1cp-3, -0x1.89c7e9a4dd4aap-1, -0x1.db6ea04a8678fp-55, -0x1p-1, -0x1.18169a4acca89p-3, -0x1.8ac871ede1d88p-1, --0x1.9afaa5b7cfc55p-55, -0x1p-1, -0x1.133cc94247758p-3, -0x1.8bc806b151741p-1, --0x1.2c5e12ed1336dp-55, -0x1p-1, -0x1.0e5fd6ca90dffp-3, -0x1.8cc6a75184655p-1, --0x1.e18b3657e2285p-55, -0x1p-1, -0x1.097fc5e39aec5p-3, -0x1.8dc45331698ccp-1, -0x1.1d9fcd83634d7p-57, -0x1p-1, -0x1.049c998f44231p-3, -0x1.8ec109b486c49p-1, --0x1.cb2a3eb6af617p-56, -0x1p-1, -0x1.ff6ca9a2ab6a2p-4, -0x1.8fbcca3ef940dp-1, --0x1.6dfa99c86f2f1p-57, -0x1p-1, -0x1.f599f55f034p-4, -0x1.90b7943575efep-1, -0x1.4ecb0c5273706p-57, -0x1p-1, -0x1.ebc11c62c1a1ep-4, -0x1.91b166fd49da2p-1, --0x1.3be953a7fe996p-57, -0x1p-1, -0x1.e1e224c0e28bdp-4, -0x1.92aa41fc5a815p-1, --0x1.68f89e2d23db7p-57, -0x1p-1, -0x1.d7fd1490285cap-4, -0x1.93a22499263fbp-1, -0x1.3d419a920df0bp-55, -0x1p-1, -0x1.ce11f1eb18148p-4, -0x1.94990e3ac4a6cp-1, -0x1.a95328edeb3e6p-56, -0x1p-1, -0x1.c420c2eff590ep-4, -0x1.958efe48e6dd7p-1, --0x1.561335da0f4e7p-55, -0x1p-1, -0x1.ba298dc0bfc6bp-4, -0x1.9683f42bd7fe1p-1, --0x1.11bad933c835ep-57, -0x1p-1, -0x1.b02c58832cf96p-4, -0x1.9777ef4c7d742p-1, --0x1.15479a240665ep-55, -0x1p-1, -0x1.a6292960a6f0bp-4, -0x1.986aef1457594p-1, --0x1.af03e318f38fcp-55, -0x1p-1, -0x1.9c200686472b5p-4, -0x1.995cf2ed80d22p-1, -0x1.7783e907fbd7bp-56, -0x1p-1, -0x1.9210f624d30fbp-4, -0x1.9a4dfa42b06b2p-1, --0x1.829b6b8b1c947p-56, -0x1p-1, -0x1.87fbfe70b81a7p-4, -0x1.9b3e047f38741p-1, --0x1.30ee286712474p-55, -0x1p-1, -0x1.7de125a2080a9p-4, -0x1.9c2d110f075c2p-1, -0x1.d9c9f1c8c30dp-55, -0x1p-1, -0x1.73c071f4750b5p-4, -0x1.9d1b1f5ea80d5p-1, -0x1.c5fadd5ffb36fp-55, -0x1p-1, -0x1.6999e9a74ddbep-4, -0x1.9e082edb42472p-1, -0x1.5809a4e121e22p-57, -0x1p-1, -0x1.5f6d92fd79f5p-4, -0x1.9ef43ef29af94p-1, -0x1.b1dfcb60445c2p-56, -0x1p-1, -0x1.553b743d75acp-4, -0x1.9fdf4f13149dep-1, -0x1.1e6d79006ec09p-55, -0x1p-1, -0x1.4b0393b14e541p-4, -0x1.a0c95eabaf937p-1, --0x1.e0ca3acbd049ap-55, -0x1p-1, -0x1.40c5f7a69e5cep-4, -0x1.a1b26d2c0a75ep-1, -0x1.30ef431d627a6p-57, -0x1p-1, -0x1.3682a66e896f5p-4, -0x1.a29a7a0462782p-1, --0x1.128bb015df175p-56, -0x1p-1, -0x1.2c39a65db8881p-4, -0x1.a38184a593bc6p-1, --0x1.bc92c5bd2d288p-55, -0x1p-1, -0x1.21eafdcc560fap-4, -0x1.a4678c8119ac8p-1, -0x1.1b4c0dd3f212ap-55, -0x1p-1, -0x1.1796b31609f0cp-4, -0x1.a54c91090f523p-1, -0x1.184300fd1c1cep-56, -0x1p-1, -0x1.0d3ccc99f5ac6p-4, -0x1.a63091b02fae2p-1, --0x1.e911152248d1p-56, -0x1p-1, -0x1.02dd50bab06b2p-4, -0x1.a7138de9d60f5p-1, --0x1.f1ab82a9c5f2dp-55, -0x1p-1, -0x1.f0f08bbc861afp-5, -0x1.a7f58529fe69dp-1, --0x1.97a441584a179p-55, -0x1p-1, -0x1.dc1b64dc48722p-5, -0x1.a8d676e545ad2p-1, --0x1.b11dcce2e74bdp-59, -0x1p-1, -0x1.c73b39ae68c87p-5, -0x1.a9b66290ea1a3p-1, -0x1.9f630e8b6dac8p-60, -0x1p-1, -0x1.b250171373be9p-5, -0x1.aa9547a2cb98ep-1, -0x1.87d00ae97abaap-60, -0x1p-1, -0x1.9d5a09f2b9b7fp-5, -0x1.ab7325916c0d4p-1, -0x1.a8b8c85baaa9bp-55, -0x1p-1, -0x1.88591f3a46e4dp-5, -0x1.ac4ffbd3efac8p-1, --0x1.818504103fa16p-56, -0x1p-1, -0x1.734d63dedb48ap-5, -0x1.ad2bc9e21d511p-1, --0x1.47fbe07bea548p-55, -0x1p-1, -0x1.5e36e4dbe2bc2p-5, -0x1.ae068f345ecefp-1, --0x1.33934c4029a4cp-56, -0x1p-1, -0x1.4915af336ceb4p-5, -0x1.aee04b43c1474p-1, --0x1.3a79a438bf8ccp-55, -0x1p-1, -0x1.33e9cfee254edp-5, -0x1.afb8fd89f57b6p-1, -0x1.1ced12d2899b8p-60, -0x1p-1, -0x1.1eb3541b4b228p-5, -0x1.b090a581502p-1, --0x1.926da300ffccep-55, -0x1p-1, -0x1.097248d0a956ap-5, -0x1.b16742a4ca2f5p-1, --0x1.ba70972b80438p-55, -0x1p-1, -0x1.e84d76551cfb2p-6, -0x1.b23cd470013b4p-1, -0x1.5a1bb35ad6d2ep-56, -0x1p-1, -0x1.bda17097896b4p-6, -0x1.b3115a5f37bf3p-1, -0x1.dde2726e34fe1p-55, -0x1p-1, -0x1.92e09abb131d4p-6, -0x1.b3e4d3ef55712p-1, --0x1.eb6b8bf11a493p-55, -0x1p-1, -0x1.680b0f1f0bd73p-6, -0x1.b4b7409de7925p-1, -0x1.f4e257bde73d8p-56, -0x1p-1, -0x1.3d20e82f8bc1p-6, -0x1.b5889fe921405p-1, --0x1.df49b307c8602p-57, -0x1p-1, -0x1.1222406561182p-6, -0x1.b658f14fdbc47p-1, -0x1.52b5308f397dep-57, -0x1p-1, -0x1.ce1e648bffb66p-7, -0x1.b728345196e3ep-1, --0x1.bc69f324e6d61p-55, -0x1p-1, -0x1.77cfb0c6e2db8p-7, -0x1.b7f6686e792e9p-1, -0x1.87665bfea06aap-55, -0x1p-1, -0x1.21589ab88869cp-7, -0x1.b8c38d27504e9p-1, --0x1.1529abff40e45p-55, -0x1p-1, -0x1.9572af6decac8p-8, -0x1.b98fa1fd9155ep-1, -0x1.5559034fe85a4p-55, -0x1p-1, -0x1.cfc874c3eb6d9p-9, -0x1.ba5aa673590d2p-1, -0x1.7ea4e370753b6p-55, -0x1p-1, -0x1.d0320ae0b8293p-11, -0x1.bb249a0b6c40dp-1, --0x1.d6318ee919f7ap-58, -0x1p-1, --0x1.d09b418edf04ap-10, -0x1.bbed7c49380eap-1, -0x1.beacbd88500b4p-59, -0x1p-1, --0x1.22a28f6cb488bp-8, -0x1.bcb54cb0d2327p-1, -0x1.410923c55523ep-62, -0x1p-1, --0x1.d16c901d95181p-8, -0x1.bd7c0ac6f952ap-1, --0x1.825a732ac700ap-55, -0x1p-1, --0x1.4042335264ba3p-7, -0x1.be41b611154c1p-1, --0x1.fdcdad3a6877ep-55, -0x1p-1, --0x1.97f4d3805f318p-7, -0x1.bf064e15377ddp-1, -0x1.2156026a1e028p-57, -0x1p-1, --0x1.efcdf2801004ap-7, -0x1.bfc9d25a1b147p-1, --0x1.51bf4ee01357p-61, -0x1p-1, --0x1.23e6ad10872a7p-6, -0x1.c08c426725549p-1, -0x1.b157fd80e2946p-58, -0x1p-1, --0x1.4ff96a0da9dfbp-6, -0x1.c14d9dc465e57p-1, -0x1.ce36b64c7f3ccp-55, -0x1p-1, --0x1.7c1f1507aeec3p-6, -0x1.c20de3fa971bp-1, --0x1.b4ca2bab1322cp-55, -0x1p-1, --0x1.a85792c327db2p-6, -0x1.c2cd14931e3f1p-1, -0x1.2ce2f9d4600f5p-56, -0x1p-1, --0x1.d4a2c7f909c4ep-6, -0x1.c38b2f180bdb1p-1, --0x1.6e0b1757c8d07p-56, -0x1p-1, --0x1.00804cab5f113p-5, -0x1.c44833141c004p-1, -0x1.23e0521df01a2p-56, -0x1p-1, --0x1.16b875bf19d4p-5, -0x1.c5042012b6907p-1, --0x1.5c058dd8eaba5p-57, -0x1p-1, --0x1.2cf9d182f7939p-5, -0x1.c5bef59fef85ap-1, --0x1.f0a406c8b7468p-58, -0x1p-1, --0x1.4344523c8e3b5p-5, -0x1.c678b3488739bp-1, -0x1.d86cac7c5ff5bp-57, -0x1p-1, --0x1.5997ea2bcfb19p-5, -0x1.c7315899eaad7p-1, --0x1.9be5dcd047da7p-57, -0x1p-1, --0x1.6ff48b8b1252ap-5, -0x1.c7e8e52233cf3p-1, -0x1.b2ad324aa35c1p-57, -0x1p-1, --0x1.865a288f196fap-5, -0x1.c89f587029c13p-1, -0x1.588358ed6e78fp-58, -0x1p-1, --0x1.9cc8b3671dd0fp-5, -0x1.c954b213411f5p-1, --0x1.2fb761e946603p-58, -0x1p-1, --0x1.b3401e3cd63bbp-5, -0x1.ca08f19b9c449p-1, --0x1.431e0a5a737fdp-56, -0x1p-1, --0x1.c9c05b347ffabp-5, -0x1.cabc169a0b9p-1, -0x1.c42d3e10851d1p-55, -0x1p-1, --0x1.e0495c6ce76b5p-5, -0x1.cb6e20a00da99p-1, --0x1.4fb24b5194c1bp-55, -0x1p-1, --0x1.f6db13ff708cbp-5, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57613b68f6abp-56, -0x1p-1, --0x1.06baba000fc9bp-4, -0x1.cccee20c2deap-1, --0x1.d3116ae0e69e4p-55, -0x1p-1, --0x1.120c373ed0bfbp-4, -0x1.cd7d9898b32f6p-1, --0x1.f2fa062496738p-57, -0x1p-1, --0x1.1d61fac0aa5b2p-4, -0x1.ce2b32799a06p-1, --0x1.631d457e46317p-56, -0x1p-1, --0x1.28bbfd87a8cffp-4, -0x1.ced7af43cc773p-1, --0x1.e7b6bb5ab58aep-58, -0x1p-1, --0x1.341a389339a36p-4, -0x1.cf830e8ce467bp-1, --0x1.7b9202780d49dp-55, -0x1p-1, --0x1.3f7ca4e02ffdcp-4, -0x1.d02d4feb2bd92p-1, -0x1.195ff41bc55fep-55, -0x1p-1, --0x1.4ae33b68c8fdcp-4, -0x1.d0d672f59d2b9p-1, --0x1.c83009f0c39dep-55, -0x1p-1, --0x1.564df524b00dap-4, -0x1.d17e7743e35dcp-1, --0x1.101da3540130ap-58, -0x1p-1, --0x1.61bccb0903395p-4, -0x1.d2255c6e5a4e1p-1, --0x1.d129a71ecafc9p-55, -0x1p-1, --0x1.6d2fb6085786ep-4, -0x1.d2cb220e0ef9fp-1, --0x1.f07656d4e6652p-56, -0x1p-1, --0x1.78a6af12bd501p-4, -0x1.d36fc7bcbfbdcp-1, --0x1.ba196d95a177dp-55, -0x1p-1, --0x1.8421af15c49d7p-4, -0x1.d4134d14dc93ap-1, --0x1.4ef5295d25af2p-55, -0x1p-1, --0x1.8fa0aefc81837p-4, -0x1.d4b5b1b187524p-1, --0x1.f56be6b42b76dp-57, -0x1p-1, --0x1.9b23a7af90805p-4, -0x1.d556f52e93eb1p-1, --0x1.80ed9233a963p-55, -0x1p-1, --0x1.a6aa92151adc3p-4, -0x1.d5f7172888a7fp-1, --0x1.68663e2225755p-55, -0x1p-1, --0x1.b2356710db0a3p-4, -0x1.d696173c9e68bp-1, --0x1.e8c61c6393d55p-56, -0x1p-1, --0x1.bdc41f84210bbp-4, -0x1.d733f508c0dffp-1, --0x1.007928e770cd5p-55, -0x1p-1, --0x1.c956b44dd6d41p-4, -0x1.d7d0b02b8ecf9p-1, -0x1.800f4ce65cd6ep-55, -0x1p-1, --0x1.d4ed1e4a84aefp-4, -0x1.d86c48445a44fp-1, -0x1.e8813c023d71fp-55, -0x1p-1, --0x1.e087565455a75p-4, -0x1.d906bcf328d46p-1, -0x1.457e610231ac2p-56, -0x1p-1, --0x1.ec2555431bf03p-4, -0x1.d9a00dd8b3d46p-1, -0x1.bea0e4bac8e16p-58, -0x1p-1, --0x1.f7c713ec554fp-4, -0x1.da383a9668988p-1, --0x1.5811000b39d84p-55, -0x1p-1, --0x1.01b6459197c38p-3, -0x1.dacf42ce68ab9p-1, --0x1.fe8d76efdf896p-56, -0x1p-1, --0x1.078ad9dc46632p-3, -0x1.db6526238a09bp-1, --0x1.adee7eae6946p-56, -0x1p-1, --0x1.0d61433d840a4p-3, -0x1.dbf9e4395759ap-1, -0x1.d8ff7350f75fdp-55, -0x1p-1, --0x1.13397e1b7ce13p-3, -0x1.dc8d7cb41026p-1, -0x1.6b7872773830dp-56, -0x1p-1, --0x1.191386db3dedcp-3, -0x1.dd1fef38a915ap-1, --0x1.782f169e17f3bp-55, -0x1p-1, --0x1.1eef59e0b74c3p-3, -0x1.ddb13b6ccc23cp-1, -0x1.83c37c6107db3p-55, -0x1p-1, --0x1.24ccf38ebe694p-3, -0x1.de4160f6d8d81p-1, -0x1.9bf11cc5f8776p-55, -0x1p-1, --0x1.2aac5047103d3p-3, -0x1.ded05f7de47dap-1, --0x1.2cc4c1f8ba966p-55, -0x1p-1, -0x1.9ee5272b58f2ap-4, -0x1.df5e36a9ba59cp-1, --0x1.e01f8bceb43d3p-57, -0x1p-2, -0x1.931f774fc9f18p-4, -0x1.dfeae622dbe2bp-1, --0x1.514ea88425567p-55, -0x1p-2, -0x1.875657223080ap-4, -0x1.e0766d9280f54p-1, -0x1.f44c969cf62e3p-55, -0x1p-2, -0x1.7b89cde7a9a4dp-4, -0x1.e100cca2980acp-1, --0x1.02d182acdf825p-57, -0x1p-2, -0x1.6fb9e2e76ced8p-4, -0x1.e18a02fdc66d9p-1, -0x1.07e272abd88cfp-55, -0x1p-2, -0x1.63e69d6ac7f74p-4, -0x1.e212104f686e5p-1, --0x1.014c76c126527p-55, -0x1p-2, -0x1.581004bd19ed2p-4, -0x1.e298f4439197ap-1, -0x1.e84e601038eb2p-57, -0x1p-2, -0x1.4c36202bcf08ep-4, -0x1.e31eae870ce25p-1, --0x1.bc7094538d678p-56, -0x1p-2, -0x1.4058f7065c11ep-4, -0x1.e3a33ec75ce85p-1, -0x1.45089cd46bbb8p-57, -0x1p-2, -0x1.3478909e39da9p-4, -0x1.e426a4b2bc17ep-1, -0x1.a873889744882p-55, -0x1p-2, -0x1.2894f446e0bccp-4, -0x1.e4a8dff81ce5ep-1, -0x1.43578776c0f46p-55, -0x1p-2, -0x1.1cae2955c414fp-4, -0x1.e529f04729ffcp-1, -0x1.9075d6e6dfc8bp-55, -0x1p-2, -0x1.10c437224dbc2p-4, -0x1.e5a9d550467d3p-1, -0x1.7d431be53f92fp-56, -0x1p-2, -0x1.04d72505d9805p-4, -0x1.e6288ec48e112p-1, --0x1.16b56f2847754p-57, -0x1p-2, -0x1.f1cdf4b76138bp-5, -0x1.e6a61c55d53a7p-1, -0x1.660d981acdcf7p-56, -0x1p-2, -0x1.d9e77d020a5bcp-5, -0x1.e7227db6a9744p-1, -0x1.2128794da5a5p-55, -0x1p-2, -0x1.c1faf1a9db555p-5, -0x1.e79db29a5165ap-1, --0x1.75e710aca58p-56, -0x1p-2, -0x1.aa086170c0a8ep-5, -0x1.e817bab4cd10dp-1, --0x1.d0afe686b5e0ap-56, -0x1p-2, -0x1.920fdb1c5d578p-5, -0x1.e89095bad6025p-1, --0x1.5a4cc0fcbccap-55, -0x1p-2, -0x1.7a116d7601c35p-5, -0x1.e9084361df7f2p-1, -0x1.cdfc7ce9dc3e9p-55, -0x1p-2, -0x1.620d274aa2903p-5, -0x1.e97ec36016b3p-1, -0x1.5bc48562557d3p-55, -0x1p-2, -0x1.4a03176acf82dp-5, -0x1.e9f4156c62ddap-1, -0x1.760b1e2e3f81ep-55, -0x1p-2, -0x1.31f34caaaa5d2p-5, -0x1.ea68393e658p-1, --0x1.467259bb7b556p-56, -0x1p-2, -0x1.19ddd5e1ddb8bp-5, -0x1.eadb2e8e7a88ep-1, --0x1.92ec52ea226a3p-55, -0x1p-2, -0x1.01c2c1eb93deep-5, -0x1.eb4cf515b8811p-1, -0x1.95da1ba97ec5ep-57, -0x1p-2, -0x1.d3443f4cdb3ddp-6, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c615e7277p-56, -0x1p-2, -0x1.a2f7fbe8f2436p-6, -0x1.ec2cf4b1af6b2p-1, -0x1.34ee3f2caa62dp-59, -0x1p-2, -0x1.72a0d77651772p-6, -0x1.ec9b2d3c3bf84p-1, -0x1.19119d358de05p-56, -0x1p-2, -0x1.423eefc693785p-6, -0x1.ed0835e999009p-1, -0x1.499d188aa32fap-57, -0x1p-2, -0x1.11d262b1f6776p-6, -0x1.ed740e7684963p-1, -0x1.e82c791f59cc2p-56, -0x1p-2, -0x1.c2b69c2e939b5p-7, -0x1.eddeb6a078651p-1, --0x1.3b579af740a74p-55, -0x1p-2, -0x1.61b39fb7b7202p-7, -0x1.ee482e25a9dbcp-1, --0x1.b6066ef81af2ap-56, -0x1p-2, -0x1.009c0bd6cc3cbp-7, -0x1.eeb074c50a544p-1, -0x1.d925f656c43b4p-55, -0x1p-2, -0x1.3ee038dff6b8p-8, -0x1.ef178a3e473c2p-1, -0x1.6310a67fe774fp-55, -0x1p-2, -0x1.f1806b9fdd1afp-10, -0x1.ef7d6e51ca3cp-1, --0x1.a3c67c3d3f604p-55, -0x1p-2, --0x1.191f2900903a6p-10, -0x1.efe220c0b95ecp-1, -0x1.c853b7bf7e0cdp-55, -0x1p-2, --0x1.0916fe858ffcdp-8, -0x1.f045a14cf738cp-1, --0x1.a52c44f45216cp-55, -0x1p-2, --0x1.cc0d09bd41caap-8, -0x1.f0a7efb9230d7p-1, -0x1.52c7adc6b4989p-56, -0x1p-2, --0x1.4794b9d21cb87p-7, -0x1.f1090bc898f5fp-1, --0x1.baa64ab102a93p-55, -0x1p-2, --0x1.a935e1efe5e4bp-7, -0x1.f168f53f7205dp-1, --0x1.26a6c1f015601p-57, -0x1p-2, --0x1.0574e07f7b332p-6, -0x1.f1c7abe284708p-1, -0x1.504b80c8a63fcp-55, -0x1p-2, --0x1.36580d5d5e775p-6, -0x1.f2252f7763adap-1, --0x1.20cb81c8d94abp-55, -0x1p-2, --0x1.67445969a108ep-6, -0x1.f2817fc4609cep-1, --0x1.dd1f8eaf65689p-55, -0x1p-2, --0x1.9839a676a6bcfp-6, -0x1.f2dc9c9089a9dp-1, -0x1.5407460bdfc07p-59, -0x1p-2, --0x1.c937d65145919p-6, -0x1.f33685a3aaefp-1, -0x1.eb78685d850f8p-56, -0x1p-2, --0x1.fa3ecac0d84e8p-6, -0x1.f38f3ac64e589p-1, --0x1.d7bafb51f72e6p-56, -0x1p-2, --0x1.15a732c3a894dp-5, -0x1.f3e6bbc1bbc65p-1, -0x1.5774bb7e8a21ep-57, -0x1p-2, --0x1.2e334430a6376p-5, -0x1.f43d085ff92ddp-1, --0x1.8fde71e361c05p-55, -0x1p-2, --0x1.46c38a8311952p-5, -0x1.f492206bcabb4p-1, -0x1.d1e921bbe3bd3p-55, -0x1p-2, --0x1.5f57f693feebep-5, -0x1.f4e603b0b2f2dp-1, --0x1.8ee01e695ac05p-56, -0x1p-2, --0x1.77f07939f3897p-5, -0x1.f538b1faf2d07p-1, --0x1.5f7cd5099519cp-59, -0x1p-2, --0x1.908d0348ef266p-5, -0x1.f58a2b1789e84p-1, -0x1.1f4a188aa368p-56, -0x1p-2, --0x1.a92d859275418p-5, -0x1.f5da6ed43685dp-1, --0x1.536fc33bf9dd8p-55, -0x1p-2, --0x1.c1d1f0e5967d5p-5, -0x1.f6297cff75cbp-1, -0x1.562172a361fd3p-56, -0x1p-2, --0x1.da7a360ef9fefp-5, -0x1.f677556883ceep-1, -0x1.ef696a8d070f4p-57, -0x1p-2, --0x1.f32645d8e6ce9p-5, -0x1.f6c3f7df5bbb7p-1, -0x1.8561ce9d5ef5bp-56, -0x1p-2, --0x1.05eb0885a69c9p-4, -0x1.f70f6434b7eb7p-1, -0x1.1775df66f0ec4p-56, -0x1p-2, --0x1.1244c435e819dp-4, -0x1.f7599a3a12077p-1, -0x1.84f31d743195cp-55, -0x1p-2, --0x1.1ea04e5ee7601p-4, -0x1.f7a299c1a322ap-1, -0x1.6e7190c94899ep-56, -0x1p-2, --0x1.2afd9f6136a9cp-4, -0x1.f7ea629e63d6ep-1, -0x1.ba92d57ebfeddp-55, -0x1p-2, -0x1.9146a0c760c35p-5, -0x1.f830f4a40c60cp-1, -0x1.8528676925128p-57, -0x1p-3, -0x1.78851122cff19p-5, -0x1.f8764fa714ba9p-1, -0x1.ab256778ffcb6p-56, -0x1p-3, -0x1.5fc0219532f79p-5, -0x1.f8ba737cb4b78p-1, --0x1.da71f96d5a49cp-55, -0x1p-3, -0x1.46f7e165f17c8p-5, -0x1.f8fd5ffae41dbp-1, --0x1.8cfd77fd970d2p-56, -0x1p-3, -0x1.2e2c5fde7ea22p-5, -0x1.f93f14f85ac08p-1, --0x1.cfd153e9a9c1ap-55, -0x1p-3, -0x1.155dac4a4f967p-5, -0x1.f97f924c9099bp-1, --0x1.e2ae0eea5963bp-55, -0x1p-3, -0x1.f917abeda4499p-6, -0x1.f9bed7cfbde29p-1, --0x1.b35b1f9bcf70bp-56, -0x1p-3, -0x1.c76dd866c689ep-6, -0x1.f9fce55adb2c8p-1, -0x1.f2a06fab9f9d1p-56, -0x1p-3, -0x1.95bdfca28b53ap-6, -0x1.fa39bac7a1791p-1, --0x1.94f388f1b4e1ep-57, -0x1p-3, -0x1.64083747309d1p-6, -0x1.fa7557f08a517p-1, --0x1.7a0a8ca13571fp-55, -0x1p-3, -0x1.324ca6fe9a04bp-6, -0x1.faafbcb0cfddcp-1, --0x1.e349cb4d3e866p-55, -0x1p-3, -0x1.008b6a763de76p-6, -0x1.fae8e8e46cfbbp-1, --0x1.3a9e414732d97p-56, -0x1p-3, -0x1.9d8940be24e74p-7, -0x1.fb20dc681d54dp-1, --0x1.ff148ec7c5fafp-55, -0x1p-3, -0x1.39f0cedaf576bp-7, -0x1.fb5797195d741p-1, -0x1.1bfac7397cc08p-56, -0x1p-3, -0x1.ac9b7964cf0bap-8, -0x1.fb8d18d66adb7p-1, --0x1.d0b66224cce2ep-56, -0x1p-3, -0x1.ca811eea0c749p-9, -0x1.fbc1617e44186p-1, --0x1.58ec496dc4ecbp-59, -0x1p-3, -0x1.dd15adf70b65ap-12, -0x1.fbf470f0a8d88p-1, --0x1.6bb200d1d70b7p-55, -0x1p-3, --0x1.536352ad19e39p-9, -0x1.fc26470e19fd3p-1, -0x1.1ec8668ecaceep-55, -0x1p-3, --0x1.7148021b55c15p-8, -0x1.fc56e3b7d9af6p-1, --0x1.03ff7a673d3bdp-56, -0x1p-3, --0x1.1c789a28b01b7p-7, -0x1.fc8646cfeb721p-1, -0x1.3143dc43a9b9dp-55, -0x1p-3, --0x1.80566267c11f6p-7, -0x1.fcb4703914354p-1, -0x1.126aa7d51b25cp-55, -0x1p-3, --0x1.e43d1c309e958p-7, -0x1.fce15fd6da67bp-1, --0x1.5dd6f830d4c09p-56, -0x1p-3, --0x1.241644f1c26cep-6, -0x1.fd0d158d86087p-1, -0x1.9705a7b864883p-55, -0x1p-3, --0x1.561236eda8ff2p-6, -0x1.fd37914220b84p-1, -0x1.52e9d7b772791p-55, -0x1p-3, --0x1.88124536d5e8fp-6, -0x1.fd60d2da75c9ep-1, -0x1.36dedb314f0ebp-58, -0x1p-3, --0x1.ba1650f592f5p-6, -0x1.fd88da3d12526p-1, --0x1.87df6378811c7p-55, -0x1p-3, --0x1.ec1e3b4fb3d7ep-6, -0x1.fdafa7514538cp-1, -0x1.d97c45ca4d398p-59, -0x1p-3, --0x1.0f14f2b4549bdp-5, -0x1.fdd539ff1f456p-1, --0x1.ab13cbbec1781p-56, -0x1p-3, --0x1.281c9830c9dafp-5, -0x1.fdf9922f73307p-1, -0x1.a5e0abd3a9b65p-56, -0x1p-3, -0x1.7db402a6a9063p-6, -0x1.fe1cafcbd5b09p-1, -0x1.a23e3202a884ep-57, -0x1p-4, -0x1.4b9dd29353428p-6, -0x1.fe3e92be9d886p-1, -0x1.afeb2e264d46bp-57, -0x1p-4, -0x1.19845e49c8257p-6, -0x1.fe5f3af2e394p-1, -0x1.b213f18c9cf17p-55, -0x1p-4, -0x1.cecf8962d14c8p-7, -0x1.fe7ea85482d6p-1, -0x1.34b085c1828f7p-56, -0x1p-4, -0x1.6a9049670cfaep-7, -0x1.fe9cdad01883ap-1, -0x1.521ecd0c67e35p-57, -0x1p-4, -0x1.064b3a76a2264p-7, -0x1.feb9d2530410fp-1, -0x1.9d429eeda9bb9p-58, -0x1p-4, -0x1.440134d709b28p-8, -0x1.fed58ecb673c4p-1, --0x1.e6e462a7ae686p-56, -0x1p-4, -0x1.ed853918c18ecp-10, -0x1.fef0102826191p-1, -0x1.3c3ea4f30addap-56, -0x1p-4, --0x1.35230c0fbe402p-10, -0x1.ff095658e71adp-1, -0x1.01a8ce18a4b9ep-55, -0x1p-4, --0x1.15fc833fb89b8p-8, -0x1.ff21614e131edp-1, --0x1.de692a167353p-55, -0x1p-4, --0x1.deb9769f940eap-8, -0x1.ff3830f8d575cp-1, --0x1.95e1e79d335f7p-56, -0x1p-4, --0x1.53bf90a81f3a5p-7, -0x1.ff4dc54b1bed3p-1, --0x1.c1169ccd1e92ep-55, -0x1p-4, --0x1.b82683bc89fbp-7, -0x1.ff621e3796d7ep-1, --0x1.c57bc2e24aa15p-57, -0x1p-4, --0x1.0e48ab4f172f4p-6, -0x1.ff753bb1b9164p-1, --0x1.7c330129f56efp-56, -0x1p-4, -0x1.7f0034a43350ep-7, -0x1.ff871dadb81dfp-1, -0x1.8b1c676208aa4p-56, -0x1p-5, -0x1.1a8e5bfe185e4p-7, -0x1.ff97c4208c014p-1, -0x1.52ab2b947e843p-57, -0x1p-5, -0x1.6c32baca2ae69p-8, -0x1.ffa72effef75dp-1, --0x1.8b4cdcdb25956p-55, -0x1p-5, -0x1.4685db42c17ebp-9, -0x1.ffb55e425fdaep-1, -0x1.6da7ec781c225p-55, -0x1p-5, --0x1.2d919c5c61fep-11, -0x1.ffc251df1d3f8p-1, -0x1.7a7d209f32d43p-56, -0x1p-5, --0x1.dd58598d6271cp-9, -0x1.ffce09ce2a679p-1, --0x1.7bd62ab5ee228p-55, -0x1p-5, --0x1.b7aa821726608p-8, -0x1.ffd886084cd0dp-1, --0x1.1354d4556e4cbp-55, -0x1p-5, -0x1.7f53487eac897p-8, -0x1.ffe1c6870cb77p-1, -0x1.89aa14768323ep-55, -0x1p-6, -0x1.6c9b5df1877eap-9, -0x1.ffe9cb44b51a1p-1, -0x1.5b43366df667p-56, -0x1p-6, --0x1.2bad2a8cd06bp-12, -0x1.fff0943c53bd1p-1, --0x1.47399f361d158p-55, -0x1p-6, --0x1.b78b80c84e1eep-9, -0x1.fff62169b92dbp-1, -0x1.5dda3c81fbd0dp-55, -0x1p-6, -0x1.6cb587284b817p-10, -0x1.fffa72c978c4fp-1, --0x1.22cb000328f91p-55, -0x1p-7, --0x1.b783c0663fe3cp-10, -0x1.fffd8858e8a92p-1, -0x1.359c71883bcf7p-55, -0x1p-7, --0x1.b781d04cd6d17p-11, -0x1.ffff621621d02p-1, --0x1.6acfcebc82813p-56, -0x1p-8, -0, -0x1p0, -0, -0, -0x1.b781d04cd6d17p-11, -0x1.ffff621621d02p-1, --0x1.6acfcebc82813p-56, --0x1p-8, -0x1.b783c0663fe3cp-10, -0x1.fffd8858e8a92p-1, -0x1.359c71883bcf7p-55, --0x1p-7, --0x1.6cb587284b817p-10, -0x1.fffa72c978c4fp-1, --0x1.22cb000328f91p-55, --0x1p-7, -0x1.b78b80c84e1eep-9, -0x1.fff62169b92dbp-1, -0x1.5dda3c81fbd0dp-55, --0x1p-6, -0x1.2bad2a8cd06bp-12, -0x1.fff0943c53bd1p-1, --0x1.47399f361d158p-55, --0x1p-6, --0x1.6c9b5df1877eap-9, -0x1.ffe9cb44b51a1p-1, -0x1.5b43366df667p-56, --0x1p-6, --0x1.7f53487eac897p-8, -0x1.ffe1c6870cb77p-1, -0x1.89aa14768323ep-55, --0x1p-6, -0x1.b7aa821726608p-8, -0x1.ffd886084cd0dp-1, --0x1.1354d4556e4cbp-55, --0x1p-5, -0x1.dd58598d6271cp-9, -0x1.ffce09ce2a679p-1, --0x1.7bd62ab5ee228p-55, --0x1p-5, -0x1.2d919c5c61fep-11, -0x1.ffc251df1d3f8p-1, -0x1.7a7d209f32d43p-56, --0x1p-5, --0x1.4685db42c17ebp-9, -0x1.ffb55e425fdaep-1, -0x1.6da7ec781c225p-55, --0x1p-5, --0x1.6c32baca2ae69p-8, -0x1.ffa72effef75dp-1, --0x1.8b4cdcdb25956p-55, --0x1p-5, --0x1.1a8e5bfe185e4p-7, -0x1.ff97c4208c014p-1, -0x1.52ab2b947e843p-57, --0x1p-5, --0x1.7f0034a43350ep-7, -0x1.ff871dadb81dfp-1, -0x1.8b1c676208aa4p-56, --0x1p-5, -0x1.0e48ab4f172f4p-6, -0x1.ff753bb1b9164p-1, --0x1.7c330129f56efp-56, --0x1p-4, -0x1.b82683bc89fbp-7, -0x1.ff621e3796d7ep-1, --0x1.c57bc2e24aa15p-57, --0x1p-4, -0x1.53bf90a81f3a5p-7, -0x1.ff4dc54b1bed3p-1, --0x1.c1169ccd1e92ep-55, --0x1p-4, -0x1.deb9769f940eap-8, -0x1.ff3830f8d575cp-1, --0x1.95e1e79d335f7p-56, --0x1p-4, -0x1.15fc833fb89b8p-8, -0x1.ff21614e131edp-1, --0x1.de692a167353p-55, --0x1p-4, -0x1.35230c0fbe402p-10, -0x1.ff095658e71adp-1, -0x1.01a8ce18a4b9ep-55, --0x1p-4, --0x1.ed853918c18ecp-10, -0x1.fef0102826191p-1, -0x1.3c3ea4f30addap-56, --0x1p-4, --0x1.440134d709b28p-8, -0x1.fed58ecb673c4p-1, --0x1.e6e462a7ae686p-56, --0x1p-4, --0x1.064b3a76a2264p-7, -0x1.feb9d2530410fp-1, -0x1.9d429eeda9bb9p-58, --0x1p-4, --0x1.6a9049670cfaep-7, -0x1.fe9cdad01883ap-1, -0x1.521ecd0c67e35p-57, --0x1p-4, --0x1.cecf8962d14c8p-7, -0x1.fe7ea85482d6p-1, -0x1.34b085c1828f7p-56, --0x1p-4, --0x1.19845e49c8257p-6, -0x1.fe5f3af2e394p-1, -0x1.b213f18c9cf17p-55, --0x1p-4, --0x1.4b9dd29353428p-6, -0x1.fe3e92be9d886p-1, -0x1.afeb2e264d46bp-57, --0x1p-4, --0x1.7db402a6a9063p-6, -0x1.fe1cafcbd5b09p-1, -0x1.a23e3202a884ep-57, --0x1p-4, -0x1.281c9830c9dafp-5, -0x1.fdf9922f73307p-1, -0x1.a5e0abd3a9b65p-56, --0x1p-3, -0x1.0f14f2b4549bdp-5, -0x1.fdd539ff1f456p-1, --0x1.ab13cbbec1781p-56, --0x1p-3, -0x1.ec1e3b4fb3d7ep-6, -0x1.fdafa7514538cp-1, -0x1.d97c45ca4d398p-59, --0x1p-3, -0x1.ba1650f592f5p-6, -0x1.fd88da3d12526p-1, --0x1.87df6378811c7p-55, --0x1p-3, -0x1.88124536d5e8fp-6, -0x1.fd60d2da75c9ep-1, -0x1.36dedb314f0ebp-58, --0x1p-3, -0x1.561236eda8ff2p-6, -0x1.fd37914220b84p-1, -0x1.52e9d7b772791p-55, --0x1p-3, -0x1.241644f1c26cep-6, -0x1.fd0d158d86087p-1, -0x1.9705a7b864883p-55, --0x1p-3, -0x1.e43d1c309e958p-7, -0x1.fce15fd6da67bp-1, --0x1.5dd6f830d4c09p-56, --0x1p-3, -0x1.80566267c11f6p-7, -0x1.fcb4703914354p-1, -0x1.126aa7d51b25cp-55, --0x1p-3, -0x1.1c789a28b01b7p-7, -0x1.fc8646cfeb721p-1, -0x1.3143dc43a9b9dp-55, --0x1p-3, -0x1.7148021b55c15p-8, -0x1.fc56e3b7d9af6p-1, --0x1.03ff7a673d3bdp-56, --0x1p-3, -0x1.536352ad19e39p-9, -0x1.fc26470e19fd3p-1, -0x1.1ec8668ecaceep-55, --0x1p-3, --0x1.dd15adf70b65ap-12, -0x1.fbf470f0a8d88p-1, --0x1.6bb200d1d70b7p-55, --0x1p-3, --0x1.ca811eea0c749p-9, -0x1.fbc1617e44186p-1, --0x1.58ec496dc4ecbp-59, --0x1p-3, --0x1.ac9b7964cf0bap-8, -0x1.fb8d18d66adb7p-1, --0x1.d0b66224cce2ep-56, --0x1p-3, --0x1.39f0cedaf576bp-7, -0x1.fb5797195d741p-1, -0x1.1bfac7397cc08p-56, --0x1p-3, --0x1.9d8940be24e74p-7, -0x1.fb20dc681d54dp-1, --0x1.ff148ec7c5fafp-55, --0x1p-3, --0x1.008b6a763de76p-6, -0x1.fae8e8e46cfbbp-1, --0x1.3a9e414732d97p-56, --0x1p-3, --0x1.324ca6fe9a04bp-6, -0x1.faafbcb0cfddcp-1, --0x1.e349cb4d3e866p-55, --0x1p-3, --0x1.64083747309d1p-6, -0x1.fa7557f08a517p-1, --0x1.7a0a8ca13571fp-55, --0x1p-3, --0x1.95bdfca28b53ap-6, -0x1.fa39bac7a1791p-1, --0x1.94f388f1b4e1ep-57, --0x1p-3, --0x1.c76dd866c689ep-6, -0x1.f9fce55adb2c8p-1, -0x1.f2a06fab9f9d1p-56, --0x1p-3, --0x1.f917abeda4499p-6, -0x1.f9bed7cfbde29p-1, --0x1.b35b1f9bcf70bp-56, --0x1p-3, --0x1.155dac4a4f967p-5, -0x1.f97f924c9099bp-1, --0x1.e2ae0eea5963bp-55, --0x1p-3, --0x1.2e2c5fde7ea22p-5, -0x1.f93f14f85ac08p-1, --0x1.cfd153e9a9c1ap-55, --0x1p-3, --0x1.46f7e165f17c8p-5, -0x1.f8fd5ffae41dbp-1, --0x1.8cfd77fd970d2p-56, --0x1p-3, --0x1.5fc0219532f79p-5, -0x1.f8ba737cb4b78p-1, --0x1.da71f96d5a49cp-55, --0x1p-3, --0x1.78851122cff19p-5, -0x1.f8764fa714ba9p-1, -0x1.ab256778ffcb6p-56, --0x1p-3, --0x1.9146a0c760c35p-5, -0x1.f830f4a40c60cp-1, -0x1.8528676925128p-57, --0x1p-3, -0x1.2afd9f6136a9cp-4, -0x1.f7ea629e63d6ep-1, -0x1.ba92d57ebfeddp-55, --0x1p-2, -0x1.1ea04e5ee7601p-4, -0x1.f7a299c1a322ap-1, -0x1.6e7190c94899ep-56, --0x1p-2, -0x1.1244c435e819dp-4, -0x1.f7599a3a12077p-1, -0x1.84f31d743195cp-55, --0x1p-2, -0x1.05eb0885a69c9p-4, -0x1.f70f6434b7eb7p-1, -0x1.1775df66f0ec4p-56, --0x1p-2, -0x1.f32645d8e6ce9p-5, -0x1.f6c3f7df5bbb7p-1, -0x1.8561ce9d5ef5bp-56, --0x1p-2, -0x1.da7a360ef9fefp-5, -0x1.f677556883ceep-1, -0x1.ef696a8d070f4p-57, --0x1p-2, -0x1.c1d1f0e5967d5p-5, -0x1.f6297cff75cbp-1, -0x1.562172a361fd3p-56, --0x1p-2, -0x1.a92d859275418p-5, -0x1.f5da6ed43685dp-1, --0x1.536fc33bf9dd8p-55, --0x1p-2, -0x1.908d0348ef266p-5, -0x1.f58a2b1789e84p-1, -0x1.1f4a188aa368p-56, --0x1p-2, -0x1.77f07939f3897p-5, -0x1.f538b1faf2d07p-1, --0x1.5f7cd5099519cp-59, --0x1p-2, -0x1.5f57f693feebep-5, -0x1.f4e603b0b2f2dp-1, --0x1.8ee01e695ac05p-56, --0x1p-2, -0x1.46c38a8311952p-5, -0x1.f492206bcabb4p-1, -0x1.d1e921bbe3bd3p-55, --0x1p-2, -0x1.2e334430a6376p-5, -0x1.f43d085ff92ddp-1, --0x1.8fde71e361c05p-55, --0x1p-2, -0x1.15a732c3a894dp-5, -0x1.f3e6bbc1bbc65p-1, -0x1.5774bb7e8a21ep-57, --0x1p-2, -0x1.fa3ecac0d84e8p-6, -0x1.f38f3ac64e589p-1, --0x1.d7bafb51f72e6p-56, --0x1p-2, -0x1.c937d65145919p-6, -0x1.f33685a3aaefp-1, -0x1.eb78685d850f8p-56, --0x1p-2, -0x1.9839a676a6bcfp-6, -0x1.f2dc9c9089a9dp-1, -0x1.5407460bdfc07p-59, --0x1p-2, -0x1.67445969a108ep-6, -0x1.f2817fc4609cep-1, --0x1.dd1f8eaf65689p-55, --0x1p-2, -0x1.36580d5d5e775p-6, -0x1.f2252f7763adap-1, --0x1.20cb81c8d94abp-55, --0x1p-2, -0x1.0574e07f7b332p-6, -0x1.f1c7abe284708p-1, -0x1.504b80c8a63fcp-55, --0x1p-2, -0x1.a935e1efe5e4bp-7, -0x1.f168f53f7205dp-1, --0x1.26a6c1f015601p-57, --0x1p-2, -0x1.4794b9d21cb87p-7, -0x1.f1090bc898f5fp-1, --0x1.baa64ab102a93p-55, --0x1p-2, -0x1.cc0d09bd41caap-8, -0x1.f0a7efb9230d7p-1, -0x1.52c7adc6b4989p-56, --0x1p-2, -0x1.0916fe858ffcdp-8, -0x1.f045a14cf738cp-1, --0x1.a52c44f45216cp-55, --0x1p-2, -0x1.191f2900903a6p-10, -0x1.efe220c0b95ecp-1, -0x1.c853b7bf7e0cdp-55, --0x1p-2, --0x1.f1806b9fdd1afp-10, -0x1.ef7d6e51ca3cp-1, --0x1.a3c67c3d3f604p-55, --0x1p-2, --0x1.3ee038dff6b8p-8, -0x1.ef178a3e473c2p-1, -0x1.6310a67fe774fp-55, --0x1p-2, --0x1.009c0bd6cc3cbp-7, -0x1.eeb074c50a544p-1, -0x1.d925f656c43b4p-55, --0x1p-2, --0x1.61b39fb7b7202p-7, -0x1.ee482e25a9dbcp-1, --0x1.b6066ef81af2ap-56, --0x1p-2, --0x1.c2b69c2e939b5p-7, -0x1.eddeb6a078651p-1, --0x1.3b579af740a74p-55, --0x1p-2, --0x1.11d262b1f6776p-6, -0x1.ed740e7684963p-1, -0x1.e82c791f59cc2p-56, --0x1p-2, --0x1.423eefc693785p-6, -0x1.ed0835e999009p-1, -0x1.499d188aa32fap-57, --0x1p-2, --0x1.72a0d77651772p-6, -0x1.ec9b2d3c3bf84p-1, -0x1.19119d358de05p-56, --0x1p-2, --0x1.a2f7fbe8f2436p-6, -0x1.ec2cf4b1af6b2p-1, -0x1.34ee3f2caa62dp-59, --0x1p-2, --0x1.d3443f4cdb3ddp-6, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c615e7277p-56, --0x1p-2, --0x1.01c2c1eb93deep-5, -0x1.eb4cf515b8811p-1, -0x1.95da1ba97ec5ep-57, --0x1p-2, --0x1.19ddd5e1ddb8bp-5, -0x1.eadb2e8e7a88ep-1, --0x1.92ec52ea226a3p-55, --0x1p-2, --0x1.31f34caaaa5d2p-5, -0x1.ea68393e658p-1, --0x1.467259bb7b556p-56, --0x1p-2, --0x1.4a03176acf82dp-5, -0x1.e9f4156c62ddap-1, -0x1.760b1e2e3f81ep-55, --0x1p-2, --0x1.620d274aa2903p-5, -0x1.e97ec36016b3p-1, -0x1.5bc48562557d3p-55, --0x1p-2, --0x1.7a116d7601c35p-5, -0x1.e9084361df7f2p-1, -0x1.cdfc7ce9dc3e9p-55, --0x1p-2, --0x1.920fdb1c5d578p-5, -0x1.e89095bad6025p-1, --0x1.5a4cc0fcbccap-55, --0x1p-2, --0x1.aa086170c0a8ep-5, -0x1.e817bab4cd10dp-1, --0x1.d0afe686b5e0ap-56, --0x1p-2, --0x1.c1faf1a9db555p-5, -0x1.e79db29a5165ap-1, --0x1.75e710aca58p-56, --0x1p-2, --0x1.d9e77d020a5bcp-5, -0x1.e7227db6a9744p-1, -0x1.2128794da5a5p-55, --0x1p-2, --0x1.f1cdf4b76138bp-5, -0x1.e6a61c55d53a7p-1, -0x1.660d981acdcf7p-56, --0x1p-2, --0x1.04d72505d9805p-4, -0x1.e6288ec48e112p-1, --0x1.16b56f2847754p-57, --0x1p-2, --0x1.10c437224dbc2p-4, -0x1.e5a9d550467d3p-1, -0x1.7d431be53f92fp-56, --0x1p-2, --0x1.1cae2955c414fp-4, -0x1.e529f04729ffcp-1, -0x1.9075d6e6dfc8bp-55, --0x1p-2, --0x1.2894f446e0bccp-4, -0x1.e4a8dff81ce5ep-1, -0x1.43578776c0f46p-55, --0x1p-2, --0x1.3478909e39da9p-4, -0x1.e426a4b2bc17ep-1, -0x1.a873889744882p-55, --0x1p-2, --0x1.4058f7065c11ep-4, -0x1.e3a33ec75ce85p-1, -0x1.45089cd46bbb8p-57, --0x1p-2, --0x1.4c36202bcf08ep-4, -0x1.e31eae870ce25p-1, --0x1.bc7094538d678p-56, --0x1p-2, --0x1.581004bd19ed2p-4, -0x1.e298f4439197ap-1, -0x1.e84e601038eb2p-57, --0x1p-2, --0x1.63e69d6ac7f74p-4, -0x1.e212104f686e5p-1, --0x1.014c76c126527p-55, --0x1p-2, --0x1.6fb9e2e76ced8p-4, -0x1.e18a02fdc66d9p-1, -0x1.07e272abd88cfp-55, --0x1p-2, --0x1.7b89cde7a9a4dp-4, -0x1.e100cca2980acp-1, --0x1.02d182acdf825p-57, --0x1p-2, --0x1.875657223080ap-4, -0x1.e0766d9280f54p-1, -0x1.f44c969cf62e3p-55, --0x1p-2, --0x1.931f774fc9f18p-4, -0x1.dfeae622dbe2bp-1, --0x1.514ea88425567p-55, --0x1p-2, --0x1.9ee5272b58f2ap-4, -0x1.df5e36a9ba59cp-1, --0x1.e01f8bceb43d3p-57, --0x1p-2, -0x1.2aac5047103d3p-3, -0x1.ded05f7de47dap-1, --0x1.2cc4c1f8ba966p-55, --0x1p-1, -0x1.24ccf38ebe694p-3, -0x1.de4160f6d8d81p-1, -0x1.9bf11cc5f8776p-55, --0x1p-1, -0x1.1eef59e0b74c3p-3, -0x1.ddb13b6ccc23cp-1, -0x1.83c37c6107db3p-55, --0x1p-1, -0x1.191386db3dedcp-3, -0x1.dd1fef38a915ap-1, --0x1.782f169e17f3bp-55, --0x1p-1, -0x1.13397e1b7ce13p-3, -0x1.dc8d7cb41026p-1, -0x1.6b7872773830dp-56, --0x1p-1, -0x1.0d61433d840a4p-3, -0x1.dbf9e4395759ap-1, -0x1.d8ff7350f75fdp-55, --0x1p-1, -0x1.078ad9dc46632p-3, -0x1.db6526238a09bp-1, --0x1.adee7eae6946p-56, --0x1p-1, -0x1.01b6459197c38p-3, -0x1.dacf42ce68ab9p-1, --0x1.fe8d76efdf896p-56, --0x1p-1, -0x1.f7c713ec554fp-4, -0x1.da383a9668988p-1, --0x1.5811000b39d84p-55, --0x1p-1, -0x1.ec2555431bf03p-4, -0x1.d9a00dd8b3d46p-1, -0x1.bea0e4bac8e16p-58, --0x1p-1, -0x1.e087565455a75p-4, -0x1.d906bcf328d46p-1, -0x1.457e610231ac2p-56, --0x1p-1, -0x1.d4ed1e4a84aefp-4, -0x1.d86c48445a44fp-1, -0x1.e8813c023d71fp-55, --0x1p-1, -0x1.c956b44dd6d41p-4, -0x1.d7d0b02b8ecf9p-1, -0x1.800f4ce65cd6ep-55, --0x1p-1, -0x1.bdc41f84210bbp-4, -0x1.d733f508c0dffp-1, --0x1.007928e770cd5p-55, --0x1p-1, -0x1.b2356710db0a3p-4, -0x1.d696173c9e68bp-1, --0x1.e8c61c6393d55p-56, --0x1p-1, -0x1.a6aa92151adc3p-4, -0x1.d5f7172888a7fp-1, --0x1.68663e2225755p-55, --0x1p-1, -0x1.9b23a7af90805p-4, -0x1.d556f52e93eb1p-1, --0x1.80ed9233a963p-55, --0x1p-1, -0x1.8fa0aefc81837p-4, -0x1.d4b5b1b187524p-1, --0x1.f56be6b42b76dp-57, --0x1p-1, -0x1.8421af15c49d7p-4, -0x1.d4134d14dc93ap-1, --0x1.4ef5295d25af2p-55, --0x1p-1, -0x1.78a6af12bd501p-4, -0x1.d36fc7bcbfbdcp-1, --0x1.ba196d95a177dp-55, --0x1p-1, -0x1.6d2fb6085786ep-4, -0x1.d2cb220e0ef9fp-1, --0x1.f07656d4e6652p-56, --0x1p-1, -0x1.61bccb0903395p-4, -0x1.d2255c6e5a4e1p-1, --0x1.d129a71ecafc9p-55, --0x1p-1, -0x1.564df524b00dap-4, -0x1.d17e7743e35dcp-1, --0x1.101da3540130ap-58, --0x1p-1, -0x1.4ae33b68c8fdcp-4, -0x1.d0d672f59d2b9p-1, --0x1.c83009f0c39dep-55, --0x1p-1, -0x1.3f7ca4e02ffdcp-4, -0x1.d02d4feb2bd92p-1, -0x1.195ff41bc55fep-55, --0x1p-1, -0x1.341a389339a36p-4, -0x1.cf830e8ce467bp-1, --0x1.7b9202780d49dp-55, --0x1p-1, -0x1.28bbfd87a8cffp-4, -0x1.ced7af43cc773p-1, --0x1.e7b6bb5ab58aep-58, --0x1p-1, -0x1.1d61fac0aa5b2p-4, -0x1.ce2b32799a06p-1, --0x1.631d457e46317p-56, --0x1p-1, -0x1.120c373ed0bfbp-4, -0x1.cd7d9898b32f6p-1, --0x1.f2fa062496738p-57, --0x1p-1, -0x1.06baba000fc9bp-4, -0x1.cccee20c2deap-1, --0x1.d3116ae0e69e4p-55, --0x1p-1, -0x1.f6db13ff708cbp-5, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57613b68f6abp-56, --0x1p-1, -0x1.e0495c6ce76b5p-5, -0x1.cb6e20a00da99p-1, --0x1.4fb24b5194c1bp-55, --0x1p-1, -0x1.c9c05b347ffabp-5, -0x1.cabc169a0b9p-1, -0x1.c42d3e10851d1p-55, --0x1p-1, -0x1.b3401e3cd63bbp-5, -0x1.ca08f19b9c449p-1, --0x1.431e0a5a737fdp-56, --0x1p-1, -0x1.9cc8b3671dd0fp-5, -0x1.c954b213411f5p-1, --0x1.2fb761e946603p-58, --0x1p-1, -0x1.865a288f196fap-5, -0x1.c89f587029c13p-1, -0x1.588358ed6e78fp-58, --0x1p-1, -0x1.6ff48b8b1252ap-5, -0x1.c7e8e52233cf3p-1, -0x1.b2ad324aa35c1p-57, --0x1p-1, -0x1.5997ea2bcfb19p-5, -0x1.c7315899eaad7p-1, --0x1.9be5dcd047da7p-57, --0x1p-1, -0x1.4344523c8e3b5p-5, -0x1.c678b3488739bp-1, -0x1.d86cac7c5ff5bp-57, --0x1p-1, -0x1.2cf9d182f7939p-5, -0x1.c5bef59fef85ap-1, --0x1.f0a406c8b7468p-58, --0x1p-1, -0x1.16b875bf19d4p-5, -0x1.c5042012b6907p-1, --0x1.5c058dd8eaba5p-57, --0x1p-1, -0x1.00804cab5f113p-5, -0x1.c44833141c004p-1, -0x1.23e0521df01a2p-56, --0x1p-1, -0x1.d4a2c7f909c4ep-6, -0x1.c38b2f180bdb1p-1, --0x1.6e0b1757c8d07p-56, --0x1p-1, -0x1.a85792c327db2p-6, -0x1.c2cd14931e3f1p-1, -0x1.2ce2f9d4600f5p-56, --0x1p-1, -0x1.7c1f1507aeec3p-6, -0x1.c20de3fa971bp-1, --0x1.b4ca2bab1322cp-55, --0x1p-1, -0x1.4ff96a0da9dfbp-6, -0x1.c14d9dc465e57p-1, -0x1.ce36b64c7f3ccp-55, --0x1p-1, -0x1.23e6ad10872a7p-6, -0x1.c08c426725549p-1, -0x1.b157fd80e2946p-58, --0x1p-1, -0x1.efcdf2801004ap-7, -0x1.bfc9d25a1b147p-1, --0x1.51bf4ee01357p-61, --0x1p-1, -0x1.97f4d3805f318p-7, -0x1.bf064e15377ddp-1, -0x1.2156026a1e028p-57, --0x1p-1, -0x1.4042335264ba3p-7, -0x1.be41b611154c1p-1, --0x1.fdcdad3a6877ep-55, --0x1p-1, -0x1.d16c901d95181p-8, -0x1.bd7c0ac6f952ap-1, --0x1.825a732ac700ap-55, --0x1p-1, -0x1.22a28f6cb488bp-8, -0x1.bcb54cb0d2327p-1, -0x1.410923c55523ep-62, --0x1p-1, -0x1.d09b418edf04ap-10, -0x1.bbed7c49380eap-1, -0x1.beacbd88500b4p-59, --0x1p-1, --0x1.d0320ae0b8293p-11, -0x1.bb249a0b6c40dp-1, --0x1.d6318ee919f7ap-58, --0x1p-1, --0x1.cfc874c3eb6d9p-9, -0x1.ba5aa673590d2p-1, -0x1.7ea4e370753b6p-55, --0x1p-1, --0x1.9572af6decac8p-8, -0x1.b98fa1fd9155ep-1, -0x1.5559034fe85a4p-55, --0x1p-1, --0x1.21589ab88869cp-7, -0x1.b8c38d27504e9p-1, --0x1.1529abff40e45p-55, --0x1p-1, --0x1.77cfb0c6e2db8p-7, -0x1.b7f6686e792e9p-1, -0x1.87665bfea06aap-55, --0x1p-1, --0x1.ce1e648bffb66p-7, -0x1.b728345196e3ep-1, --0x1.bc69f324e6d61p-55, --0x1p-1, --0x1.1222406561182p-6, -0x1.b658f14fdbc47p-1, -0x1.52b5308f397dep-57, --0x1p-1, --0x1.3d20e82f8bc1p-6, -0x1.b5889fe921405p-1, --0x1.df49b307c8602p-57, --0x1p-1, --0x1.680b0f1f0bd73p-6, -0x1.b4b7409de7925p-1, -0x1.f4e257bde73d8p-56, --0x1p-1, --0x1.92e09abb131d4p-6, -0x1.b3e4d3ef55712p-1, --0x1.eb6b8bf11a493p-55, --0x1p-1, --0x1.bda17097896b4p-6, -0x1.b3115a5f37bf3p-1, -0x1.dde2726e34fe1p-55, --0x1p-1, --0x1.e84d76551cfb2p-6, -0x1.b23cd470013b4p-1, -0x1.5a1bb35ad6d2ep-56, --0x1p-1, --0x1.097248d0a956ap-5, -0x1.b16742a4ca2f5p-1, --0x1.ba70972b80438p-55, --0x1p-1, --0x1.1eb3541b4b228p-5, -0x1.b090a581502p-1, --0x1.926da300ffccep-55, --0x1p-1, --0x1.33e9cfee254edp-5, -0x1.afb8fd89f57b6p-1, -0x1.1ced12d2899b8p-60, --0x1p-1, --0x1.4915af336ceb4p-5, -0x1.aee04b43c1474p-1, --0x1.3a79a438bf8ccp-55, --0x1p-1, --0x1.5e36e4dbe2bc2p-5, -0x1.ae068f345ecefp-1, --0x1.33934c4029a4cp-56, --0x1p-1, --0x1.734d63dedb48ap-5, -0x1.ad2bc9e21d511p-1, --0x1.47fbe07bea548p-55, --0x1p-1, --0x1.88591f3a46e4dp-5, -0x1.ac4ffbd3efac8p-1, --0x1.818504103fa16p-56, --0x1p-1, --0x1.9d5a09f2b9b7fp-5, -0x1.ab7325916c0d4p-1, -0x1.a8b8c85baaa9bp-55, --0x1p-1, --0x1.b250171373be9p-5, -0x1.aa9547a2cb98ep-1, -0x1.87d00ae97abaap-60, --0x1p-1, --0x1.c73b39ae68c87p-5, -0x1.a9b66290ea1a3p-1, -0x1.9f630e8b6dac8p-60, --0x1p-1, --0x1.dc1b64dc48722p-5, -0x1.a8d676e545ad2p-1, --0x1.b11dcce2e74bdp-59, --0x1p-1, --0x1.f0f08bbc861afp-5, -0x1.a7f58529fe69dp-1, --0x1.97a441584a179p-55, --0x1p-1, --0x1.02dd50bab06b2p-4, -0x1.a7138de9d60f5p-1, --0x1.f1ab82a9c5f2dp-55, --0x1p-1, --0x1.0d3ccc99f5ac6p-4, -0x1.a63091b02fae2p-1, --0x1.e911152248d1p-56, --0x1p-1, --0x1.1796b31609f0cp-4, -0x1.a54c91090f523p-1, -0x1.184300fd1c1cep-56, --0x1p-1, --0x1.21eafdcc560fap-4, -0x1.a4678c8119ac8p-1, -0x1.1b4c0dd3f212ap-55, --0x1p-1, --0x1.2c39a65db8881p-4, -0x1.a38184a593bc6p-1, --0x1.bc92c5bd2d288p-55, --0x1p-1, --0x1.3682a66e896f5p-4, -0x1.a29a7a0462782p-1, --0x1.128bb015df175p-56, --0x1p-1, --0x1.40c5f7a69e5cep-4, -0x1.a1b26d2c0a75ep-1, -0x1.30ef431d627a6p-57, --0x1p-1, --0x1.4b0393b14e541p-4, -0x1.a0c95eabaf937p-1, --0x1.e0ca3acbd049ap-55, --0x1p-1, --0x1.553b743d75acp-4, -0x1.9fdf4f13149dep-1, -0x1.1e6d79006ec09p-55, --0x1p-1, --0x1.5f6d92fd79f5p-4, -0x1.9ef43ef29af94p-1, -0x1.b1dfcb60445c2p-56, --0x1p-1, --0x1.6999e9a74ddbep-4, -0x1.9e082edb42472p-1, -0x1.5809a4e121e22p-57, --0x1p-1, --0x1.73c071f4750b5p-4, -0x1.9d1b1f5ea80d5p-1, -0x1.c5fadd5ffb36fp-55, --0x1p-1, --0x1.7de125a2080a9p-4, -0x1.9c2d110f075c2p-1, -0x1.d9c9f1c8c30dp-55, --0x1p-1, --0x1.87fbfe70b81a7p-4, -0x1.9b3e047f38741p-1, --0x1.30ee286712474p-55, --0x1p-1, --0x1.9210f624d30fbp-4, -0x1.9a4dfa42b06b2p-1, --0x1.829b6b8b1c947p-56, --0x1p-1, --0x1.9c200686472b5p-4, -0x1.995cf2ed80d22p-1, -0x1.7783e907fbd7bp-56, --0x1p-1, --0x1.a6292960a6f0bp-4, -0x1.986aef1457594p-1, --0x1.af03e318f38fcp-55, --0x1p-1, --0x1.b02c58832cf96p-4, -0x1.9777ef4c7d742p-1, --0x1.15479a240665ep-55, --0x1p-1, --0x1.ba298dc0bfc6bp-4, -0x1.9683f42bd7fe1p-1, --0x1.11bad933c835ep-57, --0x1p-1, --0x1.c420c2eff590ep-4, -0x1.958efe48e6dd7p-1, --0x1.561335da0f4e7p-55, --0x1p-1, --0x1.ce11f1eb18148p-4, -0x1.94990e3ac4a6cp-1, -0x1.a95328edeb3e6p-56, --0x1p-1, --0x1.d7fd1490285cap-4, -0x1.93a22499263fbp-1, -0x1.3d419a920df0bp-55, --0x1p-1, --0x1.e1e224c0e28bdp-4, -0x1.92aa41fc5a815p-1, --0x1.68f89e2d23db7p-57, --0x1p-1, --0x1.ebc11c62c1a1ep-4, -0x1.91b166fd49da2p-1, --0x1.3be953a7fe996p-57, --0x1p-1, --0x1.f599f55f034p-4, -0x1.90b7943575efep-1, -0x1.4ecb0c5273706p-57, --0x1p-1, --0x1.ff6ca9a2ab6a2p-4, -0x1.8fbcca3ef940dp-1, --0x1.6dfa99c86f2f1p-57, --0x1p-1, --0x1.049c998f44231p-3, -0x1.8ec109b486c49p-1, --0x1.cb2a3eb6af617p-56, --0x1p-1, --0x1.097fc5e39aec5p-3, -0x1.8dc45331698ccp-1, -0x1.1d9fcd83634d7p-57, --0x1p-1, --0x1.0e5fd6ca90dffp-3, -0x1.8cc6a75184655p-1, --0x1.e18b3657e2285p-55, --0x1p-1, --0x1.133cc94247758p-3, -0x1.8bc806b151741p-1, --0x1.2c5e12ed1336dp-55, --0x1p-1, --0x1.18169a4acca89p-3, -0x1.8ac871ede1d88p-1, --0x1.9afaa5b7cfc55p-55, --0x1p-1, --0x1.1ced46e61cd1cp-3, -0x1.89c7e9a4dd4aap-1, -0x1.db6ea04a8678fp-55, --0x1p-1, --0x1.21c0cc18247fcp-3, -0x1.88c66e7481ba1p-1, --0x1.5c6228970cf35p-56, --0x1p-1, --0x1.269126e6c24e3p-3, -0x1.87c400fba2ebfp-1, --0x1.2dabc0c3f64cdp-55, --0x1p-1, --0x1.2b5e5459c8bc3p-3, -0x1.86c0a1d9aa195p-1, -0x1.84564f09c3726p-59, --0x1p-1, --0x1.3028517b0001p-3, -0x1.85bc51ae958ccp-1, -0x1.45ba6478086ccp-55, --0x1p-1, --0x1.34ef1b5627dfdp-3, -0x1.84b7111af83fap-1, --0x1.63a47df0b21bap-55, --0x1p-1, --0x1.39b2aef8f97a4p-3, -0x1.83b0e0bff976ep-1, --0x1.6f420f8ea3475p-56, --0x1p-1, --0x1.3e73097329219p-3, -0x1.82a9c13f545ffp-1, --0x1.65e87a7a8cde9p-56, --0x1p-1, --0x1.433027d66826dp-3, -0x1.81a1b33b57accp-1, --0x1.5dea12d66bb66p-55, --0x1p-1, --0x1.47ea073666a98p-3, -0x1.8098b756e52fap-1, -0x1.9136e834b4707p-55, --0x1p-1, --0x1.4ca0a4a8d5657p-3, -0x1.7f8ece3571771p-1, --0x1.9c8d8ce93c917p-55, --0x1p-1, --0x1.5153fd45677efp-3, -0x1.7e83f87b03686p-1, -0x1.b61a8ccabad6p-57, --0x1p-1, --0x1.56040e25d44ddp-3, -0x1.7d7836cc33db2p-1, -0x1.162715ef03f85p-56, --0x1p-1, --0x1.5ab0d465d927ap-3, -0x1.7c6b89ce2d333p-1, --0x1.cfd628084982cp-56, --0x1p-1, --0x1.5f5a4d233b27fp-3, -0x1.7b5df226aafafp-1, --0x1.0f537acdf0ad7p-56, --0x1p-1, --0x1.6400757dc8f7dp-3, -0x1.7a4f707bf97d2p-1, -0x1.3c9751b491eafp-55, --0x1p-1, --0x1.68a34a975c941p-3, -0x1.79400574f55e5p-1, --0x1.0adadbdb4c65ap-55, --0x1p-1, --0x1.6d42c993dd121p-3, -0x1.782fb1b90b35bp-1, --0x1.3e46c1dfd001cp-55, --0x1p-1, --0x1.71deef9940631p-3, -0x1.771e75f037261p-1, -0x1.5cfce8d84068fp-56, --0x1p-1, --0x1.7677b9cf8d17p-3, -0x1.760c52c304764p-1, --0x1.11d76f8e50f1fp-55, --0x1p-1, --0x1.7b0d2560dc1d1p-3, -0x1.74f948da8d28dp-1, -0x1.19900a3b9a3a2p-63, --0x1p-1, --0x1.7f9f2f795a83ep-3, -0x1.73e558e079942p-1, --0x1.2663126697f5ep-55, --0x1p-1, --0x1.842dd5474b37bp-3, -0x1.72d0837efff96p-1, -0x1.0d4ef0f1d915cp-55, --0x1p-1, --0x1.88b913fb08bfdp-3, -0x1.71bac960e41bfp-1, --0x1.b858d90b0f7d8p-56, --0x1p-1, --0x1.8d40e8c706fa4p-3, -0x1.70a42b3176d7ap-1, --0x1.d9e3fbe2e15ap-56, --0x1p-1, --0x1.91c550dfd4d6bp-3, -0x1.6f8ca99c95b75p-1, -0x1.f22e7a35723f4p-56, --0x1p-1, --0x1.9646497c1e0f6p-3, -0x1.6e74454eaa8afp-1, --0x1.dbc03c84e226ep-55, --0x1p-1, --0x1.9ac3cfd4ace19p-3, -0x1.6d5afef4aafcdp-1, --0x1.868a696b8835ep-55, --0x1p-1, --0x1.9f3de1246bc4p-3, -0x1.6c40d73c18275p-1, -0x1.25d4f802be257p-57, --0x1p-1, --0x1.a3b47aa8671c5p-3, -0x1.6b25ced2fe29cp-1, --0x1.5ac64116beda5p-55, --0x1p-1, -0, -0x1.6a09e667f3bcdp-1, --0x1.bdd3413b26456p-55, -0, -0x1.29b4625a03ac9p-2, -0x1.68ed1eaa19c71p-1, -0x1.fd4a85350f69p-56, --0x1p0, -0x1.277e5187cfb16p-2, -0x1.67cf78491af1p-1, -0x1.750ab23477b61p-59, --0x1p0, -0x1.254a0216aa067p-2, -0x1.66b0f3f52b386p-1, -0x1.1e2eb31a8848bp-55, --0x1p0, -0x1.23177562aaea3p-2, -0x1.6591925f0783dp-1, -0x1.c3d64fbf5de23p-55, --0x1p0, -0x1.20e6acc6d4916p-2, -0x1.64715437f535bp-1, --0x1.7c399c15a17dp-55, --0x1p0, -0x1.1eb7a99d1250cp-2, -0x1.63503a31c1be9p-1, -0x1.1248f09e6587cp-57, --0x1p0, -0x1.1c8a6d3e37c82p-2, -0x1.622e44fec22ffp-1, -0x1.f98d8be132d57p-56, --0x1p0, -0x1.1a5ef902000d3p-2, -0x1.610b7551d2cdfp-1, --0x1.251b352ff2a37p-56, --0x1p0, -0x1.18354e3f0cd7dp-2, -0x1.5fe7cbde56a1p-1, --0x1.fcb9cc30cc01ep-55, --0x1p0, -0x1.160d6e4ae5ae6p-2, -0x1.5ec3495837074p-1, -0x1.dea89a9b8f727p-56, --0x1p0, -0x1.13e75a79f7139p-2, -0x1.5d9dee73e345cp-1, --0x1.de1165ecdf7a3p-57, --0x1p0, -0x1.11c3141f91b3ep-2, -0x1.5c77bbe65018cp-1, -0x1.069ea9c0bc32ap-55, --0x1p0, -0x1.0fa09c8de994bp-2, -0x1.5b50b264f7448p-1, -0x1.519d30d4cfebp-56, --0x1p0, -0x1.0d7ff51615437p-2, -0x1.5a28d2a5d725p-1, -0x1.57a25f8b1343p-55, --0x1p0, -0x1.0b611f080d05bp-2, -0x1.59001d5f723dfp-1, -0x1.a9f86ba0dde98p-56, --0x1p0, -0x1.09441bb2aa0a2p-2, -0x1.57d69348cecap-1, --0x1.75720992bfbb2p-55, --0x1p0, -0x1.0728ec63a599ap-2, -0x1.56ac35197649fp-1, --0x1.f7874188cb279p-55, --0x1p0, -0x1.050f92679849cp-2, -0x1.5581038975137p-1, -0x1.4570d9efe26dfp-55, --0x1p0, -0x1.02f80f09f92f4p-2, -0x1.5454ff5159dfcp-1, --0x1.4e247588bf256p-55, --0x1p0, -0x1.00e263951d11fp-2, -0x1.5328292a35596p-1, --0x1.a12eb89da0257p-56, --0x1p0, -0x1.fd9d22a46b416p-3, -0x1.51fa81cd99aa6p-1, --0x1.499f59d8560e9p-63, --0x1p0, -0x1.f9793312a14d1p-3, -0x1.50cc09f59a09bp-1, -0x1.693463a2c2e6fp-56, --0x1p0, -0x1.f558fb02ae805p-3, -0x1.4f9cc25cca486p-1, -0x1.48b5951cfc2b5p-55, --0x1p0, -0x1.f13c7d001a249p-3, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293edceb327p-57, --0x1p0, -0x1.ed23bb941f019p-3, -0x1.4d3bc6d589f7fp-1, -0x1.6e4d9d6b72011p-55, --0x1p0, -0x1.e90eb945a9ccfp-3, -0x1.4c0a145ec0004p-1, -0x1.2630cfafceaa1p-58, --0x1p0, -0x1.e4fd7899579acp-3, -0x1.4ad79516722f1p-1, --0x1.1273b163000f7p-55, --0x1p0, -0x1.e0effc1174505p-3, -0x1.49a449b9b0939p-1, --0x1.27ee16d719b94p-55, --0x1p0, -0x1.dce6462df917dp-3, -0x1.48703306091ffp-1, --0x1.70813b86159fdp-57, --0x1p0, -0x1.d8e0596c8ad56p-3, -0x1.473b51b987347p-1, -0x1.ca1953514e41bp-57, --0x1p0, -0x1.d4de3848789e2p-3, -0x1.4605a692b32a2p-1, -0x1.21ca219b97107p-55, --0x1p0, -0x1.d0dfe53aba2fdp-3, -0x1.44cf325091dd6p-1, -0x1.8076a2cfdc6b3p-57, --0x1p0, -0x1.cce562b9ee6aep-3, -0x1.4397f5b2a438p-1, --0x1.7274c9e48c226p-55, --0x1p0, -0x1.c8eeb33a59cdp-3, -0x1.425ff178e6bb1p-1, -0x1.7b38d675140cap-55, --0x1p0, -0x1.c4fbd92de4eddp-3, -0x1.41272663d108cp-1, -0x1.1bbe7636fadf5p-55, --0x1p0, -0x1.c10cd7041afccp-3, -0x1.3fed9534556d4p-1, -0x1.36916608c5061p-55, --0x1p0, -0x1.bd21af2a28408p-3, -0x1.3eb33eabe068p-1, -0x1.86a2357d1a0d3p-58, --0x1p0, -0x1.b93a640ad8978p-3, -0x1.3d78238c58344p-1, --0x1.0219f5f0f79cep-55, --0x1p0, -0x1.b556f80e95facp-3, -0x1.3c3c44981c518p-1, --0x1.b5e9a9644151bp-55, --0x1p0, -0x1.b1776d9b67013p-3, -0x1.3affa292050b9p-1, -0x1.e3e25e3954964p-56, --0x1p0, -0x1.ad9bc714ed64fp-3, -0x1.39c23e3d63029p-1, --0x1.3b05b276085c1p-58, --0x1p0, -0x1.a9c406dc648a5p-3, -0x1.3884185dfeb22p-1, --0x1.a038026abe6b2p-56, --0x1p0, -0x1.a5f02f50a007cp-3, -0x1.374531b817f8dp-1, -0x1.444d2b0a747fep-55, --0x1p0, -0x1.a22042ce0a2f9p-3, -0x1.36058b10659f3p-1, --0x1.1fcb3a35857e7p-55, --0x1p0, -0x1.9e5443aea29b2p-3, -0x1.34c5252c14de1p-1, -0x1.583f49632ab2bp-55, --0x1p0, -0x1.9a8c3449fcb77p-3, -0x1.338400d0c8e57p-1, --0x1.abf2a5e95e6e5p-55, --0x1p0, -0x1.96c816f53e539p-3, -0x1.32421ec49a61fp-1, -0x1.65e25cc951bfep-55, --0x1p0, -0x1.9307ee031e2fdp-3, -0x1.30ff7fce17035p-1, --0x1.efcc626f74a6fp-57, --0x1p0, -0x1.8f4bbbc3e28f6p-3, -0x1.2fbc24b441015p-1, -0x1.dba4875410874p-57, --0x1p0, -0x1.8b9382855fcaap-3, -0x1.2e780e3e8ea17p-1, --0x1.b19fafe36587ap-55, --0x1p0, -0x1.87df4492f6e38p-3, -0x1.2d333d34e9bb8p-1, --0x1.0e2c2c5549e26p-55, --0x1p0, -0x1.842f0435941afp-3, -0x1.2bedb25faf3eap-1, --0x1.14981c796ee46p-58, --0x1p0, -0x1.8082c3b3ad887p-3, -0x1.2aa76e87aeb58p-1, -0x1.fd600833287a7p-59, --0x1p0, -0x1.7cda855141b26p-3, -0x1.2960727629ca8p-1, -0x1.56d6c7af02d5cp-56, --0x1p0, -0x1.79364b4fd6288p-3, -0x1.2818bef4d3cbap-1, --0x1.e3fffeb76568ap-56, --0x1p0, -0x1.759617ee761f9p-3, -0x1.26d054cdd12dfp-1, --0x1.5da743ef3770cp-55, --0x1p0, -0x1.71f9ed69b10eap-3, -0x1.258734cbb711p-1, -0x1.3a3f0903ce09dp-57, --0x1p0, -0x1.6e61cdfb994dfp-3, -0x1.243d5fb98ac1fp-1, -0x1.c533d0a284a8dp-56, --0x1p0, -0x1.6acdbbdbc2b73p-3, -0x1.22f2d662c13e2p-1, --0x1.d5cc7580cb6d2p-55, --0x1p0, -0x1.673db93f41479p-3, -0x1.21a799933eb59p-1, --0x1.3a7b177c68fb2p-55, --0x1p0, -0x1.63b1c858a7c2ep-3, -0x1.205baa17560d6p-1, -0x1.b7b144016c7a3p-56, --0x1p0, -0x1.6029eb580658ep-3, -0x1.1f0f08bbc861bp-1, --0x1.10d9dcafb74cbp-57, --0x1p0, -0x1.5ca6246ae94b8p-3, -0x1.1dc1b64dc4872p-1, -0x1.f15e1c468be78p-57, --0x1p0, -0x1.592675bc57974p-3, -0x1.1c73b39ae68c8p-1, -0x1.b25dd267f66p-55, --0x1p0, -0x1.55aae174d19c8p-3, -0x1.1b250171373bfp-1, --0x1.b210e95e1ca4cp-55, --0x1p0, -0x1.523369ba4fcaep-3, -0x1.19d5a09f2b9b8p-1, --0x1.33656c68a1d4ap-57, --0x1p0, -0x1.4ec010b0414e1p-3, -0x1.188591f3a46e5p-1, --0x1.bbefe5a524346p-56, --0x1p0, -0x1.4b50d8778abbdp-3, -0x1.1734d63dedb49p-1, --0x1.7eef2ccc50575p-55, --0x1p0, -0x1.47e5c32e84c45p-3, -0x1.15e36e4dbe2bcp-1, -0x1.3c545f7d79eaep-56, --0x1p0, -0x1.447ed2f0fae31p-3, -0x1.14915af336cebp-1, -0x1.f3660558a0213p-56, --0x1p0, -0x1.411c09d82a128p-3, -0x1.133e9cfee254fp-1, --0x1.a1377cfd5ce5p-56, --0x1p0, -0x1.3dbd69fabf802p-3, -0x1.11eb3541b4b23p-1, --0x1.ef23b69abe4f1p-55, --0x1p0, -0x1.3a62f56cd742ep-3, -0x1.1097248d0a957p-1, --0x1.7a58759ba80ddp-55, --0x1p0, -0x1.370cae3ffb12fp-3, -0x1.0f426bb2a8e7ep-1, --0x1.bb58fb774f8eep-55, --0x1p0, -0x1.33ba968321032p-3, -0x1.0ded0b84bc4b6p-1, --0x1.8540fa327c55cp-55, --0x1p0, -0x1.306cb042aa3bap-3, -0x1.0c9704d5d898fp-1, --0x1.8d3d7de6ee9b2p-55, --0x1p0, -0x1.2d22fd8861b6bp-3, -0x1.0b405878f85ecp-1, --0x1.ad66c3bb80da5p-55, --0x1p0, -0x1.29dd805b7afecp-3, -0x1.09e907417c5e1p-1, --0x1.fe573741a9bd4p-55, --0x1p0, -0x1.269c3ac090ee4p-3, -0x1.089112032b08cp-1, -0x1.3248ddf9fe619p-57, --0x1p0, -0x1.235f2eb9a470ap-3, -0x1.073879922ffeep-1, --0x1.a5a014347406cp-55, --0x1p0, -0x1.20265e461b45ap-3, -0x1.05df3ec31b8b7p-1, --0x1.e2dcad34d9c1dp-57, --0x1p0, -0x1.1cf1cb62bec5dp-3, -0x1.0485626ae221ap-1, -0x1.b937d9091ff7p-55, --0x1p0, -0x1.19c17809baa87p-3, -0x1.032ae55edbd96p-1, --0x1.bdb022b40107ap-55, --0x1p0, -0x1.169566329bcb7p-3, -0x1.01cfc874c3eb7p-1, --0x1.34a35e7c2368cp-56, --0x1p0, -0x1.136d97d24efccp-3, -0x1.00740c82b82e1p-1, --0x1.6d48563c60e87p-55, --0x1p0, -0x1.104a0edb1fc58p-3, -0x1.fe2f64be7121p-2, --0x1.297ab1ca2d7dbp-56, --0x1p0, -0x1.0d2acd3cb7364p-3, -0x1.fb7575c24d2dep-2, --0x1.5bfdc883c8664p-57, --0x1p0, -0x1.0a0fd4e41ab5ap-3, -0x1.f8ba4dbf89abap-2, --0x1.2ec1fc1b776b8p-60, --0x1p0, -0x1.06f927bbaacfep-3, -0x1.f5fdee656cda3p-2, --0x1.7bf9780816b05p-58, --0x1p0, -0x1.03e6c7ab2208cp-3, -0x1.f3405963fd067p-2, -0x1.06846d44a238fp-56, --0x1p0, -0x1.00d8b69793ae4p-3, -0x1.f081906bff7fep-2, --0x1.4cab2d4ff6fccp-56, --0x1p0, -0x1.fb9decc6d55b8p-4, -0x1.edc1952ef78d6p-2, --0x1.dd0f7c33edee6p-56, --0x1p0, -0x1.f59311dcd0d44p-4, -0x1.eb00695f2562p-2, -0x1.53c9fd3083e22p-56, --0x1p0, -0x1.ef90e02b47283p-4, -0x1.e83e0eaf85114p-2, --0x1.7bc380ef24ba7p-57, --0x1p0, -0x1.e9975b670e077p-4, -0x1.e57a86d3cd825p-2, --0x1.2c80dcd511e87p-57, --0x1p0, -0x1.e3a6873fa1279p-4, -0x1.e2b5d3806f63bp-2, -0x1.e0d891d3c6841p-58, --0x1p0, -0x1.ddbe675f1ffdfp-4, -0x1.dfeff66a941dep-2, --0x1.a756c6e625f96p-56, --0x1p0, -0x1.d7deff6a4b7c9p-4, -0x1.dd28f1481cc58p-2, --0x1.e7576fa6c944ep-59, --0x1p0, -0x1.d208530083d3p-4, -0x1.da60c5cfa10d9p-2, --0x1.0f38e2143c8d5p-57, --0x1p0, -0x1.cc3a65bbc6327p-4, -0x1.d79775b86e389p-2, -0x1.550ec87bc0575p-56, --0x1p0, -0x1.c6753b30aa949p-4, -0x1.d4cd02ba8609dp-2, --0x1.37f33c63033d6p-57, --0x1p0, -0x1.c0b8d6ee61867p-4, -0x1.d2016e8e9db5bp-2, --0x1.c8bce9d93efb8p-57, --0x1p0, -0x1.bb053c7eb1f68p-4, -0x1.cf34baee1cd21p-2, --0x1.118724d19d014p-56, --0x1p0, -0x1.b55a6f65f7058p-4, -0x1.cc66e9931c45ep-2, -0x1.6850e59c37f8fp-58, --0x1p0, -0x1.afb873231ddb9p-4, -0x1.c997fc3865389p-2, --0x1.6295f8b0ca33bp-56, --0x1p0, -0x1.aa1f4b2fa37fcp-4, -0x1.c6c7f4997000bp-2, --0x1.bec2669c68e74p-56, --0x1p0, -0x1.a48efaff92b3bp-4, -0x1.c3f6d47263129p-2, -0x1.9c7bd0fcdecddp-56, --0x1p0, -0x1.9f07860181d1ep-4, -0x1.c1249d8011ee7p-2, --0x1.813aabb515206p-56, --0x1p0, -0x1.9988ef9e90b04p-4, -0x1.be51517ffc0d9p-2, -0x1.2b667131a5f16p-56, --0x1p0, -0x1.94133b3a66851p-4, -0x1.bb7cf2304bd01p-2, -0x1.9e1a5bd9269d4p-57, --0x1p0, -0x1.8ea66c332fd01p-4, -0x1.b8a7814fd5693p-2, -0x1.9a9e6651cc119p-56, --0x1p0, -0x1.894285e19c468p-4, -0x1.b5d1009e15ccp-2, -0x1.5b362cb974183p-57, --0x1p0, -0x1.83e78b98dcc2bp-4, -0x1.b2f971db31972p-2, -0x1.fa971a4a41f2p-56, --0x1p0, -0x1.7e9580a6a136ep-4, -0x1.b020d6c7f4009p-2, -0x1.414ae7e555208p-58, --0x1p0, -0x1.794c685316a3cp-4, -0x1.ad473125cdc09p-2, --0x1.379ede57649dap-58, --0x1p0, -0x1.740c45e0e512p-4, -0x1.aa6c82b6d3fcap-2, --0x1.d5f106ee5ccf7p-56, --0x1p0, -0x1.6ed51c8d2d8fcp-4, -0x1.a790cd3dbf31bp-2, --0x1.7f786986d9023p-57, --0x1p0, -0x1.69a6ef8f8830ap-4, -0x1.a4b4127dea1e5p-2, --0x1.bec6f01bc22f1p-56, --0x1p0, -0x1.6481c21a02123p-4, -0x1.a1d6543b50acp-2, --0x1.0246cfd8779fbp-57, --0x1p0, -0x1.5f6597591b633p-4, -0x1.9ef7943a8ed8ap-2, -0x1.6da81290bdbabp-57, --0x1p0, -0x1.5a527273c56e1p-4, -0x1.9c17d440df9f2p-2, -0x1.923c540a9eec4p-57, --0x1p0, -0x1.5548568b60a7bp-4, -0x1.993716141bdffp-2, --0x1.15e8cce261c55p-56, --0x1p0, -0x1.504746bbbac0bp-4, -0x1.96555b7ab948fp-2, -0x1.7afd51eff33adp-56, --0x1p0, -0x1.4b4f461b0cbaap-4, -0x1.9372a63bc93d7p-2, -0x1.684319e5ad5b1p-57, --0x1p0, -0x1.466057b9f900ap-4, -0x1.908ef81ef7bd1p-2, -0x1.4c00267012357p-56, --0x1p0, -0x1.417a7ea389835p-4, -0x1.8daa52ec8a4bp-2, --0x1.72eb2db8c621ep-57, --0x1p0, -0x1.3c9dbddd2dd84p-4, -0x1.8ac4b86d5ed44p-2, -0x1.17fa7f944ad5bp-56, --0x1p0, -0x1.37ca1866b95cfp-4, -0x1.87de2a6aea963p-2, --0x1.72cedd3d5a61p-57, --0x1p0, -0x1.32ff913a615dp-4, -0x1.84f6aaaf3903fp-2, -0x1.6dcdc2bd47067p-57, --0x1p0, -0x1.2e3e2b4cbb3c3p-4, -0x1.820e3b04eaac4p-2, --0x1.92379eb01c6b6p-59, --0x1p0, -0x1.2985e98cbaa3ap-4, -0x1.7f24dd37341e4p-2, -0x1.2791a1b5eb796p-57, --0x1p0, -0x1.24d6cee3afb2ap-4, -0x1.7c3a9311dcce7p-2, -0x1.9a3f21ef3e8d9p-62, --0x1p0, -0x1.2030de354532cp-4, -0x1.794f5e613dfaep-2, -0x1.820a4b0d21fc5p-57, --0x1p0, -0x1.1b941a5f7ecffp-4, -0x1.766340f2418f6p-2, -0x1.2b2adc9041b2cp-56, --0x1p0, -0x1.1700863ab7533p-4, -0x1.73763c9261092p-2, --0x1.52324face3b1ap-57, --0x1p0, -0x1.127624999ee1dp-4, -0x1.7088530fa459fp-2, --0x1.44b19e0864c5dp-56, --0x1p0, -0x1.0df4f849393f5p-4, -0x1.6d998638a0cb6p-2, --0x1.1ca14532860dfp-61, --0x1p0, -0x1.097d0410dc132p-4, -0x1.6aa9d7dc77e17p-2, --0x1.38b470592c7b3p-56, --0x1p0, -0x1.050e4ab22d321p-4, -0x1.67b949cad63cbp-2, --0x1.a23369348d7efp-56, --0x1p0, -0x1.00a8cee920eabp-4, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4a664121p-58, --0x1p0, -0x1.f89926d7f0ab8p-5, -0x1.61d595c88c202p-2, -0x1.f6b1e333415d7p-56, --0x1p0, -0x1.eff335d67f541p-5, -0x1.5ee27379ea693p-2, -0x1.634ff2fa75245p-56, --0x1p0, -0x1.e75fd0239926cp-5, -0x1.5bee78b9db3b6p-2, -0x1.e734a63158dfdp-58, --0x1p0, -0x1.dedefb09791b4p-5, -0x1.58f9a75ab1fddp-2, --0x1.efdc0d58cf62p-62, --0x1p0, -0x1.d670bbc6e685ep-5, -0x1.5604012f467b4p-2, -0x1.a0e0b2a5b25p-56, --0x1p0, -0x1.ce15178f31db3p-5, -0x1.530d880af3c24p-2, --0x1.fab8e2103fbd6p-56, --0x1p0, -0x1.c5cc138a317afp-5, -0x1.50163dc197048p-2, --0x1.ec66cb05c7ea4p-56, --0x1p0, -0x1.bd95b4d43e819p-5, -0x1.4d1e24278e76ap-2, -0x1.2417218792858p-57, --0x1p0, -0x1.b572007e31a1bp-5, -0x1.4a253d11b82f3p-2, --0x1.2afa4d6d42a55p-58, --0x1p0, -0x1.ad60fb8d6003ap-5, -0x1.472b8a5571054p-2, --0x1.01ea0fe4dff23p-56, --0x1p0, -0x1.a562aafb982cdp-5, -0x1.44310dc8936fp-2, -0x1.8b694e91d3125p-56, --0x1p0, -0x1.9d7713b71eee1p-5, -0x1.4135c94176601p-2, -0x1.0c97c4afa2518p-56, --0x1p0, -0x1.959e3aa2ac58dp-5, -0x1.3e39be96ec271p-2, -0x1.814c6de9aaaf6p-56, --0x1p0, -0x1.8dd8249568bbbp-5, -0x1.3b3cefa0414b7p-2, -0x1.f36dc4a9c2294p-56, --0x1p0, -0x1.8624d65ae9a63p-5, -0x1.383f5e353b6abp-2, --0x1.a812a4a5c3d44p-56, --0x1p0, -0x1.7e8454b32ef34p-5, -0x1.35410c2e18152p-2, --0x1.3cb002f96e062p-56, --0x1p0, -0x1.76f6a4529fdb5p-5, -0x1.3241fb638baafp-2, -0x1.ecee8f76f8c51p-60, --0x1p0, -0x1.6f7bc9e2080d9p-5, -0x1.2f422daec0387p-2, --0x1.7501ba473da6fp-56, --0x1p0, -0x1.6813c9fe94cfbp-5, -0x1.2c41a4e95452p-2, -0x1.9cf0354aad2dcp-56, --0x1p0, -0x1.60bea939d225ap-5, -0x1.294062ed59f06p-2, --0x1.5d28da2c4612dp-56, --0x1p0, -0x1.597c6c19a8003p-5, -0x1.263e6995554bap-2, -0x1.1d350ffc5ff32p-56, --0x1p0, -0x1.524d171857726p-5, -0x1.233bbabc3bb71p-2, -0x1.99b04e23259efp-56, --0x1p0, -0x1.4b30aea477eeep-5, -0x1.2038583d727bep-2, --0x1.c69cd46300a3p-57, --0x1p0, -0x1.44273720f48bcp-5, -0x1.1d3443f4cdb3ep-2, --0x1.720d41c13519ep-57, --0x1p0, -0x1.3d30b4e5094ep-5, -0x1.1a2f7fbe8f243p-2, -0x1.6465ac86ba7b2p-56, --0x1p0, -0x1.364d2c3c407bep-5, -0x1.172a0d7765177p-2, -0x1.22575f33366bep-57, --0x1p0, -0x1.2f7ca1666ff6fp-5, -0x1.1423eefc69378p-2, -0x1.22d3368ec9b62p-56, --0x1p0, -0x1.28bf1897b69ccp-5, -0x1.111d262b1f677p-2, -0x1.824c20ab7aa9ap-56, --0x1p0, -0x1.221495f879af5p-5, -0x1.0e15b4e1749cep-2, --0x1.5b7fb156c550ap-56, --0x1p0, -0x1.1b7d1da562443p-5, -0x1.0b0d9cfdbdb9p-2, -0x1.3b3a7b8d1200dp-58, --0x1p0, -0x1.14f8b3af5abb9p-5, -0x1.0804e05eb661ep-2, -0x1.54e583d92d3d8p-56, --0x1p0, -0x1.0e875c1b8c3dap-5, -0x1.04fb80e37fdaep-2, --0x1.412cdb72583ccp-63, --0x1p0, -0x1.08291ae35c407p-5, -0x1.01f1806b9fdd2p-2, --0x1.448135394b8bap-56, --0x1p0, -0x1.01ddf3f46a139p-5, -0x1.fdcdc1adfedf9p-3, --0x1.2dba4580ed7bbp-57, --0x1p0, -0x1.f74bd66118e8dp-6, -0x1.f7b7480bd3802p-3, --0x1.9a96d967ee12ep-57, --0x1p0, -0x1.eb0208db9e51bp-6, -0x1.f19f97b215f1bp-3, --0x1.42deef11da2c4p-57, --0x1p0, -0x1.dede86ece142ep-6, -0x1.eb86b462de348p-3, --0x1.bfcde46f90b62p-57, --0x1p0, -0x1.d2e15811bf462p-6, -0x1.e56ca1e101a1bp-3, -0x1.46ac3f9fd0227p-57, --0x1p0, -0x1.c70a83af71ef5p-6, -0x1.df5163f01099ap-3, --0x1.01f7d79906e86p-57, --0x1p0, -0x1.bb5a11138a4c9p-6, -0x1.d934fe5454311p-3, -0x1.75b92277107adp-57, --0x1p0, -0x1.afd00773ec64fp-6, -0x1.d31774d2cbdeep-3, -0x1.2fdc8e5791a0bp-57, --0x1p0, -0x1.a46c6deecac5fp-6, -0x1.ccf8cb312b286p-3, -0x1.2382b0aecadf8p-58, --0x1p0, -0x1.992f4b8aa21f8p-6, -0x1.c6d90535d74ddp-3, --0x1.bfb2be2264962p-59, --0x1p0, -0x1.8e18a73634ee7p-6, -0x1.c0b826a7e4f63p-3, --0x1.af1439e521935p-62, --0x1p0, -0x1.832887c88735dp-6, -0x1.ba96334f15dadp-3, --0x1.75098c05dd18ap-57, --0x1p0, -0x1.785ef400da46cp-6, -0x1.b4732ef3d6722p-3, -0x1.bbe5d5d75cbd8p-57, --0x1p0, -0x1.6dbbf286a8971p-6, -0x1.ae4f1d5f3b9abp-3, -0x1.aa8bbcef9b68ep-57, --0x1p0, -0x1.633f89e9a1a66p-6, -0x1.a82a025b00451p-3, --0x1.87905ffd084adp-57, --0x1p0, -0x1.58e9c0a1a5f21p-6, -0x1.a203e1b1831dap-3, -0x1.c1aadb580a1ecp-58, --0x1p0, -0x1.4eba9d0ec2f7cp-6, -0x1.9bdcbf2dc4366p-3, -0x1.9632d189956fep-57, --0x1p0, -0x1.44b225792f46bp-6, -0x1.95b49e9b62afap-3, --0x1.100b3d1dbfeaap-59, --0x1p0, -0x1.3ad06011469fbp-6, -0x1.8f8b83c69a60bp-3, --0x1.26d19b9ff8d82p-57, --0x1p0, -0x1.311552ef8623cp-6, -0x1.8961727c41804p-3, -0x1.3fdab4e42640ap-58, --0x1p0, -0x1.278104148891ap-6, -0x1.83366e89c64c6p-3, --0x1.192952df10db8p-57, --0x1p0, -0x1.1e1379690291cp-6, -0x1.7d0a7bbd2cb1cp-3, --0x1.cf900f27c58efp-57, --0x1p0, -0x1.14ccb8bdbf114p-6, -0x1.76dd9de50bf31p-3, -0x1.1d5eeec501b2fp-57, --0x1p0, -0x1.0bacc7cb9babap-6, -0x1.70afd8d08c4ffp-3, -0x1.260c3f1369484p-57, --0x1p0, -0x1.02b3ac3385232p-6, -0x1.6a81304f64ab2p-3, -0x1.f0cd73fb5d8d4p-58, --0x1p0, -0x1.f3c2d6fce7cfap-7, -0x1.6451a831d830dp-3, -0x1.ad16031a34d5p-58, --0x1p0, -0x1.e26c163ad15b3p-7, -0x1.5e214448b3fc6p-3, -0x1.531ff779ddac6p-57, --0x1p0, -0x1.d16320d2d221ep-7, -0x1.57f008654cbdep-3, -0x1.908c95c4c9118p-58, --0x1p0, -0x1.c0a80146f894cp-7, -0x1.51bdf8597c5f2p-3, --0x1.9f9976af04aa5p-61, --0x1p0, -0x1.b03ac1e94fe1dp-7, -0x1.4b8b17f79fa88p-3, -0x1.b534fe588f0dp-57, --0x1p0, -0x1.a01b6cdbd995ep-7, -0x1.45576b1293e5ap-3, --0x1.285a24119f7b1p-58, --0x1p0, -0x1.904a0c10875cep-7, -0x1.3f22f57db4893p-3, -0x1.bfe7ff2274956p-59, --0x1p0, -0x1.80c6a94934dfp-7, -0x1.38edbb0cd8d14p-3, --0x1.198c21fbf7718p-57, --0x1p0, -0x1.71914e17a1bc6p-7, -0x1.32b7bf94516a7p-3, -0x1.2a24e2431ef29p-57, --0x1p0, -0x1.62aa03dd6ba58p-7, -0x1.2c8106e8e613ap-3, -0x1.13000a89a11ep-58, --0x1p0, -0x1.5410d3cc0891ep-7, -0x1.264994dfd3409p-3, -0x1.a744ce26f39cp-57, --0x1p0, -0x1.45c5c6e4c114ap-7, -0x1.20116d4ec7bcfp-3, --0x1.242c8e1053452p-57, --0x1p0, -0x1.37c8e5f8aacep-7, -0x1.19d8940be24e7p-3, -0x1.e8dcdca90cc74p-58, --0x1p0, -0x1.2a1a39a8a2fb7p-7, -0x1.139f0cedaf577p-3, --0x1.523434d1b3cfap-57, --0x1p0, -0x1.1cb9ca654924fp-7, -0x1.0d64dbcb26786p-3, --0x1.713a562132055p-58, --0x1p0, -0x1.0fa7a06ef9e81p-7, -0x1.072a047ba831dp-3, -0x1.19db1f70118cap-58, --0x1p0, -0x1.02e3c3d5c9e17p-7, -0x1.00ee8ad6fb85bp-3, -0x1.673eac8308f11p-58, --0x1p0, -0x1.ecdc78f30165cp-8, -0x1.f564e56a9730ep-4, -0x1.a2704729ae56dp-59, --0x1p0, -0x1.d48e24132851p-8, -0x1.e8eb7fde4aa3fp-4, --0x1.23758f2d5bb8bp-58, --0x1p0, -0x1.bcdc980a46f5ap-8, -0x1.dc70ecbae9fc9p-4, -0x1.2fda2d73295eep-60, --0x1p0, -0x1.a5c7e375e55dep-8, -0x1.cff533b307dc1p-4, -0x1.8feeb8f9c3334p-59, --0x1p0, -0x1.8f501492cc296p-8, -0x1.c3785c79ec2d5p-4, --0x1.4f39df133fb21p-61, --0x1p0, -0x1.7975393cfbc4dp-8, -0x1.b6fa6ec38f64cp-4, -0x1.db5d943691f09p-58, --0x1p0, -0x1.64375eefa3dd6p-8, -0x1.aa7b724495c03p-4, -0x1.e5399ba0967b8p-58, --0x1p0, -0x1.4f9692c51b0fbp-8, -0x1.9dfb6eb24a85cp-4, -0x1.e96b47b8c44e6p-59, --0x1p0, -0x1.3b92e176d6d31p-8, -0x1.917a6bc29b42cp-4, --0x1.e2718d26ed688p-60, --0x1p0, -0x1.282c575d639fcp-8, -0x1.84f8712c130a1p-4, --0x1.e626ebafe374ep-58, --0x1p0, -0x1.156300705d51bp-8, -0x1.787586a5d5b21p-4, -0x1.5f7589f083399p-58, --0x1p0, -0x1.0336e84667c66p-8, -0x1.6bf1b3e79b129p-4, --0x1.14b6da08765p-58, --0x1p0, -0x1.e350342a4f6e6p-9, -0x1.5f6d00a9aa419p-4, --0x1.f4022d03f6c9ap-59, --0x1p0, -0x1.c16d4162779e5p-9, -0x1.52e774a4d4d0ap-4, -0x1.b2edf18c730cbp-60, --0x1p0, -0x1.a0c50d1c6bf93p-9, -0x1.4661179272096p-4, --0x1.4b109f2406c4cp-58, --0x1p0, -0x1.8157ab7d29fd9p-9, -0x1.39d9f12c5a299p-4, -0x1.1287ff27ae554p-62, --0x1p0, -0x1.63252fe77c5ebp-9, -0x1.2d52092ce19f6p-4, --0x1.9a088a8bf6b2cp-59, --0x1p0, -0x1.462dacfbef0f3p-9, -0x1.20c9674ed444dp-4, --0x1.f9d48faba7974p-58, --0x1p0, -0x1.2a713498c3c3dp-9, -0x1.1440134d709b3p-4, --0x1.fec446daea6adp-58, --0x1p0, -0x1.0fefd7d9e6ed8p-9, -0x1.07b614e463064p-4, --0x1.384f8c3ee7605p-58, --0x1p0, -0x1.ed534e31ca57fp-10, -0x1.f656e79f820ep-5, --0x1.2e1ebe392bffep-61, --0x1p0, -0x1.bd3d63d9c26efp-10, -0x1.dd406f9808ec9p-5, -0x1.1313a4b4068bdp-62, --0x1p0, -0x1.8f9e0e5514865p-10, -0x1.c428d12c0d7e3p-5, --0x1.89bc74b58c513p-60, --0x1p0, -0x1.647569c825ae1p-10, -0x1.ab101bd5f8317p-5, --0x1.65c6175c6dc68p-59, --0x1p0, -0x1.3bc390d250439p-10, -0x1.91f65f10dd814p-5, --0x1.912bd0d569a9p-61, --0x1p0, -0x1.15889c8dd385fp-10, -0x1.78dbaa5874686p-5, --0x1.4a0ef4035c29cp-60, --0x1p0, -0x1.e389491f8833ap-11, -0x1.5fc00d290cd43p-5, -0x1.a2669a693a8e1p-59, --0x1p0, -0x1.a0ef7dcffafabp-11, -0x1.46a396ff86179p-5, -0x1.136ac00fa2da9p-61, --0x1p0, -0x1.6344004228d8bp-11, -0x1.2d865759455cdp-5, -0x1.686f65ba93acp-61, --0x1p0, -0x1.2a86f68094692p-11, -0x1.14685db42c17fp-5, --0x1.2890d277cb974p-59, --0x1p0, -0x1.ed71071603e86p-12, -0x1.f693731d1cf01p-6, --0x1.3fe9bc66286c7p-66, --0x1p0, -0x1.8fb18eacc3af8p-12, -0x1.c454f4ce53b1dp-6, --0x1.d63d7fef0e36cp-60, --0x1p0, -0x1.3bcfbd9979a27p-12, -0x1.92155f7a3667ep-6, --0x1.b1d63091a013p-64, --0x1p0, -0x1.e3978f34889d9p-13, -0x1.5fd4d21fab226p-6, --0x1.0c0a91c37851cp-61, --0x1p0, -0x1.634bb4ae5ed49p-13, -0x1.2d936bbe30efdp-6, -0x1.b5f91ee371d64p-61, --0x1p0, -0x1.ed7875885ea3ap-14, -0x1.f6a296ab997cbp-7, --0x1.f2943d8fe7033p-61, --0x1p0, -0x1.3bd2c8da49511p-14, -0x1.921d1fcdec784p-7, -0x1.9878ebe836d9dp-61, --0x1p0, -0x1.634da1cec522dp-15, -0x1.2d96b0e509703p-7, --0x1.1e9131ff52dc9p-63, --0x1p0, -0x1.3bd38bab6d94cp-16, -0x1.921f0fe670071p-8, -0x1.ab967fe6b7a9bp-64, --0x1p0, -0x1.3bd3bc5fc5ab4p-18, -0x1.921f8becca4bap-9, -0x1.2ba407bcab5b2p-63, --0x1p0, -0, -0, -0, --0x1p0, -0x1.3bd3bc5fc5ab4p-18, --0x1.921f8becca4bap-9, --0x1.2ba407bcab5b2p-63, --0x1p0, -0x1.3bd38bab6d94cp-16, --0x1.921f0fe670071p-8, --0x1.ab967fe6b7a9bp-64, --0x1p0, -0x1.634da1cec522dp-15, --0x1.2d96b0e509703p-7, -0x1.1e9131ff52dc9p-63, --0x1p0, -0x1.3bd2c8da49511p-14, --0x1.921d1fcdec784p-7, --0x1.9878ebe836d9dp-61, --0x1p0, -0x1.ed7875885ea3ap-14, --0x1.f6a296ab997cbp-7, -0x1.f2943d8fe7033p-61, --0x1p0, -0x1.634bb4ae5ed49p-13, --0x1.2d936bbe30efdp-6, --0x1.b5f91ee371d64p-61, --0x1p0, -0x1.e3978f34889d9p-13, --0x1.5fd4d21fab226p-6, -0x1.0c0a91c37851cp-61, --0x1p0, -0x1.3bcfbd9979a27p-12, --0x1.92155f7a3667ep-6, -0x1.b1d63091a013p-64, --0x1p0, -0x1.8fb18eacc3af8p-12, --0x1.c454f4ce53b1dp-6, -0x1.d63d7fef0e36cp-60, --0x1p0, -0x1.ed71071603e86p-12, --0x1.f693731d1cf01p-6, -0x1.3fe9bc66286c7p-66, --0x1p0, -0x1.2a86f68094692p-11, --0x1.14685db42c17fp-5, -0x1.2890d277cb974p-59, --0x1p0, -0x1.6344004228d8bp-11, --0x1.2d865759455cdp-5, --0x1.686f65ba93acp-61, --0x1p0, -0x1.a0ef7dcffafabp-11, --0x1.46a396ff86179p-5, --0x1.136ac00fa2da9p-61, --0x1p0, -0x1.e389491f8833ap-11, --0x1.5fc00d290cd43p-5, --0x1.a2669a693a8e1p-59, --0x1p0, -0x1.15889c8dd385fp-10, --0x1.78dbaa5874686p-5, -0x1.4a0ef4035c29cp-60, --0x1p0, -0x1.3bc390d250439p-10, --0x1.91f65f10dd814p-5, -0x1.912bd0d569a9p-61, --0x1p0, -0x1.647569c825ae1p-10, --0x1.ab101bd5f8317p-5, -0x1.65c6175c6dc68p-59, --0x1p0, -0x1.8f9e0e5514865p-10, --0x1.c428d12c0d7e3p-5, -0x1.89bc74b58c513p-60, --0x1p0, -0x1.bd3d63d9c26efp-10, --0x1.dd406f9808ec9p-5, --0x1.1313a4b4068bdp-62, --0x1p0, -0x1.ed534e31ca57fp-10, --0x1.f656e79f820ep-5, -0x1.2e1ebe392bffep-61, --0x1p0, -0x1.0fefd7d9e6ed8p-9, --0x1.07b614e463064p-4, -0x1.384f8c3ee7605p-58, --0x1p0, -0x1.2a713498c3c3dp-9, --0x1.1440134d709b3p-4, -0x1.fec446daea6adp-58, --0x1p0, -0x1.462dacfbef0f3p-9, --0x1.20c9674ed444dp-4, -0x1.f9d48faba7974p-58, --0x1p0, -0x1.63252fe77c5ebp-9, --0x1.2d52092ce19f6p-4, -0x1.9a088a8bf6b2cp-59, --0x1p0, -0x1.8157ab7d29fd9p-9, --0x1.39d9f12c5a299p-4, --0x1.1287ff27ae554p-62, --0x1p0, -0x1.a0c50d1c6bf93p-9, --0x1.4661179272096p-4, -0x1.4b109f2406c4cp-58, --0x1p0, -0x1.c16d4162779e5p-9, --0x1.52e774a4d4d0ap-4, --0x1.b2edf18c730cbp-60, --0x1p0, -0x1.e350342a4f6e6p-9, --0x1.5f6d00a9aa419p-4, -0x1.f4022d03f6c9ap-59, --0x1p0, -0x1.0336e84667c66p-8, --0x1.6bf1b3e79b129p-4, -0x1.14b6da08765p-58, --0x1p0, -0x1.156300705d51bp-8, --0x1.787586a5d5b21p-4, --0x1.5f7589f083399p-58, --0x1p0, -0x1.282c575d639fcp-8, --0x1.84f8712c130a1p-4, -0x1.e626ebafe374ep-58, --0x1p0, -0x1.3b92e176d6d31p-8, --0x1.917a6bc29b42cp-4, -0x1.e2718d26ed688p-60, --0x1p0, -0x1.4f9692c51b0fbp-8, --0x1.9dfb6eb24a85cp-4, --0x1.e96b47b8c44e6p-59, --0x1p0, -0x1.64375eefa3dd6p-8, --0x1.aa7b724495c03p-4, --0x1.e5399ba0967b8p-58, --0x1p0, -0x1.7975393cfbc4dp-8, --0x1.b6fa6ec38f64cp-4, --0x1.db5d943691f09p-58, --0x1p0, -0x1.8f501492cc296p-8, --0x1.c3785c79ec2d5p-4, -0x1.4f39df133fb21p-61, --0x1p0, -0x1.a5c7e375e55dep-8, --0x1.cff533b307dc1p-4, --0x1.8feeb8f9c3334p-59, --0x1p0, -0x1.bcdc980a46f5ap-8, --0x1.dc70ecbae9fc9p-4, --0x1.2fda2d73295eep-60, --0x1p0, -0x1.d48e24132851p-8, --0x1.e8eb7fde4aa3fp-4, -0x1.23758f2d5bb8bp-58, --0x1p0, -0x1.ecdc78f30165cp-8, --0x1.f564e56a9730ep-4, --0x1.a2704729ae56dp-59, --0x1p0, -0x1.02e3c3d5c9e17p-7, --0x1.00ee8ad6fb85bp-3, --0x1.673eac8308f11p-58, --0x1p0, -0x1.0fa7a06ef9e81p-7, --0x1.072a047ba831dp-3, --0x1.19db1f70118cap-58, --0x1p0, -0x1.1cb9ca654924fp-7, --0x1.0d64dbcb26786p-3, -0x1.713a562132055p-58, --0x1p0, -0x1.2a1a39a8a2fb7p-7, --0x1.139f0cedaf577p-3, -0x1.523434d1b3cfap-57, --0x1p0, -0x1.37c8e5f8aacep-7, --0x1.19d8940be24e7p-3, --0x1.e8dcdca90cc74p-58, --0x1p0, -0x1.45c5c6e4c114ap-7, --0x1.20116d4ec7bcfp-3, -0x1.242c8e1053452p-57, --0x1p0, -0x1.5410d3cc0891ep-7, --0x1.264994dfd3409p-3, --0x1.a744ce26f39cp-57, --0x1p0, -0x1.62aa03dd6ba58p-7, --0x1.2c8106e8e613ap-3, --0x1.13000a89a11ep-58, --0x1p0, -0x1.71914e17a1bc6p-7, --0x1.32b7bf94516a7p-3, --0x1.2a24e2431ef29p-57, --0x1p0, -0x1.80c6a94934dfp-7, --0x1.38edbb0cd8d14p-3, -0x1.198c21fbf7718p-57, --0x1p0, -0x1.904a0c10875cep-7, --0x1.3f22f57db4893p-3, --0x1.bfe7ff2274956p-59, --0x1p0, -0x1.a01b6cdbd995ep-7, --0x1.45576b1293e5ap-3, -0x1.285a24119f7b1p-58, --0x1p0, -0x1.b03ac1e94fe1dp-7, --0x1.4b8b17f79fa88p-3, --0x1.b534fe588f0dp-57, --0x1p0, -0x1.c0a80146f894cp-7, --0x1.51bdf8597c5f2p-3, -0x1.9f9976af04aa5p-61, --0x1p0, -0x1.d16320d2d221ep-7, --0x1.57f008654cbdep-3, --0x1.908c95c4c9118p-58, --0x1p0, -0x1.e26c163ad15b3p-7, --0x1.5e214448b3fc6p-3, --0x1.531ff779ddac6p-57, --0x1p0, -0x1.f3c2d6fce7cfap-7, --0x1.6451a831d830dp-3, --0x1.ad16031a34d5p-58, --0x1p0, -0x1.02b3ac3385232p-6, --0x1.6a81304f64ab2p-3, --0x1.f0cd73fb5d8d4p-58, --0x1p0, -0x1.0bacc7cb9babap-6, --0x1.70afd8d08c4ffp-3, --0x1.260c3f1369484p-57, --0x1p0, -0x1.14ccb8bdbf114p-6, --0x1.76dd9de50bf31p-3, --0x1.1d5eeec501b2fp-57, --0x1p0, -0x1.1e1379690291cp-6, --0x1.7d0a7bbd2cb1cp-3, -0x1.cf900f27c58efp-57, --0x1p0, -0x1.278104148891ap-6, --0x1.83366e89c64c6p-3, -0x1.192952df10db8p-57, --0x1p0, -0x1.311552ef8623cp-6, --0x1.8961727c41804p-3, --0x1.3fdab4e42640ap-58, --0x1p0, -0x1.3ad06011469fbp-6, --0x1.8f8b83c69a60bp-3, -0x1.26d19b9ff8d82p-57, --0x1p0, -0x1.44b225792f46bp-6, --0x1.95b49e9b62afap-3, -0x1.100b3d1dbfeaap-59, --0x1p0, -0x1.4eba9d0ec2f7cp-6, --0x1.9bdcbf2dc4366p-3, --0x1.9632d189956fep-57, --0x1p0, -0x1.58e9c0a1a5f21p-6, --0x1.a203e1b1831dap-3, --0x1.c1aadb580a1ecp-58, --0x1p0, -0x1.633f89e9a1a66p-6, --0x1.a82a025b00451p-3, -0x1.87905ffd084adp-57, --0x1p0, -0x1.6dbbf286a8971p-6, --0x1.ae4f1d5f3b9abp-3, --0x1.aa8bbcef9b68ep-57, --0x1p0, -0x1.785ef400da46cp-6, --0x1.b4732ef3d6722p-3, --0x1.bbe5d5d75cbd8p-57, --0x1p0, -0x1.832887c88735dp-6, --0x1.ba96334f15dadp-3, -0x1.75098c05dd18ap-57, --0x1p0, -0x1.8e18a73634ee7p-6, --0x1.c0b826a7e4f63p-3, -0x1.af1439e521935p-62, --0x1p0, -0x1.992f4b8aa21f8p-6, --0x1.c6d90535d74ddp-3, -0x1.bfb2be2264962p-59, --0x1p0, -0x1.a46c6deecac5fp-6, --0x1.ccf8cb312b286p-3, --0x1.2382b0aecadf8p-58, --0x1p0, -0x1.afd00773ec64fp-6, --0x1.d31774d2cbdeep-3, --0x1.2fdc8e5791a0bp-57, --0x1p0, -0x1.bb5a11138a4c9p-6, --0x1.d934fe5454311p-3, --0x1.75b92277107adp-57, --0x1p0, -0x1.c70a83af71ef5p-6, --0x1.df5163f01099ap-3, -0x1.01f7d79906e86p-57, --0x1p0, -0x1.d2e15811bf462p-6, --0x1.e56ca1e101a1bp-3, --0x1.46ac3f9fd0227p-57, --0x1p0, -0x1.dede86ece142ep-6, --0x1.eb86b462de348p-3, -0x1.bfcde46f90b62p-57, --0x1p0, -0x1.eb0208db9e51bp-6, --0x1.f19f97b215f1bp-3, -0x1.42deef11da2c4p-57, --0x1p0, -0x1.f74bd66118e8dp-6, --0x1.f7b7480bd3802p-3, -0x1.9a96d967ee12ep-57, --0x1p0, -0x1.01ddf3f46a139p-5, --0x1.fdcdc1adfedf9p-3, -0x1.2dba4580ed7bbp-57, --0x1p0, -0x1.08291ae35c407p-5, --0x1.01f1806b9fdd2p-2, -0x1.448135394b8bap-56, --0x1p0, -0x1.0e875c1b8c3dap-5, --0x1.04fb80e37fdaep-2, -0x1.412cdb72583ccp-63, --0x1p0, -0x1.14f8b3af5abb9p-5, --0x1.0804e05eb661ep-2, --0x1.54e583d92d3d8p-56, --0x1p0, -0x1.1b7d1da562443p-5, --0x1.0b0d9cfdbdb9p-2, --0x1.3b3a7b8d1200dp-58, --0x1p0, -0x1.221495f879af5p-5, --0x1.0e15b4e1749cep-2, -0x1.5b7fb156c550ap-56, --0x1p0, -0x1.28bf1897b69ccp-5, --0x1.111d262b1f677p-2, --0x1.824c20ab7aa9ap-56, --0x1p0, -0x1.2f7ca1666ff6fp-5, --0x1.1423eefc69378p-2, --0x1.22d3368ec9b62p-56, --0x1p0, -0x1.364d2c3c407bep-5, --0x1.172a0d7765177p-2, --0x1.22575f33366bep-57, --0x1p0, -0x1.3d30b4e5094ep-5, --0x1.1a2f7fbe8f243p-2, --0x1.6465ac86ba7b2p-56, --0x1p0, -0x1.44273720f48bcp-5, --0x1.1d3443f4cdb3ep-2, -0x1.720d41c13519ep-57, --0x1p0, -0x1.4b30aea477eeep-5, --0x1.2038583d727bep-2, -0x1.c69cd46300a3p-57, --0x1p0, -0x1.524d171857726p-5, --0x1.233bbabc3bb71p-2, --0x1.99b04e23259efp-56, --0x1p0, -0x1.597c6c19a8003p-5, --0x1.263e6995554bap-2, --0x1.1d350ffc5ff32p-56, --0x1p0, -0x1.60bea939d225ap-5, --0x1.294062ed59f06p-2, -0x1.5d28da2c4612dp-56, --0x1p0, -0x1.6813c9fe94cfbp-5, --0x1.2c41a4e95452p-2, --0x1.9cf0354aad2dcp-56, --0x1p0, -0x1.6f7bc9e2080d9p-5, --0x1.2f422daec0387p-2, -0x1.7501ba473da6fp-56, --0x1p0, -0x1.76f6a4529fdb5p-5, --0x1.3241fb638baafp-2, --0x1.ecee8f76f8c51p-60, --0x1p0, -0x1.7e8454b32ef34p-5, --0x1.35410c2e18152p-2, -0x1.3cb002f96e062p-56, --0x1p0, -0x1.8624d65ae9a63p-5, --0x1.383f5e353b6abp-2, -0x1.a812a4a5c3d44p-56, --0x1p0, -0x1.8dd8249568bbbp-5, --0x1.3b3cefa0414b7p-2, --0x1.f36dc4a9c2294p-56, --0x1p0, -0x1.959e3aa2ac58dp-5, --0x1.3e39be96ec271p-2, --0x1.814c6de9aaaf6p-56, --0x1p0, -0x1.9d7713b71eee1p-5, --0x1.4135c94176601p-2, --0x1.0c97c4afa2518p-56, --0x1p0, -0x1.a562aafb982cdp-5, --0x1.44310dc8936fp-2, --0x1.8b694e91d3125p-56, --0x1p0, -0x1.ad60fb8d6003ap-5, --0x1.472b8a5571054p-2, -0x1.01ea0fe4dff23p-56, --0x1p0, -0x1.b572007e31a1bp-5, --0x1.4a253d11b82f3p-2, -0x1.2afa4d6d42a55p-58, --0x1p0, -0x1.bd95b4d43e819p-5, --0x1.4d1e24278e76ap-2, --0x1.2417218792858p-57, --0x1p0, -0x1.c5cc138a317afp-5, --0x1.50163dc197048p-2, -0x1.ec66cb05c7ea4p-56, --0x1p0, -0x1.ce15178f31db3p-5, --0x1.530d880af3c24p-2, -0x1.fab8e2103fbd6p-56, --0x1p0, -0x1.d670bbc6e685ep-5, --0x1.5604012f467b4p-2, --0x1.a0e0b2a5b25p-56, --0x1p0, -0x1.dedefb09791b4p-5, --0x1.58f9a75ab1fddp-2, -0x1.efdc0d58cf62p-62, --0x1p0, -0x1.e75fd0239926cp-5, --0x1.5bee78b9db3b6p-2, --0x1.e734a63158dfdp-58, --0x1p0, -0x1.eff335d67f541p-5, --0x1.5ee27379ea693p-2, --0x1.634ff2fa75245p-56, --0x1p0, -0x1.f89926d7f0ab8p-5, --0x1.61d595c88c202p-2, --0x1.f6b1e333415d7p-56, --0x1p0, -0x1.00a8cee920eabp-4, --0x1.64c7ddd3f27c6p-2, --0x1.10d2b4a664121p-58, --0x1p0, -0x1.050e4ab22d321p-4, --0x1.67b949cad63cbp-2, -0x1.a23369348d7efp-56, --0x1p0, -0x1.097d0410dc132p-4, --0x1.6aa9d7dc77e17p-2, -0x1.38b470592c7b3p-56, --0x1p0, -0x1.0df4f849393f5p-4, --0x1.6d998638a0cb6p-2, -0x1.1ca14532860dfp-61, --0x1p0, -0x1.127624999ee1dp-4, --0x1.7088530fa459fp-2, -0x1.44b19e0864c5dp-56, --0x1p0, -0x1.1700863ab7533p-4, --0x1.73763c9261092p-2, -0x1.52324face3b1ap-57, --0x1p0, -0x1.1b941a5f7ecffp-4, --0x1.766340f2418f6p-2, --0x1.2b2adc9041b2cp-56, --0x1p0, -0x1.2030de354532cp-4, --0x1.794f5e613dfaep-2, --0x1.820a4b0d21fc5p-57, --0x1p0, -0x1.24d6cee3afb2ap-4, --0x1.7c3a9311dcce7p-2, --0x1.9a3f21ef3e8d9p-62, --0x1p0, -0x1.2985e98cbaa3ap-4, --0x1.7f24dd37341e4p-2, --0x1.2791a1b5eb796p-57, --0x1p0, -0x1.2e3e2b4cbb3c3p-4, --0x1.820e3b04eaac4p-2, -0x1.92379eb01c6b6p-59, --0x1p0, -0x1.32ff913a615dp-4, --0x1.84f6aaaf3903fp-2, --0x1.6dcdc2bd47067p-57, --0x1p0, -0x1.37ca1866b95cfp-4, --0x1.87de2a6aea963p-2, -0x1.72cedd3d5a61p-57, --0x1p0, -0x1.3c9dbddd2dd84p-4, --0x1.8ac4b86d5ed44p-2, --0x1.17fa7f944ad5bp-56, --0x1p0, -0x1.417a7ea389835p-4, --0x1.8daa52ec8a4bp-2, -0x1.72eb2db8c621ep-57, --0x1p0, -0x1.466057b9f900ap-4, --0x1.908ef81ef7bd1p-2, --0x1.4c00267012357p-56, --0x1p0, -0x1.4b4f461b0cbaap-4, --0x1.9372a63bc93d7p-2, --0x1.684319e5ad5b1p-57, --0x1p0, -0x1.504746bbbac0bp-4, --0x1.96555b7ab948fp-2, --0x1.7afd51eff33adp-56, --0x1p0, -0x1.5548568b60a7bp-4, --0x1.993716141bdffp-2, -0x1.15e8cce261c55p-56, --0x1p0, -0x1.5a527273c56e1p-4, --0x1.9c17d440df9f2p-2, --0x1.923c540a9eec4p-57, --0x1p0, -0x1.5f6597591b633p-4, --0x1.9ef7943a8ed8ap-2, --0x1.6da81290bdbabp-57, --0x1p0, -0x1.6481c21a02123p-4, --0x1.a1d6543b50acp-2, -0x1.0246cfd8779fbp-57, --0x1p0, -0x1.69a6ef8f8830ap-4, --0x1.a4b4127dea1e5p-2, -0x1.bec6f01bc22f1p-56, --0x1p0, -0x1.6ed51c8d2d8fcp-4, --0x1.a790cd3dbf31bp-2, -0x1.7f786986d9023p-57, --0x1p0, -0x1.740c45e0e512p-4, --0x1.aa6c82b6d3fcap-2, -0x1.d5f106ee5ccf7p-56, --0x1p0, -0x1.794c685316a3cp-4, --0x1.ad473125cdc09p-2, -0x1.379ede57649dap-58, --0x1p0, -0x1.7e9580a6a136ep-4, --0x1.b020d6c7f4009p-2, --0x1.414ae7e555208p-58, --0x1p0, -0x1.83e78b98dcc2bp-4, --0x1.b2f971db31972p-2, --0x1.fa971a4a41f2p-56, --0x1p0, -0x1.894285e19c468p-4, --0x1.b5d1009e15ccp-2, --0x1.5b362cb974183p-57, --0x1p0, -0x1.8ea66c332fd01p-4, --0x1.b8a7814fd5693p-2, --0x1.9a9e6651cc119p-56, --0x1p0, -0x1.94133b3a66851p-4, --0x1.bb7cf2304bd01p-2, --0x1.9e1a5bd9269d4p-57, --0x1p0, -0x1.9988ef9e90b04p-4, --0x1.be51517ffc0d9p-2, --0x1.2b667131a5f16p-56, --0x1p0, -0x1.9f07860181d1ep-4, --0x1.c1249d8011ee7p-2, -0x1.813aabb515206p-56, --0x1p0, -0x1.a48efaff92b3bp-4, --0x1.c3f6d47263129p-2, --0x1.9c7bd0fcdecddp-56, --0x1p0, -0x1.aa1f4b2fa37fcp-4, --0x1.c6c7f4997000bp-2, -0x1.bec2669c68e74p-56, --0x1p0, -0x1.afb873231ddb9p-4, --0x1.c997fc3865389p-2, -0x1.6295f8b0ca33bp-56, --0x1p0, -0x1.b55a6f65f7058p-4, --0x1.cc66e9931c45ep-2, --0x1.6850e59c37f8fp-58, --0x1p0, -0x1.bb053c7eb1f68p-4, --0x1.cf34baee1cd21p-2, -0x1.118724d19d014p-56, --0x1p0, -0x1.c0b8d6ee61867p-4, --0x1.d2016e8e9db5bp-2, -0x1.c8bce9d93efb8p-57, --0x1p0, -0x1.c6753b30aa949p-4, --0x1.d4cd02ba8609dp-2, -0x1.37f33c63033d6p-57, --0x1p0, -0x1.cc3a65bbc6327p-4, --0x1.d79775b86e389p-2, --0x1.550ec87bc0575p-56, --0x1p0, -0x1.d208530083d3p-4, --0x1.da60c5cfa10d9p-2, -0x1.0f38e2143c8d5p-57, --0x1p0, -0x1.d7deff6a4b7c9p-4, --0x1.dd28f1481cc58p-2, -0x1.e7576fa6c944ep-59, --0x1p0, -0x1.ddbe675f1ffdfp-4, --0x1.dfeff66a941dep-2, -0x1.a756c6e625f96p-56, --0x1p0, -0x1.e3a6873fa1279p-4, --0x1.e2b5d3806f63bp-2, --0x1.e0d891d3c6841p-58, --0x1p0, -0x1.e9975b670e077p-4, --0x1.e57a86d3cd825p-2, -0x1.2c80dcd511e87p-57, --0x1p0, -0x1.ef90e02b47283p-4, --0x1.e83e0eaf85114p-2, -0x1.7bc380ef24ba7p-57, --0x1p0, -0x1.f59311dcd0d44p-4, --0x1.eb00695f2562p-2, --0x1.53c9fd3083e22p-56, --0x1p0, -0x1.fb9decc6d55b8p-4, --0x1.edc1952ef78d6p-2, -0x1.dd0f7c33edee6p-56, --0x1p0, -0x1.00d8b69793ae4p-3, --0x1.f081906bff7fep-2, -0x1.4cab2d4ff6fccp-56, --0x1p0, -0x1.03e6c7ab2208cp-3, --0x1.f3405963fd067p-2, --0x1.06846d44a238fp-56, --0x1p0, -0x1.06f927bbaacfep-3, --0x1.f5fdee656cda3p-2, -0x1.7bf9780816b05p-58, --0x1p0, -0x1.0a0fd4e41ab5ap-3, --0x1.f8ba4dbf89abap-2, -0x1.2ec1fc1b776b8p-60, --0x1p0, -0x1.0d2acd3cb7364p-3, --0x1.fb7575c24d2dep-2, -0x1.5bfdc883c8664p-57, --0x1p0, -0x1.104a0edb1fc58p-3, --0x1.fe2f64be7121p-2, -0x1.297ab1ca2d7dbp-56, --0x1p0, -0x1.136d97d24efccp-3, --0x1.00740c82b82e1p-1, -0x1.6d48563c60e87p-55, --0x1p0, -0x1.169566329bcb7p-3, --0x1.01cfc874c3eb7p-1, -0x1.34a35e7c2368cp-56, --0x1p0, -0x1.19c17809baa87p-3, --0x1.032ae55edbd96p-1, -0x1.bdb022b40107ap-55, --0x1p0, -0x1.1cf1cb62bec5dp-3, --0x1.0485626ae221ap-1, --0x1.b937d9091ff7p-55, --0x1p0, -0x1.20265e461b45ap-3, --0x1.05df3ec31b8b7p-1, -0x1.e2dcad34d9c1dp-57, --0x1p0, -0x1.235f2eb9a470ap-3, --0x1.073879922ffeep-1, -0x1.a5a014347406cp-55, --0x1p0, -0x1.269c3ac090ee4p-3, --0x1.089112032b08cp-1, --0x1.3248ddf9fe619p-57, --0x1p0, -0x1.29dd805b7afecp-3, --0x1.09e907417c5e1p-1, -0x1.fe573741a9bd4p-55, --0x1p0, -0x1.2d22fd8861b6bp-3, --0x1.0b405878f85ecp-1, -0x1.ad66c3bb80da5p-55, --0x1p0, -0x1.306cb042aa3bap-3, --0x1.0c9704d5d898fp-1, -0x1.8d3d7de6ee9b2p-55, --0x1p0, -0x1.33ba968321032p-3, --0x1.0ded0b84bc4b6p-1, -0x1.8540fa327c55cp-55, --0x1p0, -0x1.370cae3ffb12fp-3, --0x1.0f426bb2a8e7ep-1, -0x1.bb58fb774f8eep-55, --0x1p0, -0x1.3a62f56cd742ep-3, --0x1.1097248d0a957p-1, -0x1.7a58759ba80ddp-55, --0x1p0, -0x1.3dbd69fabf802p-3, --0x1.11eb3541b4b23p-1, -0x1.ef23b69abe4f1p-55, --0x1p0, -0x1.411c09d82a128p-3, --0x1.133e9cfee254fp-1, -0x1.a1377cfd5ce5p-56, --0x1p0, -0x1.447ed2f0fae31p-3, --0x1.14915af336cebp-1, --0x1.f3660558a0213p-56, --0x1p0, -0x1.47e5c32e84c45p-3, --0x1.15e36e4dbe2bcp-1, --0x1.3c545f7d79eaep-56, --0x1p0, -0x1.4b50d8778abbdp-3, --0x1.1734d63dedb49p-1, -0x1.7eef2ccc50575p-55, --0x1p0, -0x1.4ec010b0414e1p-3, --0x1.188591f3a46e5p-1, -0x1.bbefe5a524346p-56, --0x1p0, -0x1.523369ba4fcaep-3, --0x1.19d5a09f2b9b8p-1, -0x1.33656c68a1d4ap-57, --0x1p0, -0x1.55aae174d19c8p-3, --0x1.1b250171373bfp-1, -0x1.b210e95e1ca4cp-55, --0x1p0, -0x1.592675bc57974p-3, --0x1.1c73b39ae68c8p-1, --0x1.b25dd267f66p-55, --0x1p0, -0x1.5ca6246ae94b8p-3, --0x1.1dc1b64dc4872p-1, --0x1.f15e1c468be78p-57, --0x1p0, -0x1.6029eb580658ep-3, --0x1.1f0f08bbc861bp-1, -0x1.10d9dcafb74cbp-57, --0x1p0, -0x1.63b1c858a7c2ep-3, --0x1.205baa17560d6p-1, --0x1.b7b144016c7a3p-56, --0x1p0, -0x1.673db93f41479p-3, --0x1.21a799933eb59p-1, -0x1.3a7b177c68fb2p-55, --0x1p0, -0x1.6acdbbdbc2b73p-3, --0x1.22f2d662c13e2p-1, -0x1.d5cc7580cb6d2p-55, --0x1p0, -0x1.6e61cdfb994dfp-3, --0x1.243d5fb98ac1fp-1, --0x1.c533d0a284a8dp-56, --0x1p0, -0x1.71f9ed69b10eap-3, --0x1.258734cbb711p-1, --0x1.3a3f0903ce09dp-57, --0x1p0, -0x1.759617ee761f9p-3, --0x1.26d054cdd12dfp-1, -0x1.5da743ef3770cp-55, --0x1p0, -0x1.79364b4fd6288p-3, --0x1.2818bef4d3cbap-1, -0x1.e3fffeb76568ap-56, --0x1p0, -0x1.7cda855141b26p-3, --0x1.2960727629ca8p-1, --0x1.56d6c7af02d5cp-56, --0x1p0, -0x1.8082c3b3ad887p-3, --0x1.2aa76e87aeb58p-1, --0x1.fd600833287a7p-59, --0x1p0, -0x1.842f0435941afp-3, --0x1.2bedb25faf3eap-1, -0x1.14981c796ee46p-58, --0x1p0, -0x1.87df4492f6e38p-3, --0x1.2d333d34e9bb8p-1, -0x1.0e2c2c5549e26p-55, --0x1p0, -0x1.8b9382855fcaap-3, --0x1.2e780e3e8ea17p-1, -0x1.b19fafe36587ap-55, --0x1p0, -0x1.8f4bbbc3e28f6p-3, --0x1.2fbc24b441015p-1, --0x1.dba4875410874p-57, --0x1p0, -0x1.9307ee031e2fdp-3, --0x1.30ff7fce17035p-1, -0x1.efcc626f74a6fp-57, --0x1p0, -0x1.96c816f53e539p-3, --0x1.32421ec49a61fp-1, --0x1.65e25cc951bfep-55, --0x1p0, -0x1.9a8c3449fcb77p-3, --0x1.338400d0c8e57p-1, -0x1.abf2a5e95e6e5p-55, --0x1p0, -0x1.9e5443aea29b2p-3, --0x1.34c5252c14de1p-1, --0x1.583f49632ab2bp-55, --0x1p0, -0x1.a22042ce0a2f9p-3, --0x1.36058b10659f3p-1, -0x1.1fcb3a35857e7p-55, --0x1p0, -0x1.a5f02f50a007cp-3, --0x1.374531b817f8dp-1, --0x1.444d2b0a747fep-55, --0x1p0, -0x1.a9c406dc648a5p-3, --0x1.3884185dfeb22p-1, -0x1.a038026abe6b2p-56, --0x1p0, -0x1.ad9bc714ed64fp-3, --0x1.39c23e3d63029p-1, -0x1.3b05b276085c1p-58, --0x1p0, -0x1.b1776d9b67013p-3, --0x1.3affa292050b9p-1, --0x1.e3e25e3954964p-56, --0x1p0, -0x1.b556f80e95facp-3, --0x1.3c3c44981c518p-1, -0x1.b5e9a9644151bp-55, --0x1p0, -0x1.b93a640ad8978p-3, --0x1.3d78238c58344p-1, -0x1.0219f5f0f79cep-55, --0x1p0, -0x1.bd21af2a28408p-3, --0x1.3eb33eabe068p-1, --0x1.86a2357d1a0d3p-58, --0x1p0, -0x1.c10cd7041afccp-3, --0x1.3fed9534556d4p-1, --0x1.36916608c5061p-55, --0x1p0, -0x1.c4fbd92de4eddp-3, --0x1.41272663d108cp-1, --0x1.1bbe7636fadf5p-55, --0x1p0, -0x1.c8eeb33a59cdp-3, --0x1.425ff178e6bb1p-1, --0x1.7b38d675140cap-55, --0x1p0, -0x1.cce562b9ee6aep-3, --0x1.4397f5b2a438p-1, -0x1.7274c9e48c226p-55, --0x1p0, -0x1.d0dfe53aba2fdp-3, --0x1.44cf325091dd6p-1, --0x1.8076a2cfdc6b3p-57, --0x1p0, -0x1.d4de3848789e2p-3, --0x1.4605a692b32a2p-1, --0x1.21ca219b97107p-55, --0x1p0, -0x1.d8e0596c8ad56p-3, --0x1.473b51b987347p-1, --0x1.ca1953514e41bp-57, --0x1p0, -0x1.dce6462df917dp-3, --0x1.48703306091ffp-1, -0x1.70813b86159fdp-57, --0x1p0, -0x1.e0effc1174505p-3, --0x1.49a449b9b0939p-1, -0x1.27ee16d719b94p-55, --0x1p0, -0x1.e4fd7899579acp-3, --0x1.4ad79516722f1p-1, -0x1.1273b163000f7p-55, --0x1p0, -0x1.e90eb945a9ccfp-3, --0x1.4c0a145ec0004p-1, --0x1.2630cfafceaa1p-58, --0x1p0, -0x1.ed23bb941f019p-3, --0x1.4d3bc6d589f7fp-1, --0x1.6e4d9d6b72011p-55, --0x1p0, -0x1.f13c7d001a249p-3, --0x1.4e6cabbe3e5e9p-1, --0x1.3c293edceb327p-57, --0x1p0, -0x1.f558fb02ae805p-3, --0x1.4f9cc25cca486p-1, --0x1.48b5951cfc2b5p-55, --0x1p0, -0x1.f9793312a14d1p-3, --0x1.50cc09f59a09bp-1, --0x1.693463a2c2e6fp-56, --0x1p0, -0x1.fd9d22a46b416p-3, --0x1.51fa81cd99aa6p-1, -0x1.499f59d8560e9p-63, --0x1p0, -0x1.00e263951d11fp-2, --0x1.5328292a35596p-1, -0x1.a12eb89da0257p-56, --0x1p0, -0x1.02f80f09f92f4p-2, --0x1.5454ff5159dfcp-1, -0x1.4e247588bf256p-55, --0x1p0, -0x1.050f92679849cp-2, --0x1.5581038975137p-1, --0x1.4570d9efe26dfp-55, --0x1p0, -0x1.0728ec63a599ap-2, --0x1.56ac35197649fp-1, -0x1.f7874188cb279p-55, --0x1p0, -0x1.09441bb2aa0a2p-2, --0x1.57d69348cecap-1, -0x1.75720992bfbb2p-55, --0x1p0, -0x1.0b611f080d05bp-2, --0x1.59001d5f723dfp-1, --0x1.a9f86ba0dde98p-56, --0x1p0, -0x1.0d7ff51615437p-2, --0x1.5a28d2a5d725p-1, --0x1.57a25f8b1343p-55, --0x1p0, -0x1.0fa09c8de994bp-2, --0x1.5b50b264f7448p-1, --0x1.519d30d4cfebp-56, --0x1p0, -0x1.11c3141f91b3ep-2, --0x1.5c77bbe65018cp-1, --0x1.069ea9c0bc32ap-55, --0x1p0, -0x1.13e75a79f7139p-2, --0x1.5d9dee73e345cp-1, -0x1.de1165ecdf7a3p-57, --0x1p0, -0x1.160d6e4ae5ae6p-2, --0x1.5ec3495837074p-1, --0x1.dea89a9b8f727p-56, --0x1p0, -0x1.18354e3f0cd7dp-2, --0x1.5fe7cbde56a1p-1, -0x1.fcb9cc30cc01ep-55, --0x1p0, -0x1.1a5ef902000d3p-2, --0x1.610b7551d2cdfp-1, -0x1.251b352ff2a37p-56, --0x1p0, -0x1.1c8a6d3e37c82p-2, --0x1.622e44fec22ffp-1, --0x1.f98d8be132d57p-56, --0x1p0, -0x1.1eb7a99d1250cp-2, --0x1.63503a31c1be9p-1, --0x1.1248f09e6587cp-57, --0x1p0, -0x1.20e6acc6d4916p-2, --0x1.64715437f535bp-1, -0x1.7c399c15a17dp-55, --0x1p0, -0x1.23177562aaea3p-2, --0x1.6591925f0783dp-1, --0x1.c3d64fbf5de23p-55, --0x1p0, -0x1.254a0216aa067p-2, --0x1.66b0f3f52b386p-1, --0x1.1e2eb31a8848bp-55, --0x1p0, -0x1.277e5187cfb16p-2, --0x1.67cf78491af1p-1, --0x1.750ab23477b61p-59, --0x1p0, -0x1.29b4625a03ac9p-2, --0x1.68ed1eaa19c71p-1, --0x1.fd4a85350f69p-56, --0x1p0, -0, --0x1.6a09e667f3bcdp-1, -0x1.bdd3413b26456p-55, -0, --0x1.a3b47aa8671c5p-3, --0x1.6b25ced2fe29cp-1, -0x1.5ac64116beda5p-55, --0x1p-1, --0x1.9f3de1246bc4p-3, --0x1.6c40d73c18275p-1, --0x1.25d4f802be257p-57, --0x1p-1, --0x1.9ac3cfd4ace19p-3, --0x1.6d5afef4aafcdp-1, -0x1.868a696b8835ep-55, --0x1p-1, --0x1.9646497c1e0f6p-3, --0x1.6e74454eaa8afp-1, -0x1.dbc03c84e226ep-55, --0x1p-1, --0x1.91c550dfd4d6bp-3, --0x1.6f8ca99c95b75p-1, --0x1.f22e7a35723f4p-56, --0x1p-1, --0x1.8d40e8c706fa4p-3, --0x1.70a42b3176d7ap-1, -0x1.d9e3fbe2e15ap-56, --0x1p-1, --0x1.88b913fb08bfdp-3, --0x1.71bac960e41bfp-1, -0x1.b858d90b0f7d8p-56, --0x1p-1, --0x1.842dd5474b37bp-3, --0x1.72d0837efff96p-1, --0x1.0d4ef0f1d915cp-55, --0x1p-1, --0x1.7f9f2f795a83ep-3, --0x1.73e558e079942p-1, -0x1.2663126697f5ep-55, --0x1p-1, --0x1.7b0d2560dc1d1p-3, --0x1.74f948da8d28dp-1, --0x1.19900a3b9a3a2p-63, --0x1p-1, --0x1.7677b9cf8d17p-3, --0x1.760c52c304764p-1, -0x1.11d76f8e50f1fp-55, --0x1p-1, --0x1.71deef9940631p-3, --0x1.771e75f037261p-1, --0x1.5cfce8d84068fp-56, --0x1p-1, --0x1.6d42c993dd121p-3, --0x1.782fb1b90b35bp-1, -0x1.3e46c1dfd001cp-55, --0x1p-1, --0x1.68a34a975c941p-3, --0x1.79400574f55e5p-1, -0x1.0adadbdb4c65ap-55, --0x1p-1, --0x1.6400757dc8f7dp-3, --0x1.7a4f707bf97d2p-1, --0x1.3c9751b491eafp-55, --0x1p-1, --0x1.5f5a4d233b27fp-3, --0x1.7b5df226aafafp-1, -0x1.0f537acdf0ad7p-56, --0x1p-1, --0x1.5ab0d465d927ap-3, --0x1.7c6b89ce2d333p-1, -0x1.cfd628084982cp-56, --0x1p-1, --0x1.56040e25d44ddp-3, --0x1.7d7836cc33db2p-1, --0x1.162715ef03f85p-56, --0x1p-1, --0x1.5153fd45677efp-3, --0x1.7e83f87b03686p-1, --0x1.b61a8ccabad6p-57, --0x1p-1, --0x1.4ca0a4a8d5657p-3, --0x1.7f8ece3571771p-1, -0x1.9c8d8ce93c917p-55, --0x1p-1, --0x1.47ea073666a98p-3, --0x1.8098b756e52fap-1, --0x1.9136e834b4707p-55, --0x1p-1, --0x1.433027d66826dp-3, --0x1.81a1b33b57accp-1, -0x1.5dea12d66bb66p-55, --0x1p-1, --0x1.3e73097329219p-3, --0x1.82a9c13f545ffp-1, -0x1.65e87a7a8cde9p-56, --0x1p-1, --0x1.39b2aef8f97a4p-3, --0x1.83b0e0bff976ep-1, -0x1.6f420f8ea3475p-56, --0x1p-1, --0x1.34ef1b5627dfdp-3, --0x1.84b7111af83fap-1, -0x1.63a47df0b21bap-55, --0x1p-1, --0x1.3028517b0001p-3, --0x1.85bc51ae958ccp-1, --0x1.45ba6478086ccp-55, --0x1p-1, --0x1.2b5e5459c8bc3p-3, --0x1.86c0a1d9aa195p-1, --0x1.84564f09c3726p-59, --0x1p-1, --0x1.269126e6c24e3p-3, --0x1.87c400fba2ebfp-1, -0x1.2dabc0c3f64cdp-55, --0x1p-1, --0x1.21c0cc18247fcp-3, --0x1.88c66e7481ba1p-1, -0x1.5c6228970cf35p-56, --0x1p-1, --0x1.1ced46e61cd1cp-3, --0x1.89c7e9a4dd4aap-1, --0x1.db6ea04a8678fp-55, --0x1p-1, --0x1.18169a4acca89p-3, --0x1.8ac871ede1d88p-1, -0x1.9afaa5b7cfc55p-55, --0x1p-1, --0x1.133cc94247758p-3, --0x1.8bc806b151741p-1, -0x1.2c5e12ed1336dp-55, --0x1p-1, --0x1.0e5fd6ca90dffp-3, --0x1.8cc6a75184655p-1, -0x1.e18b3657e2285p-55, --0x1p-1, --0x1.097fc5e39aec5p-3, --0x1.8dc45331698ccp-1, --0x1.1d9fcd83634d7p-57, --0x1p-1, --0x1.049c998f44231p-3, --0x1.8ec109b486c49p-1, -0x1.cb2a3eb6af617p-56, --0x1p-1, --0x1.ff6ca9a2ab6a2p-4, --0x1.8fbcca3ef940dp-1, -0x1.6dfa99c86f2f1p-57, --0x1p-1, --0x1.f599f55f034p-4, --0x1.90b7943575efep-1, --0x1.4ecb0c5273706p-57, --0x1p-1, --0x1.ebc11c62c1a1ep-4, --0x1.91b166fd49da2p-1, -0x1.3be953a7fe996p-57, --0x1p-1, --0x1.e1e224c0e28bdp-4, --0x1.92aa41fc5a815p-1, -0x1.68f89e2d23db7p-57, --0x1p-1, --0x1.d7fd1490285cap-4, --0x1.93a22499263fbp-1, --0x1.3d419a920df0bp-55, --0x1p-1, --0x1.ce11f1eb18148p-4, --0x1.94990e3ac4a6cp-1, --0x1.a95328edeb3e6p-56, --0x1p-1, --0x1.c420c2eff590ep-4, --0x1.958efe48e6dd7p-1, -0x1.561335da0f4e7p-55, --0x1p-1, --0x1.ba298dc0bfc6bp-4, --0x1.9683f42bd7fe1p-1, -0x1.11bad933c835ep-57, --0x1p-1, --0x1.b02c58832cf96p-4, --0x1.9777ef4c7d742p-1, -0x1.15479a240665ep-55, --0x1p-1, --0x1.a6292960a6f0bp-4, --0x1.986aef1457594p-1, -0x1.af03e318f38fcp-55, --0x1p-1, --0x1.9c200686472b5p-4, --0x1.995cf2ed80d22p-1, --0x1.7783e907fbd7bp-56, --0x1p-1, --0x1.9210f624d30fbp-4, --0x1.9a4dfa42b06b2p-1, -0x1.829b6b8b1c947p-56, --0x1p-1, --0x1.87fbfe70b81a7p-4, --0x1.9b3e047f38741p-1, -0x1.30ee286712474p-55, --0x1p-1, --0x1.7de125a2080a9p-4, --0x1.9c2d110f075c2p-1, --0x1.d9c9f1c8c30dp-55, --0x1p-1, --0x1.73c071f4750b5p-4, --0x1.9d1b1f5ea80d5p-1, --0x1.c5fadd5ffb36fp-55, --0x1p-1, --0x1.6999e9a74ddbep-4, --0x1.9e082edb42472p-1, --0x1.5809a4e121e22p-57, --0x1p-1, --0x1.5f6d92fd79f5p-4, --0x1.9ef43ef29af94p-1, --0x1.b1dfcb60445c2p-56, --0x1p-1, --0x1.553b743d75acp-4, --0x1.9fdf4f13149dep-1, --0x1.1e6d79006ec09p-55, --0x1p-1, --0x1.4b0393b14e541p-4, --0x1.a0c95eabaf937p-1, -0x1.e0ca3acbd049ap-55, --0x1p-1, --0x1.40c5f7a69e5cep-4, --0x1.a1b26d2c0a75ep-1, --0x1.30ef431d627a6p-57, --0x1p-1, --0x1.3682a66e896f5p-4, --0x1.a29a7a0462782p-1, -0x1.128bb015df175p-56, --0x1p-1, --0x1.2c39a65db8881p-4, --0x1.a38184a593bc6p-1, -0x1.bc92c5bd2d288p-55, --0x1p-1, --0x1.21eafdcc560fap-4, --0x1.a4678c8119ac8p-1, --0x1.1b4c0dd3f212ap-55, --0x1p-1, --0x1.1796b31609f0cp-4, --0x1.a54c91090f523p-1, --0x1.184300fd1c1cep-56, --0x1p-1, --0x1.0d3ccc99f5ac6p-4, --0x1.a63091b02fae2p-1, -0x1.e911152248d1p-56, --0x1p-1, --0x1.02dd50bab06b2p-4, --0x1.a7138de9d60f5p-1, -0x1.f1ab82a9c5f2dp-55, --0x1p-1, --0x1.f0f08bbc861afp-5, --0x1.a7f58529fe69dp-1, -0x1.97a441584a179p-55, --0x1p-1, --0x1.dc1b64dc48722p-5, --0x1.a8d676e545ad2p-1, -0x1.b11dcce2e74bdp-59, --0x1p-1, --0x1.c73b39ae68c87p-5, --0x1.a9b66290ea1a3p-1, --0x1.9f630e8b6dac8p-60, --0x1p-1, --0x1.b250171373be9p-5, --0x1.aa9547a2cb98ep-1, --0x1.87d00ae97abaap-60, --0x1p-1, --0x1.9d5a09f2b9b7fp-5, --0x1.ab7325916c0d4p-1, --0x1.a8b8c85baaa9bp-55, --0x1p-1, --0x1.88591f3a46e4dp-5, --0x1.ac4ffbd3efac8p-1, -0x1.818504103fa16p-56, --0x1p-1, --0x1.734d63dedb48ap-5, --0x1.ad2bc9e21d511p-1, -0x1.47fbe07bea548p-55, --0x1p-1, --0x1.5e36e4dbe2bc2p-5, --0x1.ae068f345ecefp-1, -0x1.33934c4029a4cp-56, --0x1p-1, --0x1.4915af336ceb4p-5, --0x1.aee04b43c1474p-1, -0x1.3a79a438bf8ccp-55, --0x1p-1, --0x1.33e9cfee254edp-5, --0x1.afb8fd89f57b6p-1, --0x1.1ced12d2899b8p-60, --0x1p-1, --0x1.1eb3541b4b228p-5, --0x1.b090a581502p-1, -0x1.926da300ffccep-55, --0x1p-1, --0x1.097248d0a956ap-5, --0x1.b16742a4ca2f5p-1, -0x1.ba70972b80438p-55, --0x1p-1, --0x1.e84d76551cfb2p-6, --0x1.b23cd470013b4p-1, --0x1.5a1bb35ad6d2ep-56, --0x1p-1, --0x1.bda17097896b4p-6, --0x1.b3115a5f37bf3p-1, --0x1.dde2726e34fe1p-55, --0x1p-1, --0x1.92e09abb131d4p-6, --0x1.b3e4d3ef55712p-1, -0x1.eb6b8bf11a493p-55, --0x1p-1, --0x1.680b0f1f0bd73p-6, --0x1.b4b7409de7925p-1, --0x1.f4e257bde73d8p-56, --0x1p-1, --0x1.3d20e82f8bc1p-6, --0x1.b5889fe921405p-1, -0x1.df49b307c8602p-57, --0x1p-1, --0x1.1222406561182p-6, --0x1.b658f14fdbc47p-1, --0x1.52b5308f397dep-57, --0x1p-1, --0x1.ce1e648bffb66p-7, --0x1.b728345196e3ep-1, -0x1.bc69f324e6d61p-55, --0x1p-1, --0x1.77cfb0c6e2db8p-7, --0x1.b7f6686e792e9p-1, --0x1.87665bfea06aap-55, --0x1p-1, --0x1.21589ab88869cp-7, --0x1.b8c38d27504e9p-1, -0x1.1529abff40e45p-55, --0x1p-1, --0x1.9572af6decac8p-8, --0x1.b98fa1fd9155ep-1, --0x1.5559034fe85a4p-55, --0x1p-1, --0x1.cfc874c3eb6d9p-9, --0x1.ba5aa673590d2p-1, --0x1.7ea4e370753b6p-55, --0x1p-1, --0x1.d0320ae0b8293p-11, --0x1.bb249a0b6c40dp-1, -0x1.d6318ee919f7ap-58, --0x1p-1, -0x1.d09b418edf04ap-10, --0x1.bbed7c49380eap-1, --0x1.beacbd88500b4p-59, --0x1p-1, -0x1.22a28f6cb488bp-8, --0x1.bcb54cb0d2327p-1, --0x1.410923c55523ep-62, --0x1p-1, -0x1.d16c901d95181p-8, --0x1.bd7c0ac6f952ap-1, -0x1.825a732ac700ap-55, --0x1p-1, -0x1.4042335264ba3p-7, --0x1.be41b611154c1p-1, -0x1.fdcdad3a6877ep-55, --0x1p-1, -0x1.97f4d3805f318p-7, --0x1.bf064e15377ddp-1, --0x1.2156026a1e028p-57, --0x1p-1, -0x1.efcdf2801004ap-7, --0x1.bfc9d25a1b147p-1, -0x1.51bf4ee01357p-61, --0x1p-1, -0x1.23e6ad10872a7p-6, --0x1.c08c426725549p-1, --0x1.b157fd80e2946p-58, --0x1p-1, -0x1.4ff96a0da9dfbp-6, --0x1.c14d9dc465e57p-1, --0x1.ce36b64c7f3ccp-55, --0x1p-1, -0x1.7c1f1507aeec3p-6, --0x1.c20de3fa971bp-1, -0x1.b4ca2bab1322cp-55, --0x1p-1, -0x1.a85792c327db2p-6, --0x1.c2cd14931e3f1p-1, --0x1.2ce2f9d4600f5p-56, --0x1p-1, -0x1.d4a2c7f909c4ep-6, --0x1.c38b2f180bdb1p-1, -0x1.6e0b1757c8d07p-56, --0x1p-1, -0x1.00804cab5f113p-5, --0x1.c44833141c004p-1, --0x1.23e0521df01a2p-56, --0x1p-1, -0x1.16b875bf19d4p-5, --0x1.c5042012b6907p-1, -0x1.5c058dd8eaba5p-57, --0x1p-1, -0x1.2cf9d182f7939p-5, --0x1.c5bef59fef85ap-1, -0x1.f0a406c8b7468p-58, --0x1p-1, -0x1.4344523c8e3b5p-5, --0x1.c678b3488739bp-1, --0x1.d86cac7c5ff5bp-57, --0x1p-1, -0x1.5997ea2bcfb19p-5, --0x1.c7315899eaad7p-1, -0x1.9be5dcd047da7p-57, --0x1p-1, -0x1.6ff48b8b1252ap-5, --0x1.c7e8e52233cf3p-1, --0x1.b2ad324aa35c1p-57, --0x1p-1, -0x1.865a288f196fap-5, --0x1.c89f587029c13p-1, --0x1.588358ed6e78fp-58, --0x1p-1, -0x1.9cc8b3671dd0fp-5, --0x1.c954b213411f5p-1, -0x1.2fb761e946603p-58, --0x1p-1, -0x1.b3401e3cd63bbp-5, --0x1.ca08f19b9c449p-1, -0x1.431e0a5a737fdp-56, --0x1p-1, -0x1.c9c05b347ffabp-5, --0x1.cabc169a0b9p-1, --0x1.c42d3e10851d1p-55, --0x1p-1, -0x1.e0495c6ce76b5p-5, --0x1.cb6e20a00da99p-1, -0x1.4fb24b5194c1bp-55, --0x1p-1, -0x1.f6db13ff708cbp-5, --0x1.cc1f0f3fcfc5cp-1, --0x1.e57613b68f6abp-56, --0x1p-1, -0x1.06baba000fc9bp-4, --0x1.cccee20c2deap-1, -0x1.d3116ae0e69e4p-55, --0x1p-1, -0x1.120c373ed0bfbp-4, --0x1.cd7d9898b32f6p-1, -0x1.f2fa062496738p-57, --0x1p-1, -0x1.1d61fac0aa5b2p-4, --0x1.ce2b32799a06p-1, -0x1.631d457e46317p-56, --0x1p-1, -0x1.28bbfd87a8cffp-4, --0x1.ced7af43cc773p-1, -0x1.e7b6bb5ab58aep-58, --0x1p-1, -0x1.341a389339a36p-4, --0x1.cf830e8ce467bp-1, -0x1.7b9202780d49dp-55, --0x1p-1, -0x1.3f7ca4e02ffdcp-4, --0x1.d02d4feb2bd92p-1, --0x1.195ff41bc55fep-55, --0x1p-1, -0x1.4ae33b68c8fdcp-4, --0x1.d0d672f59d2b9p-1, -0x1.c83009f0c39dep-55, --0x1p-1, -0x1.564df524b00dap-4, --0x1.d17e7743e35dcp-1, -0x1.101da3540130ap-58, --0x1p-1, -0x1.61bccb0903395p-4, --0x1.d2255c6e5a4e1p-1, -0x1.d129a71ecafc9p-55, --0x1p-1, -0x1.6d2fb6085786ep-4, --0x1.d2cb220e0ef9fp-1, -0x1.f07656d4e6652p-56, --0x1p-1, -0x1.78a6af12bd501p-4, --0x1.d36fc7bcbfbdcp-1, -0x1.ba196d95a177dp-55, --0x1p-1, -0x1.8421af15c49d7p-4, --0x1.d4134d14dc93ap-1, -0x1.4ef5295d25af2p-55, --0x1p-1, -0x1.8fa0aefc81837p-4, --0x1.d4b5b1b187524p-1, -0x1.f56be6b42b76dp-57, --0x1p-1, -0x1.9b23a7af90805p-4, --0x1.d556f52e93eb1p-1, -0x1.80ed9233a963p-55, --0x1p-1, -0x1.a6aa92151adc3p-4, --0x1.d5f7172888a7fp-1, -0x1.68663e2225755p-55, --0x1p-1, -0x1.b2356710db0a3p-4, --0x1.d696173c9e68bp-1, -0x1.e8c61c6393d55p-56, --0x1p-1, -0x1.bdc41f84210bbp-4, --0x1.d733f508c0dffp-1, -0x1.007928e770cd5p-55, --0x1p-1, -0x1.c956b44dd6d41p-4, --0x1.d7d0b02b8ecf9p-1, --0x1.800f4ce65cd6ep-55, --0x1p-1, -0x1.d4ed1e4a84aefp-4, --0x1.d86c48445a44fp-1, --0x1.e8813c023d71fp-55, --0x1p-1, -0x1.e087565455a75p-4, --0x1.d906bcf328d46p-1, --0x1.457e610231ac2p-56, --0x1p-1, -0x1.ec2555431bf03p-4, --0x1.d9a00dd8b3d46p-1, --0x1.bea0e4bac8e16p-58, --0x1p-1, -0x1.f7c713ec554fp-4, --0x1.da383a9668988p-1, -0x1.5811000b39d84p-55, --0x1p-1, -0x1.01b6459197c38p-3, --0x1.dacf42ce68ab9p-1, -0x1.fe8d76efdf896p-56, --0x1p-1, -0x1.078ad9dc46632p-3, --0x1.db6526238a09bp-1, -0x1.adee7eae6946p-56, --0x1p-1, -0x1.0d61433d840a4p-3, --0x1.dbf9e4395759ap-1, --0x1.d8ff7350f75fdp-55, --0x1p-1, -0x1.13397e1b7ce13p-3, --0x1.dc8d7cb41026p-1, --0x1.6b7872773830dp-56, --0x1p-1, -0x1.191386db3dedcp-3, --0x1.dd1fef38a915ap-1, -0x1.782f169e17f3bp-55, --0x1p-1, -0x1.1eef59e0b74c3p-3, --0x1.ddb13b6ccc23cp-1, --0x1.83c37c6107db3p-55, --0x1p-1, -0x1.24ccf38ebe694p-3, --0x1.de4160f6d8d81p-1, --0x1.9bf11cc5f8776p-55, --0x1p-1, -0x1.2aac5047103d3p-3, --0x1.ded05f7de47dap-1, -0x1.2cc4c1f8ba966p-55, --0x1p-1, --0x1.9ee5272b58f2ap-4, --0x1.df5e36a9ba59cp-1, -0x1.e01f8bceb43d3p-57, --0x1p-2, --0x1.931f774fc9f18p-4, --0x1.dfeae622dbe2bp-1, -0x1.514ea88425567p-55, --0x1p-2, --0x1.875657223080ap-4, --0x1.e0766d9280f54p-1, --0x1.f44c969cf62e3p-55, --0x1p-2, --0x1.7b89cde7a9a4dp-4, --0x1.e100cca2980acp-1, -0x1.02d182acdf825p-57, --0x1p-2, --0x1.6fb9e2e76ced8p-4, --0x1.e18a02fdc66d9p-1, --0x1.07e272abd88cfp-55, --0x1p-2, --0x1.63e69d6ac7f74p-4, --0x1.e212104f686e5p-1, -0x1.014c76c126527p-55, --0x1p-2, --0x1.581004bd19ed2p-4, --0x1.e298f4439197ap-1, --0x1.e84e601038eb2p-57, --0x1p-2, --0x1.4c36202bcf08ep-4, --0x1.e31eae870ce25p-1, -0x1.bc7094538d678p-56, --0x1p-2, --0x1.4058f7065c11ep-4, --0x1.e3a33ec75ce85p-1, --0x1.45089cd46bbb8p-57, --0x1p-2, --0x1.3478909e39da9p-4, --0x1.e426a4b2bc17ep-1, --0x1.a873889744882p-55, --0x1p-2, --0x1.2894f446e0bccp-4, --0x1.e4a8dff81ce5ep-1, --0x1.43578776c0f46p-55, --0x1p-2, --0x1.1cae2955c414fp-4, --0x1.e529f04729ffcp-1, --0x1.9075d6e6dfc8bp-55, --0x1p-2, --0x1.10c437224dbc2p-4, --0x1.e5a9d550467d3p-1, --0x1.7d431be53f92fp-56, --0x1p-2, --0x1.04d72505d9805p-4, --0x1.e6288ec48e112p-1, -0x1.16b56f2847754p-57, --0x1p-2, --0x1.f1cdf4b76138bp-5, --0x1.e6a61c55d53a7p-1, --0x1.660d981acdcf7p-56, --0x1p-2, --0x1.d9e77d020a5bcp-5, --0x1.e7227db6a9744p-1, --0x1.2128794da5a5p-55, --0x1p-2, --0x1.c1faf1a9db555p-5, --0x1.e79db29a5165ap-1, -0x1.75e710aca58p-56, --0x1p-2, --0x1.aa086170c0a8ep-5, --0x1.e817bab4cd10dp-1, -0x1.d0afe686b5e0ap-56, --0x1p-2, --0x1.920fdb1c5d578p-5, --0x1.e89095bad6025p-1, -0x1.5a4cc0fcbccap-55, --0x1p-2, --0x1.7a116d7601c35p-5, --0x1.e9084361df7f2p-1, --0x1.cdfc7ce9dc3e9p-55, --0x1p-2, --0x1.620d274aa2903p-5, --0x1.e97ec36016b3p-1, --0x1.5bc48562557d3p-55, --0x1p-2, --0x1.4a03176acf82dp-5, --0x1.e9f4156c62ddap-1, --0x1.760b1e2e3f81ep-55, --0x1p-2, --0x1.31f34caaaa5d2p-5, --0x1.ea68393e658p-1, -0x1.467259bb7b556p-56, --0x1p-2, --0x1.19ddd5e1ddb8bp-5, --0x1.eadb2e8e7a88ep-1, -0x1.92ec52ea226a3p-55, --0x1p-2, --0x1.01c2c1eb93deep-5, --0x1.eb4cf515b8811p-1, --0x1.95da1ba97ec5ep-57, --0x1p-2, --0x1.d3443f4cdb3ddp-6, --0x1.ebbd8c8df0b74p-1, --0x1.c6c8c615e7277p-56, --0x1p-2, --0x1.a2f7fbe8f2436p-6, --0x1.ec2cf4b1af6b2p-1, --0x1.34ee3f2caa62dp-59, --0x1p-2, --0x1.72a0d77651772p-6, --0x1.ec9b2d3c3bf84p-1, --0x1.19119d358de05p-56, --0x1p-2, --0x1.423eefc693785p-6, --0x1.ed0835e999009p-1, --0x1.499d188aa32fap-57, --0x1p-2, --0x1.11d262b1f6776p-6, --0x1.ed740e7684963p-1, --0x1.e82c791f59cc2p-56, --0x1p-2, --0x1.c2b69c2e939b5p-7, --0x1.eddeb6a078651p-1, -0x1.3b579af740a74p-55, --0x1p-2, --0x1.61b39fb7b7202p-7, --0x1.ee482e25a9dbcp-1, -0x1.b6066ef81af2ap-56, --0x1p-2, --0x1.009c0bd6cc3cbp-7, --0x1.eeb074c50a544p-1, --0x1.d925f656c43b4p-55, --0x1p-2, --0x1.3ee038dff6b8p-8, --0x1.ef178a3e473c2p-1, --0x1.6310a67fe774fp-55, --0x1p-2, --0x1.f1806b9fdd1afp-10, --0x1.ef7d6e51ca3cp-1, -0x1.a3c67c3d3f604p-55, --0x1p-2, -0x1.191f2900903a6p-10, --0x1.efe220c0b95ecp-1, --0x1.c853b7bf7e0cdp-55, --0x1p-2, -0x1.0916fe858ffcdp-8, --0x1.f045a14cf738cp-1, -0x1.a52c44f45216cp-55, --0x1p-2, -0x1.cc0d09bd41caap-8, --0x1.f0a7efb9230d7p-1, --0x1.52c7adc6b4989p-56, --0x1p-2, -0x1.4794b9d21cb87p-7, --0x1.f1090bc898f5fp-1, -0x1.baa64ab102a93p-55, --0x1p-2, -0x1.a935e1efe5e4bp-7, --0x1.f168f53f7205dp-1, -0x1.26a6c1f015601p-57, --0x1p-2, -0x1.0574e07f7b332p-6, --0x1.f1c7abe284708p-1, --0x1.504b80c8a63fcp-55, --0x1p-2, -0x1.36580d5d5e775p-6, --0x1.f2252f7763adap-1, -0x1.20cb81c8d94abp-55, --0x1p-2, -0x1.67445969a108ep-6, --0x1.f2817fc4609cep-1, -0x1.dd1f8eaf65689p-55, --0x1p-2, -0x1.9839a676a6bcfp-6, --0x1.f2dc9c9089a9dp-1, --0x1.5407460bdfc07p-59, --0x1p-2, -0x1.c937d65145919p-6, --0x1.f33685a3aaefp-1, --0x1.eb78685d850f8p-56, --0x1p-2, -0x1.fa3ecac0d84e8p-6, --0x1.f38f3ac64e589p-1, -0x1.d7bafb51f72e6p-56, --0x1p-2, -0x1.15a732c3a894dp-5, --0x1.f3e6bbc1bbc65p-1, --0x1.5774bb7e8a21ep-57, --0x1p-2, -0x1.2e334430a6376p-5, --0x1.f43d085ff92ddp-1, -0x1.8fde71e361c05p-55, --0x1p-2, -0x1.46c38a8311952p-5, --0x1.f492206bcabb4p-1, --0x1.d1e921bbe3bd3p-55, --0x1p-2, -0x1.5f57f693feebep-5, --0x1.f4e603b0b2f2dp-1, -0x1.8ee01e695ac05p-56, --0x1p-2, -0x1.77f07939f3897p-5, --0x1.f538b1faf2d07p-1, -0x1.5f7cd5099519cp-59, --0x1p-2, -0x1.908d0348ef266p-5, --0x1.f58a2b1789e84p-1, --0x1.1f4a188aa368p-56, --0x1p-2, -0x1.a92d859275418p-5, --0x1.f5da6ed43685dp-1, -0x1.536fc33bf9dd8p-55, --0x1p-2, -0x1.c1d1f0e5967d5p-5, --0x1.f6297cff75cbp-1, --0x1.562172a361fd3p-56, --0x1p-2, -0x1.da7a360ef9fefp-5, --0x1.f677556883ceep-1, --0x1.ef696a8d070f4p-57, --0x1p-2, -0x1.f32645d8e6ce9p-5, --0x1.f6c3f7df5bbb7p-1, --0x1.8561ce9d5ef5bp-56, --0x1p-2, -0x1.05eb0885a69c9p-4, --0x1.f70f6434b7eb7p-1, --0x1.1775df66f0ec4p-56, --0x1p-2, -0x1.1244c435e819dp-4, --0x1.f7599a3a12077p-1, --0x1.84f31d743195cp-55, --0x1p-2, -0x1.1ea04e5ee7601p-4, --0x1.f7a299c1a322ap-1, --0x1.6e7190c94899ep-56, --0x1p-2, -0x1.2afd9f6136a9cp-4, --0x1.f7ea629e63d6ep-1, --0x1.ba92d57ebfeddp-55, --0x1p-2, --0x1.9146a0c760c35p-5, --0x1.f830f4a40c60cp-1, --0x1.8528676925128p-57, --0x1p-3, --0x1.78851122cff19p-5, --0x1.f8764fa714ba9p-1, --0x1.ab256778ffcb6p-56, --0x1p-3, --0x1.5fc0219532f79p-5, --0x1.f8ba737cb4b78p-1, -0x1.da71f96d5a49cp-55, --0x1p-3, --0x1.46f7e165f17c8p-5, --0x1.f8fd5ffae41dbp-1, -0x1.8cfd77fd970d2p-56, --0x1p-3, --0x1.2e2c5fde7ea22p-5, --0x1.f93f14f85ac08p-1, -0x1.cfd153e9a9c1ap-55, --0x1p-3, --0x1.155dac4a4f967p-5, --0x1.f97f924c9099bp-1, -0x1.e2ae0eea5963bp-55, --0x1p-3, --0x1.f917abeda4499p-6, --0x1.f9bed7cfbde29p-1, -0x1.b35b1f9bcf70bp-56, --0x1p-3, --0x1.c76dd866c689ep-6, --0x1.f9fce55adb2c8p-1, --0x1.f2a06fab9f9d1p-56, --0x1p-3, --0x1.95bdfca28b53ap-6, --0x1.fa39bac7a1791p-1, -0x1.94f388f1b4e1ep-57, --0x1p-3, --0x1.64083747309d1p-6, --0x1.fa7557f08a517p-1, -0x1.7a0a8ca13571fp-55, --0x1p-3, --0x1.324ca6fe9a04bp-6, --0x1.faafbcb0cfddcp-1, -0x1.e349cb4d3e866p-55, --0x1p-3, --0x1.008b6a763de76p-6, --0x1.fae8e8e46cfbbp-1, -0x1.3a9e414732d97p-56, --0x1p-3, --0x1.9d8940be24e74p-7, --0x1.fb20dc681d54dp-1, -0x1.ff148ec7c5fafp-55, --0x1p-3, --0x1.39f0cedaf576bp-7, --0x1.fb5797195d741p-1, --0x1.1bfac7397cc08p-56, --0x1p-3, --0x1.ac9b7964cf0bap-8, --0x1.fb8d18d66adb7p-1, -0x1.d0b66224cce2ep-56, --0x1p-3, --0x1.ca811eea0c749p-9, --0x1.fbc1617e44186p-1, -0x1.58ec496dc4ecbp-59, --0x1p-3, --0x1.dd15adf70b65ap-12, --0x1.fbf470f0a8d88p-1, -0x1.6bb200d1d70b7p-55, --0x1p-3, -0x1.536352ad19e39p-9, --0x1.fc26470e19fd3p-1, --0x1.1ec8668ecaceep-55, --0x1p-3, -0x1.7148021b55c15p-8, --0x1.fc56e3b7d9af6p-1, -0x1.03ff7a673d3bdp-56, --0x1p-3, -0x1.1c789a28b01b7p-7, --0x1.fc8646cfeb721p-1, --0x1.3143dc43a9b9dp-55, --0x1p-3, -0x1.80566267c11f6p-7, --0x1.fcb4703914354p-1, --0x1.126aa7d51b25cp-55, --0x1p-3, -0x1.e43d1c309e958p-7, --0x1.fce15fd6da67bp-1, -0x1.5dd6f830d4c09p-56, --0x1p-3, -0x1.241644f1c26cep-6, --0x1.fd0d158d86087p-1, --0x1.9705a7b864883p-55, --0x1p-3, -0x1.561236eda8ff2p-6, --0x1.fd37914220b84p-1, --0x1.52e9d7b772791p-55, --0x1p-3, -0x1.88124536d5e8fp-6, --0x1.fd60d2da75c9ep-1, --0x1.36dedb314f0ebp-58, --0x1p-3, -0x1.ba1650f592f5p-6, --0x1.fd88da3d12526p-1, -0x1.87df6378811c7p-55, --0x1p-3, -0x1.ec1e3b4fb3d7ep-6, --0x1.fdafa7514538cp-1, --0x1.d97c45ca4d398p-59, --0x1p-3, -0x1.0f14f2b4549bdp-5, --0x1.fdd539ff1f456p-1, -0x1.ab13cbbec1781p-56, --0x1p-3, -0x1.281c9830c9dafp-5, --0x1.fdf9922f73307p-1, --0x1.a5e0abd3a9b65p-56, --0x1p-3, --0x1.7db402a6a9063p-6, --0x1.fe1cafcbd5b09p-1, --0x1.a23e3202a884ep-57, --0x1p-4, --0x1.4b9dd29353428p-6, --0x1.fe3e92be9d886p-1, --0x1.afeb2e264d46bp-57, --0x1p-4, --0x1.19845e49c8257p-6, --0x1.fe5f3af2e394p-1, --0x1.b213f18c9cf17p-55, --0x1p-4, --0x1.cecf8962d14c8p-7, --0x1.fe7ea85482d6p-1, --0x1.34b085c1828f7p-56, --0x1p-4, --0x1.6a9049670cfaep-7, --0x1.fe9cdad01883ap-1, --0x1.521ecd0c67e35p-57, --0x1p-4, --0x1.064b3a76a2264p-7, --0x1.feb9d2530410fp-1, --0x1.9d429eeda9bb9p-58, --0x1p-4, --0x1.440134d709b28p-8, --0x1.fed58ecb673c4p-1, -0x1.e6e462a7ae686p-56, --0x1p-4, --0x1.ed853918c18ecp-10, --0x1.fef0102826191p-1, --0x1.3c3ea4f30addap-56, --0x1p-4, -0x1.35230c0fbe402p-10, --0x1.ff095658e71adp-1, --0x1.01a8ce18a4b9ep-55, --0x1p-4, -0x1.15fc833fb89b8p-8, --0x1.ff21614e131edp-1, -0x1.de692a167353p-55, --0x1p-4, -0x1.deb9769f940eap-8, --0x1.ff3830f8d575cp-1, -0x1.95e1e79d335f7p-56, --0x1p-4, -0x1.53bf90a81f3a5p-7, --0x1.ff4dc54b1bed3p-1, -0x1.c1169ccd1e92ep-55, --0x1p-4, -0x1.b82683bc89fbp-7, --0x1.ff621e3796d7ep-1, -0x1.c57bc2e24aa15p-57, --0x1p-4, -0x1.0e48ab4f172f4p-6, --0x1.ff753bb1b9164p-1, -0x1.7c330129f56efp-56, --0x1p-4, --0x1.7f0034a43350ep-7, --0x1.ff871dadb81dfp-1, --0x1.8b1c676208aa4p-56, --0x1p-5, --0x1.1a8e5bfe185e4p-7, --0x1.ff97c4208c014p-1, --0x1.52ab2b947e843p-57, --0x1p-5, --0x1.6c32baca2ae69p-8, --0x1.ffa72effef75dp-1, -0x1.8b4cdcdb25956p-55, --0x1p-5, --0x1.4685db42c17ebp-9, --0x1.ffb55e425fdaep-1, --0x1.6da7ec781c225p-55, --0x1p-5, -0x1.2d919c5c61fep-11, --0x1.ffc251df1d3f8p-1, --0x1.7a7d209f32d43p-56, --0x1p-5, -0x1.dd58598d6271cp-9, --0x1.ffce09ce2a679p-1, -0x1.7bd62ab5ee228p-55, --0x1p-5, -0x1.b7aa821726608p-8, --0x1.ffd886084cd0dp-1, -0x1.1354d4556e4cbp-55, --0x1p-5, --0x1.7f53487eac897p-8, --0x1.ffe1c6870cb77p-1, --0x1.89aa14768323ep-55, --0x1p-6, --0x1.6c9b5df1877eap-9, --0x1.ffe9cb44b51a1p-1, --0x1.5b43366df667p-56, --0x1p-6, -0x1.2bad2a8cd06bp-12, --0x1.fff0943c53bd1p-1, -0x1.47399f361d158p-55, --0x1p-6, -0x1.b78b80c84e1eep-9, --0x1.fff62169b92dbp-1, --0x1.5dda3c81fbd0dp-55, --0x1p-6, --0x1.6cb587284b817p-10, --0x1.fffa72c978c4fp-1, -0x1.22cb000328f91p-55, --0x1p-7, -0x1.b783c0663fe3cp-10, --0x1.fffd8858e8a92p-1, --0x1.359c71883bcf7p-55, --0x1p-7, -0x1.b781d04cd6d17p-11, --0x1.ffff621621d02p-1, -0x1.6acfcebc82813p-56, --0x1p-8, -0, --0x1p0, -0, -0, --0x1.b781d04cd6d17p-11, --0x1.ffff621621d02p-1, -0x1.6acfcebc82813p-56, -0x1p-8, --0x1.b783c0663fe3cp-10, --0x1.fffd8858e8a92p-1, --0x1.359c71883bcf7p-55, -0x1p-7, -0x1.6cb587284b817p-10, --0x1.fffa72c978c4fp-1, -0x1.22cb000328f91p-55, -0x1p-7, --0x1.b78b80c84e1eep-9, --0x1.fff62169b92dbp-1, --0x1.5dda3c81fbd0dp-55, -0x1p-6, --0x1.2bad2a8cd06bp-12, --0x1.fff0943c53bd1p-1, -0x1.47399f361d158p-55, -0x1p-6, -0x1.6c9b5df1877eap-9, --0x1.ffe9cb44b51a1p-1, --0x1.5b43366df667p-56, -0x1p-6, -0x1.7f53487eac897p-8, --0x1.ffe1c6870cb77p-1, --0x1.89aa14768323ep-55, -0x1p-6, --0x1.b7aa821726608p-8, --0x1.ffd886084cd0dp-1, -0x1.1354d4556e4cbp-55, -0x1p-5, --0x1.dd58598d6271cp-9, --0x1.ffce09ce2a679p-1, -0x1.7bd62ab5ee228p-55, -0x1p-5, --0x1.2d919c5c61fep-11, --0x1.ffc251df1d3f8p-1, --0x1.7a7d209f32d43p-56, -0x1p-5, -0x1.4685db42c17ebp-9, --0x1.ffb55e425fdaep-1, --0x1.6da7ec781c225p-55, -0x1p-5, -0x1.6c32baca2ae69p-8, --0x1.ffa72effef75dp-1, -0x1.8b4cdcdb25956p-55, -0x1p-5, -0x1.1a8e5bfe185e4p-7, --0x1.ff97c4208c014p-1, --0x1.52ab2b947e843p-57, -0x1p-5, -0x1.7f0034a43350ep-7, --0x1.ff871dadb81dfp-1, --0x1.8b1c676208aa4p-56, -0x1p-5, --0x1.0e48ab4f172f4p-6, --0x1.ff753bb1b9164p-1, -0x1.7c330129f56efp-56, -0x1p-4, --0x1.b82683bc89fbp-7, --0x1.ff621e3796d7ep-1, -0x1.c57bc2e24aa15p-57, -0x1p-4, --0x1.53bf90a81f3a5p-7, --0x1.ff4dc54b1bed3p-1, -0x1.c1169ccd1e92ep-55, -0x1p-4, --0x1.deb9769f940eap-8, --0x1.ff3830f8d575cp-1, -0x1.95e1e79d335f7p-56, -0x1p-4, --0x1.15fc833fb89b8p-8, --0x1.ff21614e131edp-1, -0x1.de692a167353p-55, -0x1p-4, --0x1.35230c0fbe402p-10, --0x1.ff095658e71adp-1, --0x1.01a8ce18a4b9ep-55, -0x1p-4, -0x1.ed853918c18ecp-10, --0x1.fef0102826191p-1, --0x1.3c3ea4f30addap-56, -0x1p-4, -0x1.440134d709b28p-8, --0x1.fed58ecb673c4p-1, -0x1.e6e462a7ae686p-56, -0x1p-4, -0x1.064b3a76a2264p-7, --0x1.feb9d2530410fp-1, --0x1.9d429eeda9bb9p-58, -0x1p-4, -0x1.6a9049670cfaep-7, --0x1.fe9cdad01883ap-1, --0x1.521ecd0c67e35p-57, -0x1p-4, -0x1.cecf8962d14c8p-7, --0x1.fe7ea85482d6p-1, --0x1.34b085c1828f7p-56, -0x1p-4, -0x1.19845e49c8257p-6, --0x1.fe5f3af2e394p-1, --0x1.b213f18c9cf17p-55, -0x1p-4, -0x1.4b9dd29353428p-6, --0x1.fe3e92be9d886p-1, --0x1.afeb2e264d46bp-57, -0x1p-4, -0x1.7db402a6a9063p-6, --0x1.fe1cafcbd5b09p-1, --0x1.a23e3202a884ep-57, -0x1p-4, --0x1.281c9830c9dafp-5, --0x1.fdf9922f73307p-1, --0x1.a5e0abd3a9b65p-56, -0x1p-3, --0x1.0f14f2b4549bdp-5, --0x1.fdd539ff1f456p-1, -0x1.ab13cbbec1781p-56, -0x1p-3, --0x1.ec1e3b4fb3d7ep-6, --0x1.fdafa7514538cp-1, --0x1.d97c45ca4d398p-59, -0x1p-3, --0x1.ba1650f592f5p-6, --0x1.fd88da3d12526p-1, -0x1.87df6378811c7p-55, -0x1p-3, --0x1.88124536d5e8fp-6, --0x1.fd60d2da75c9ep-1, --0x1.36dedb314f0ebp-58, -0x1p-3, --0x1.561236eda8ff2p-6, --0x1.fd37914220b84p-1, --0x1.52e9d7b772791p-55, -0x1p-3, --0x1.241644f1c26cep-6, --0x1.fd0d158d86087p-1, --0x1.9705a7b864883p-55, -0x1p-3, --0x1.e43d1c309e958p-7, --0x1.fce15fd6da67bp-1, -0x1.5dd6f830d4c09p-56, -0x1p-3, --0x1.80566267c11f6p-7, --0x1.fcb4703914354p-1, --0x1.126aa7d51b25cp-55, -0x1p-3, --0x1.1c789a28b01b7p-7, --0x1.fc8646cfeb721p-1, --0x1.3143dc43a9b9dp-55, -0x1p-3, --0x1.7148021b55c15p-8, --0x1.fc56e3b7d9af6p-1, -0x1.03ff7a673d3bdp-56, -0x1p-3, --0x1.536352ad19e39p-9, --0x1.fc26470e19fd3p-1, --0x1.1ec8668ecaceep-55, -0x1p-3, -0x1.dd15adf70b65ap-12, --0x1.fbf470f0a8d88p-1, -0x1.6bb200d1d70b7p-55, -0x1p-3, -0x1.ca811eea0c749p-9, --0x1.fbc1617e44186p-1, -0x1.58ec496dc4ecbp-59, -0x1p-3, -0x1.ac9b7964cf0bap-8, --0x1.fb8d18d66adb7p-1, -0x1.d0b66224cce2ep-56, -0x1p-3, -0x1.39f0cedaf576bp-7, --0x1.fb5797195d741p-1, --0x1.1bfac7397cc08p-56, -0x1p-3, -0x1.9d8940be24e74p-7, --0x1.fb20dc681d54dp-1, -0x1.ff148ec7c5fafp-55, -0x1p-3, -0x1.008b6a763de76p-6, --0x1.fae8e8e46cfbbp-1, -0x1.3a9e414732d97p-56, -0x1p-3, -0x1.324ca6fe9a04bp-6, --0x1.faafbcb0cfddcp-1, -0x1.e349cb4d3e866p-55, -0x1p-3, -0x1.64083747309d1p-6, --0x1.fa7557f08a517p-1, -0x1.7a0a8ca13571fp-55, -0x1p-3, -0x1.95bdfca28b53ap-6, --0x1.fa39bac7a1791p-1, -0x1.94f388f1b4e1ep-57, -0x1p-3, -0x1.c76dd866c689ep-6, --0x1.f9fce55adb2c8p-1, --0x1.f2a06fab9f9d1p-56, -0x1p-3, -0x1.f917abeda4499p-6, --0x1.f9bed7cfbde29p-1, -0x1.b35b1f9bcf70bp-56, -0x1p-3, -0x1.155dac4a4f967p-5, --0x1.f97f924c9099bp-1, -0x1.e2ae0eea5963bp-55, -0x1p-3, -0x1.2e2c5fde7ea22p-5, --0x1.f93f14f85ac08p-1, -0x1.cfd153e9a9c1ap-55, -0x1p-3, -0x1.46f7e165f17c8p-5, --0x1.f8fd5ffae41dbp-1, -0x1.8cfd77fd970d2p-56, -0x1p-3, -0x1.5fc0219532f79p-5, --0x1.f8ba737cb4b78p-1, -0x1.da71f96d5a49cp-55, -0x1p-3, -0x1.78851122cff19p-5, --0x1.f8764fa714ba9p-1, --0x1.ab256778ffcb6p-56, -0x1p-3, -0x1.9146a0c760c35p-5, --0x1.f830f4a40c60cp-1, --0x1.8528676925128p-57, -0x1p-3, --0x1.2afd9f6136a9cp-4, --0x1.f7ea629e63d6ep-1, --0x1.ba92d57ebfeddp-55, -0x1p-2, --0x1.1ea04e5ee7601p-4, --0x1.f7a299c1a322ap-1, --0x1.6e7190c94899ep-56, -0x1p-2, --0x1.1244c435e819dp-4, --0x1.f7599a3a12077p-1, --0x1.84f31d743195cp-55, -0x1p-2, --0x1.05eb0885a69c9p-4, --0x1.f70f6434b7eb7p-1, --0x1.1775df66f0ec4p-56, -0x1p-2, --0x1.f32645d8e6ce9p-5, --0x1.f6c3f7df5bbb7p-1, --0x1.8561ce9d5ef5bp-56, -0x1p-2, --0x1.da7a360ef9fefp-5, --0x1.f677556883ceep-1, --0x1.ef696a8d070f4p-57, -0x1p-2, --0x1.c1d1f0e5967d5p-5, --0x1.f6297cff75cbp-1, --0x1.562172a361fd3p-56, -0x1p-2, --0x1.a92d859275418p-5, --0x1.f5da6ed43685dp-1, -0x1.536fc33bf9dd8p-55, -0x1p-2, --0x1.908d0348ef266p-5, --0x1.f58a2b1789e84p-1, --0x1.1f4a188aa368p-56, -0x1p-2, --0x1.77f07939f3897p-5, --0x1.f538b1faf2d07p-1, -0x1.5f7cd5099519cp-59, -0x1p-2, --0x1.5f57f693feebep-5, --0x1.f4e603b0b2f2dp-1, -0x1.8ee01e695ac05p-56, -0x1p-2, --0x1.46c38a8311952p-5, --0x1.f492206bcabb4p-1, --0x1.d1e921bbe3bd3p-55, -0x1p-2, --0x1.2e334430a6376p-5, --0x1.f43d085ff92ddp-1, -0x1.8fde71e361c05p-55, -0x1p-2, --0x1.15a732c3a894dp-5, --0x1.f3e6bbc1bbc65p-1, --0x1.5774bb7e8a21ep-57, -0x1p-2, --0x1.fa3ecac0d84e8p-6, --0x1.f38f3ac64e589p-1, -0x1.d7bafb51f72e6p-56, -0x1p-2, --0x1.c937d65145919p-6, --0x1.f33685a3aaefp-1, --0x1.eb78685d850f8p-56, -0x1p-2, --0x1.9839a676a6bcfp-6, --0x1.f2dc9c9089a9dp-1, --0x1.5407460bdfc07p-59, -0x1p-2, --0x1.67445969a108ep-6, --0x1.f2817fc4609cep-1, -0x1.dd1f8eaf65689p-55, -0x1p-2, --0x1.36580d5d5e775p-6, --0x1.f2252f7763adap-1, -0x1.20cb81c8d94abp-55, -0x1p-2, --0x1.0574e07f7b332p-6, --0x1.f1c7abe284708p-1, --0x1.504b80c8a63fcp-55, -0x1p-2, --0x1.a935e1efe5e4bp-7, --0x1.f168f53f7205dp-1, -0x1.26a6c1f015601p-57, -0x1p-2, --0x1.4794b9d21cb87p-7, --0x1.f1090bc898f5fp-1, -0x1.baa64ab102a93p-55, -0x1p-2, --0x1.cc0d09bd41caap-8, --0x1.f0a7efb9230d7p-1, --0x1.52c7adc6b4989p-56, -0x1p-2, --0x1.0916fe858ffcdp-8, --0x1.f045a14cf738cp-1, -0x1.a52c44f45216cp-55, -0x1p-2, --0x1.191f2900903a6p-10, --0x1.efe220c0b95ecp-1, --0x1.c853b7bf7e0cdp-55, -0x1p-2, -0x1.f1806b9fdd1afp-10, --0x1.ef7d6e51ca3cp-1, -0x1.a3c67c3d3f604p-55, -0x1p-2, -0x1.3ee038dff6b8p-8, --0x1.ef178a3e473c2p-1, --0x1.6310a67fe774fp-55, -0x1p-2, -0x1.009c0bd6cc3cbp-7, --0x1.eeb074c50a544p-1, --0x1.d925f656c43b4p-55, -0x1p-2, -0x1.61b39fb7b7202p-7, --0x1.ee482e25a9dbcp-1, -0x1.b6066ef81af2ap-56, -0x1p-2, -0x1.c2b69c2e939b5p-7, --0x1.eddeb6a078651p-1, -0x1.3b579af740a74p-55, -0x1p-2, -0x1.11d262b1f6776p-6, --0x1.ed740e7684963p-1, --0x1.e82c791f59cc2p-56, -0x1p-2, -0x1.423eefc693785p-6, --0x1.ed0835e999009p-1, --0x1.499d188aa32fap-57, -0x1p-2, -0x1.72a0d77651772p-6, --0x1.ec9b2d3c3bf84p-1, --0x1.19119d358de05p-56, -0x1p-2, -0x1.a2f7fbe8f2436p-6, --0x1.ec2cf4b1af6b2p-1, --0x1.34ee3f2caa62dp-59, -0x1p-2, -0x1.d3443f4cdb3ddp-6, --0x1.ebbd8c8df0b74p-1, --0x1.c6c8c615e7277p-56, -0x1p-2, -0x1.01c2c1eb93deep-5, --0x1.eb4cf515b8811p-1, --0x1.95da1ba97ec5ep-57, -0x1p-2, -0x1.19ddd5e1ddb8bp-5, --0x1.eadb2e8e7a88ep-1, -0x1.92ec52ea226a3p-55, -0x1p-2, -0x1.31f34caaaa5d2p-5, --0x1.ea68393e658p-1, -0x1.467259bb7b556p-56, -0x1p-2, -0x1.4a03176acf82dp-5, --0x1.e9f4156c62ddap-1, --0x1.760b1e2e3f81ep-55, -0x1p-2, -0x1.620d274aa2903p-5, --0x1.e97ec36016b3p-1, --0x1.5bc48562557d3p-55, -0x1p-2, -0x1.7a116d7601c35p-5, --0x1.e9084361df7f2p-1, --0x1.cdfc7ce9dc3e9p-55, -0x1p-2, -0x1.920fdb1c5d578p-5, --0x1.e89095bad6025p-1, -0x1.5a4cc0fcbccap-55, -0x1p-2, -0x1.aa086170c0a8ep-5, --0x1.e817bab4cd10dp-1, -0x1.d0afe686b5e0ap-56, -0x1p-2, -0x1.c1faf1a9db555p-5, --0x1.e79db29a5165ap-1, -0x1.75e710aca58p-56, -0x1p-2, -0x1.d9e77d020a5bcp-5, --0x1.e7227db6a9744p-1, --0x1.2128794da5a5p-55, -0x1p-2, -0x1.f1cdf4b76138bp-5, --0x1.e6a61c55d53a7p-1, --0x1.660d981acdcf7p-56, -0x1p-2, -0x1.04d72505d9805p-4, --0x1.e6288ec48e112p-1, -0x1.16b56f2847754p-57, -0x1p-2, -0x1.10c437224dbc2p-4, --0x1.e5a9d550467d3p-1, --0x1.7d431be53f92fp-56, -0x1p-2, -0x1.1cae2955c414fp-4, --0x1.e529f04729ffcp-1, --0x1.9075d6e6dfc8bp-55, -0x1p-2, -0x1.2894f446e0bccp-4, --0x1.e4a8dff81ce5ep-1, --0x1.43578776c0f46p-55, -0x1p-2, -0x1.3478909e39da9p-4, --0x1.e426a4b2bc17ep-1, --0x1.a873889744882p-55, -0x1p-2, -0x1.4058f7065c11ep-4, --0x1.e3a33ec75ce85p-1, --0x1.45089cd46bbb8p-57, -0x1p-2, -0x1.4c36202bcf08ep-4, --0x1.e31eae870ce25p-1, -0x1.bc7094538d678p-56, -0x1p-2, -0x1.581004bd19ed2p-4, --0x1.e298f4439197ap-1, --0x1.e84e601038eb2p-57, -0x1p-2, -0x1.63e69d6ac7f74p-4, --0x1.e212104f686e5p-1, -0x1.014c76c126527p-55, -0x1p-2, -0x1.6fb9e2e76ced8p-4, --0x1.e18a02fdc66d9p-1, --0x1.07e272abd88cfp-55, -0x1p-2, -0x1.7b89cde7a9a4dp-4, --0x1.e100cca2980acp-1, -0x1.02d182acdf825p-57, -0x1p-2, -0x1.875657223080ap-4, --0x1.e0766d9280f54p-1, --0x1.f44c969cf62e3p-55, -0x1p-2, -0x1.931f774fc9f18p-4, --0x1.dfeae622dbe2bp-1, -0x1.514ea88425567p-55, -0x1p-2, -0x1.9ee5272b58f2ap-4, --0x1.df5e36a9ba59cp-1, -0x1.e01f8bceb43d3p-57, -0x1p-2, --0x1.2aac5047103d3p-3, --0x1.ded05f7de47dap-1, -0x1.2cc4c1f8ba966p-55, -0x1p-1, --0x1.24ccf38ebe694p-3, --0x1.de4160f6d8d81p-1, --0x1.9bf11cc5f8776p-55, -0x1p-1, --0x1.1eef59e0b74c3p-3, --0x1.ddb13b6ccc23cp-1, --0x1.83c37c6107db3p-55, -0x1p-1, --0x1.191386db3dedcp-3, --0x1.dd1fef38a915ap-1, -0x1.782f169e17f3bp-55, -0x1p-1, --0x1.13397e1b7ce13p-3, --0x1.dc8d7cb41026p-1, --0x1.6b7872773830dp-56, -0x1p-1, --0x1.0d61433d840a4p-3, --0x1.dbf9e4395759ap-1, --0x1.d8ff7350f75fdp-55, -0x1p-1, --0x1.078ad9dc46632p-3, --0x1.db6526238a09bp-1, -0x1.adee7eae6946p-56, -0x1p-1, --0x1.01b6459197c38p-3, --0x1.dacf42ce68ab9p-1, -0x1.fe8d76efdf896p-56, -0x1p-1, --0x1.f7c713ec554fp-4, --0x1.da383a9668988p-1, -0x1.5811000b39d84p-55, -0x1p-1, --0x1.ec2555431bf03p-4, --0x1.d9a00dd8b3d46p-1, --0x1.bea0e4bac8e16p-58, -0x1p-1, --0x1.e087565455a75p-4, --0x1.d906bcf328d46p-1, --0x1.457e610231ac2p-56, -0x1p-1, --0x1.d4ed1e4a84aefp-4, --0x1.d86c48445a44fp-1, --0x1.e8813c023d71fp-55, -0x1p-1, --0x1.c956b44dd6d41p-4, --0x1.d7d0b02b8ecf9p-1, --0x1.800f4ce65cd6ep-55, -0x1p-1, --0x1.bdc41f84210bbp-4, --0x1.d733f508c0dffp-1, -0x1.007928e770cd5p-55, -0x1p-1, --0x1.b2356710db0a3p-4, --0x1.d696173c9e68bp-1, -0x1.e8c61c6393d55p-56, -0x1p-1, --0x1.a6aa92151adc3p-4, --0x1.d5f7172888a7fp-1, -0x1.68663e2225755p-55, -0x1p-1, --0x1.9b23a7af90805p-4, --0x1.d556f52e93eb1p-1, -0x1.80ed9233a963p-55, -0x1p-1, --0x1.8fa0aefc81837p-4, --0x1.d4b5b1b187524p-1, -0x1.f56be6b42b76dp-57, -0x1p-1, --0x1.8421af15c49d7p-4, --0x1.d4134d14dc93ap-1, -0x1.4ef5295d25af2p-55, -0x1p-1, --0x1.78a6af12bd501p-4, --0x1.d36fc7bcbfbdcp-1, -0x1.ba196d95a177dp-55, -0x1p-1, --0x1.6d2fb6085786ep-4, --0x1.d2cb220e0ef9fp-1, -0x1.f07656d4e6652p-56, -0x1p-1, --0x1.61bccb0903395p-4, --0x1.d2255c6e5a4e1p-1, -0x1.d129a71ecafc9p-55, -0x1p-1, --0x1.564df524b00dap-4, --0x1.d17e7743e35dcp-1, -0x1.101da3540130ap-58, -0x1p-1, --0x1.4ae33b68c8fdcp-4, --0x1.d0d672f59d2b9p-1, -0x1.c83009f0c39dep-55, -0x1p-1, --0x1.3f7ca4e02ffdcp-4, --0x1.d02d4feb2bd92p-1, --0x1.195ff41bc55fep-55, -0x1p-1, --0x1.341a389339a36p-4, --0x1.cf830e8ce467bp-1, -0x1.7b9202780d49dp-55, -0x1p-1, --0x1.28bbfd87a8cffp-4, --0x1.ced7af43cc773p-1, -0x1.e7b6bb5ab58aep-58, -0x1p-1, --0x1.1d61fac0aa5b2p-4, --0x1.ce2b32799a06p-1, -0x1.631d457e46317p-56, -0x1p-1, --0x1.120c373ed0bfbp-4, --0x1.cd7d9898b32f6p-1, -0x1.f2fa062496738p-57, -0x1p-1, --0x1.06baba000fc9bp-4, --0x1.cccee20c2deap-1, -0x1.d3116ae0e69e4p-55, -0x1p-1, --0x1.f6db13ff708cbp-5, --0x1.cc1f0f3fcfc5cp-1, --0x1.e57613b68f6abp-56, -0x1p-1, --0x1.e0495c6ce76b5p-5, --0x1.cb6e20a00da99p-1, -0x1.4fb24b5194c1bp-55, -0x1p-1, --0x1.c9c05b347ffabp-5, --0x1.cabc169a0b9p-1, --0x1.c42d3e10851d1p-55, -0x1p-1, --0x1.b3401e3cd63bbp-5, --0x1.ca08f19b9c449p-1, -0x1.431e0a5a737fdp-56, -0x1p-1, --0x1.9cc8b3671dd0fp-5, --0x1.c954b213411f5p-1, -0x1.2fb761e946603p-58, -0x1p-1, --0x1.865a288f196fap-5, --0x1.c89f587029c13p-1, --0x1.588358ed6e78fp-58, -0x1p-1, --0x1.6ff48b8b1252ap-5, --0x1.c7e8e52233cf3p-1, --0x1.b2ad324aa35c1p-57, -0x1p-1, --0x1.5997ea2bcfb19p-5, --0x1.c7315899eaad7p-1, -0x1.9be5dcd047da7p-57, -0x1p-1, --0x1.4344523c8e3b5p-5, --0x1.c678b3488739bp-1, --0x1.d86cac7c5ff5bp-57, -0x1p-1, --0x1.2cf9d182f7939p-5, --0x1.c5bef59fef85ap-1, -0x1.f0a406c8b7468p-58, -0x1p-1, --0x1.16b875bf19d4p-5, --0x1.c5042012b6907p-1, -0x1.5c058dd8eaba5p-57, -0x1p-1, --0x1.00804cab5f113p-5, --0x1.c44833141c004p-1, --0x1.23e0521df01a2p-56, -0x1p-1, --0x1.d4a2c7f909c4ep-6, --0x1.c38b2f180bdb1p-1, -0x1.6e0b1757c8d07p-56, -0x1p-1, --0x1.a85792c327db2p-6, --0x1.c2cd14931e3f1p-1, --0x1.2ce2f9d4600f5p-56, -0x1p-1, --0x1.7c1f1507aeec3p-6, --0x1.c20de3fa971bp-1, -0x1.b4ca2bab1322cp-55, -0x1p-1, --0x1.4ff96a0da9dfbp-6, --0x1.c14d9dc465e57p-1, --0x1.ce36b64c7f3ccp-55, -0x1p-1, --0x1.23e6ad10872a7p-6, --0x1.c08c426725549p-1, --0x1.b157fd80e2946p-58, -0x1p-1, --0x1.efcdf2801004ap-7, --0x1.bfc9d25a1b147p-1, -0x1.51bf4ee01357p-61, -0x1p-1, --0x1.97f4d3805f318p-7, --0x1.bf064e15377ddp-1, --0x1.2156026a1e028p-57, -0x1p-1, --0x1.4042335264ba3p-7, --0x1.be41b611154c1p-1, -0x1.fdcdad3a6877ep-55, -0x1p-1, --0x1.d16c901d95181p-8, --0x1.bd7c0ac6f952ap-1, -0x1.825a732ac700ap-55, -0x1p-1, --0x1.22a28f6cb488bp-8, --0x1.bcb54cb0d2327p-1, --0x1.410923c55523ep-62, -0x1p-1, --0x1.d09b418edf04ap-10, --0x1.bbed7c49380eap-1, --0x1.beacbd88500b4p-59, -0x1p-1, -0x1.d0320ae0b8293p-11, --0x1.bb249a0b6c40dp-1, -0x1.d6318ee919f7ap-58, -0x1p-1, -0x1.cfc874c3eb6d9p-9, --0x1.ba5aa673590d2p-1, --0x1.7ea4e370753b6p-55, -0x1p-1, -0x1.9572af6decac8p-8, --0x1.b98fa1fd9155ep-1, --0x1.5559034fe85a4p-55, -0x1p-1, -0x1.21589ab88869cp-7, --0x1.b8c38d27504e9p-1, -0x1.1529abff40e45p-55, -0x1p-1, -0x1.77cfb0c6e2db8p-7, --0x1.b7f6686e792e9p-1, --0x1.87665bfea06aap-55, -0x1p-1, -0x1.ce1e648bffb66p-7, --0x1.b728345196e3ep-1, -0x1.bc69f324e6d61p-55, -0x1p-1, -0x1.1222406561182p-6, --0x1.b658f14fdbc47p-1, --0x1.52b5308f397dep-57, -0x1p-1, -0x1.3d20e82f8bc1p-6, --0x1.b5889fe921405p-1, -0x1.df49b307c8602p-57, -0x1p-1, -0x1.680b0f1f0bd73p-6, --0x1.b4b7409de7925p-1, --0x1.f4e257bde73d8p-56, -0x1p-1, -0x1.92e09abb131d4p-6, --0x1.b3e4d3ef55712p-1, -0x1.eb6b8bf11a493p-55, -0x1p-1, -0x1.bda17097896b4p-6, --0x1.b3115a5f37bf3p-1, --0x1.dde2726e34fe1p-55, -0x1p-1, -0x1.e84d76551cfb2p-6, --0x1.b23cd470013b4p-1, --0x1.5a1bb35ad6d2ep-56, -0x1p-1, -0x1.097248d0a956ap-5, --0x1.b16742a4ca2f5p-1, -0x1.ba70972b80438p-55, -0x1p-1, -0x1.1eb3541b4b228p-5, --0x1.b090a581502p-1, -0x1.926da300ffccep-55, -0x1p-1, -0x1.33e9cfee254edp-5, --0x1.afb8fd89f57b6p-1, --0x1.1ced12d2899b8p-60, -0x1p-1, -0x1.4915af336ceb4p-5, --0x1.aee04b43c1474p-1, -0x1.3a79a438bf8ccp-55, -0x1p-1, -0x1.5e36e4dbe2bc2p-5, --0x1.ae068f345ecefp-1, -0x1.33934c4029a4cp-56, -0x1p-1, -0x1.734d63dedb48ap-5, --0x1.ad2bc9e21d511p-1, -0x1.47fbe07bea548p-55, -0x1p-1, -0x1.88591f3a46e4dp-5, --0x1.ac4ffbd3efac8p-1, -0x1.818504103fa16p-56, -0x1p-1, -0x1.9d5a09f2b9b7fp-5, --0x1.ab7325916c0d4p-1, --0x1.a8b8c85baaa9bp-55, -0x1p-1, -0x1.b250171373be9p-5, --0x1.aa9547a2cb98ep-1, --0x1.87d00ae97abaap-60, -0x1p-1, -0x1.c73b39ae68c87p-5, --0x1.a9b66290ea1a3p-1, --0x1.9f630e8b6dac8p-60, -0x1p-1, -0x1.dc1b64dc48722p-5, --0x1.a8d676e545ad2p-1, -0x1.b11dcce2e74bdp-59, -0x1p-1, -0x1.f0f08bbc861afp-5, --0x1.a7f58529fe69dp-1, -0x1.97a441584a179p-55, -0x1p-1, -0x1.02dd50bab06b2p-4, --0x1.a7138de9d60f5p-1, -0x1.f1ab82a9c5f2dp-55, -0x1p-1, -0x1.0d3ccc99f5ac6p-4, --0x1.a63091b02fae2p-1, -0x1.e911152248d1p-56, -0x1p-1, -0x1.1796b31609f0cp-4, --0x1.a54c91090f523p-1, --0x1.184300fd1c1cep-56, -0x1p-1, -0x1.21eafdcc560fap-4, --0x1.a4678c8119ac8p-1, --0x1.1b4c0dd3f212ap-55, -0x1p-1, -0x1.2c39a65db8881p-4, --0x1.a38184a593bc6p-1, -0x1.bc92c5bd2d288p-55, -0x1p-1, -0x1.3682a66e896f5p-4, --0x1.a29a7a0462782p-1, -0x1.128bb015df175p-56, -0x1p-1, -0x1.40c5f7a69e5cep-4, --0x1.a1b26d2c0a75ep-1, --0x1.30ef431d627a6p-57, -0x1p-1, -0x1.4b0393b14e541p-4, --0x1.a0c95eabaf937p-1, -0x1.e0ca3acbd049ap-55, -0x1p-1, -0x1.553b743d75acp-4, --0x1.9fdf4f13149dep-1, --0x1.1e6d79006ec09p-55, -0x1p-1, -0x1.5f6d92fd79f5p-4, --0x1.9ef43ef29af94p-1, --0x1.b1dfcb60445c2p-56, -0x1p-1, -0x1.6999e9a74ddbep-4, --0x1.9e082edb42472p-1, --0x1.5809a4e121e22p-57, -0x1p-1, -0x1.73c071f4750b5p-4, --0x1.9d1b1f5ea80d5p-1, --0x1.c5fadd5ffb36fp-55, -0x1p-1, -0x1.7de125a2080a9p-4, --0x1.9c2d110f075c2p-1, --0x1.d9c9f1c8c30dp-55, -0x1p-1, -0x1.87fbfe70b81a7p-4, --0x1.9b3e047f38741p-1, -0x1.30ee286712474p-55, -0x1p-1, -0x1.9210f624d30fbp-4, --0x1.9a4dfa42b06b2p-1, -0x1.829b6b8b1c947p-56, -0x1p-1, -0x1.9c200686472b5p-4, --0x1.995cf2ed80d22p-1, --0x1.7783e907fbd7bp-56, -0x1p-1, -0x1.a6292960a6f0bp-4, --0x1.986aef1457594p-1, -0x1.af03e318f38fcp-55, -0x1p-1, -0x1.b02c58832cf96p-4, --0x1.9777ef4c7d742p-1, -0x1.15479a240665ep-55, -0x1p-1, -0x1.ba298dc0bfc6bp-4, --0x1.9683f42bd7fe1p-1, -0x1.11bad933c835ep-57, -0x1p-1, -0x1.c420c2eff590ep-4, --0x1.958efe48e6dd7p-1, -0x1.561335da0f4e7p-55, -0x1p-1, -0x1.ce11f1eb18148p-4, --0x1.94990e3ac4a6cp-1, --0x1.a95328edeb3e6p-56, -0x1p-1, -0x1.d7fd1490285cap-4, --0x1.93a22499263fbp-1, --0x1.3d419a920df0bp-55, -0x1p-1, -0x1.e1e224c0e28bdp-4, --0x1.92aa41fc5a815p-1, -0x1.68f89e2d23db7p-57, -0x1p-1, -0x1.ebc11c62c1a1ep-4, --0x1.91b166fd49da2p-1, -0x1.3be953a7fe996p-57, -0x1p-1, -0x1.f599f55f034p-4, --0x1.90b7943575efep-1, --0x1.4ecb0c5273706p-57, -0x1p-1, -0x1.ff6ca9a2ab6a2p-4, --0x1.8fbcca3ef940dp-1, -0x1.6dfa99c86f2f1p-57, -0x1p-1, -0x1.049c998f44231p-3, --0x1.8ec109b486c49p-1, -0x1.cb2a3eb6af617p-56, -0x1p-1, -0x1.097fc5e39aec5p-3, --0x1.8dc45331698ccp-1, --0x1.1d9fcd83634d7p-57, -0x1p-1, -0x1.0e5fd6ca90dffp-3, --0x1.8cc6a75184655p-1, -0x1.e18b3657e2285p-55, -0x1p-1, -0x1.133cc94247758p-3, --0x1.8bc806b151741p-1, -0x1.2c5e12ed1336dp-55, -0x1p-1, -0x1.18169a4acca89p-3, --0x1.8ac871ede1d88p-1, -0x1.9afaa5b7cfc55p-55, -0x1p-1, -0x1.1ced46e61cd1cp-3, --0x1.89c7e9a4dd4aap-1, --0x1.db6ea04a8678fp-55, -0x1p-1, -0x1.21c0cc18247fcp-3, --0x1.88c66e7481ba1p-1, -0x1.5c6228970cf35p-56, -0x1p-1, -0x1.269126e6c24e3p-3, --0x1.87c400fba2ebfp-1, -0x1.2dabc0c3f64cdp-55, -0x1p-1, -0x1.2b5e5459c8bc3p-3, --0x1.86c0a1d9aa195p-1, --0x1.84564f09c3726p-59, -0x1p-1, -0x1.3028517b0001p-3, --0x1.85bc51ae958ccp-1, --0x1.45ba6478086ccp-55, -0x1p-1, -0x1.34ef1b5627dfdp-3, --0x1.84b7111af83fap-1, -0x1.63a47df0b21bap-55, -0x1p-1, -0x1.39b2aef8f97a4p-3, --0x1.83b0e0bff976ep-1, -0x1.6f420f8ea3475p-56, -0x1p-1, -0x1.3e73097329219p-3, --0x1.82a9c13f545ffp-1, -0x1.65e87a7a8cde9p-56, -0x1p-1, -0x1.433027d66826dp-3, --0x1.81a1b33b57accp-1, -0x1.5dea12d66bb66p-55, -0x1p-1, -0x1.47ea073666a98p-3, --0x1.8098b756e52fap-1, --0x1.9136e834b4707p-55, -0x1p-1, -0x1.4ca0a4a8d5657p-3, --0x1.7f8ece3571771p-1, -0x1.9c8d8ce93c917p-55, -0x1p-1, -0x1.5153fd45677efp-3, --0x1.7e83f87b03686p-1, --0x1.b61a8ccabad6p-57, -0x1p-1, -0x1.56040e25d44ddp-3, --0x1.7d7836cc33db2p-1, --0x1.162715ef03f85p-56, -0x1p-1, -0x1.5ab0d465d927ap-3, --0x1.7c6b89ce2d333p-1, -0x1.cfd628084982cp-56, -0x1p-1, -0x1.5f5a4d233b27fp-3, --0x1.7b5df226aafafp-1, -0x1.0f537acdf0ad7p-56, -0x1p-1, -0x1.6400757dc8f7dp-3, --0x1.7a4f707bf97d2p-1, --0x1.3c9751b491eafp-55, -0x1p-1, -0x1.68a34a975c941p-3, --0x1.79400574f55e5p-1, -0x1.0adadbdb4c65ap-55, -0x1p-1, -0x1.6d42c993dd121p-3, --0x1.782fb1b90b35bp-1, -0x1.3e46c1dfd001cp-55, -0x1p-1, -0x1.71deef9940631p-3, --0x1.771e75f037261p-1, --0x1.5cfce8d84068fp-56, -0x1p-1, -0x1.7677b9cf8d17p-3, --0x1.760c52c304764p-1, -0x1.11d76f8e50f1fp-55, -0x1p-1, -0x1.7b0d2560dc1d1p-3, --0x1.74f948da8d28dp-1, --0x1.19900a3b9a3a2p-63, -0x1p-1, -0x1.7f9f2f795a83ep-3, --0x1.73e558e079942p-1, -0x1.2663126697f5ep-55, -0x1p-1, -0x1.842dd5474b37bp-3, --0x1.72d0837efff96p-1, --0x1.0d4ef0f1d915cp-55, -0x1p-1, -0x1.88b913fb08bfdp-3, --0x1.71bac960e41bfp-1, -0x1.b858d90b0f7d8p-56, -0x1p-1, -0x1.8d40e8c706fa4p-3, --0x1.70a42b3176d7ap-1, -0x1.d9e3fbe2e15ap-56, -0x1p-1, -0x1.91c550dfd4d6bp-3, --0x1.6f8ca99c95b75p-1, --0x1.f22e7a35723f4p-56, -0x1p-1, -0x1.9646497c1e0f6p-3, --0x1.6e74454eaa8afp-1, -0x1.dbc03c84e226ep-55, -0x1p-1, -0x1.9ac3cfd4ace19p-3, --0x1.6d5afef4aafcdp-1, -0x1.868a696b8835ep-55, -0x1p-1, -0x1.9f3de1246bc4p-3, --0x1.6c40d73c18275p-1, --0x1.25d4f802be257p-57, -0x1p-1, -0x1.a3b47aa8671c5p-3, --0x1.6b25ced2fe29cp-1, -0x1.5ac64116beda5p-55, -0x1p-1, -0, --0x1.6a09e667f3bcdp-1, -0x1.bdd3413b26456p-55, -0, --0x1.29b4625a03ac9p-2, --0x1.68ed1eaa19c71p-1, --0x1.fd4a85350f69p-56, -0x1p0, --0x1.277e5187cfb16p-2, --0x1.67cf78491af1p-1, --0x1.750ab23477b61p-59, -0x1p0, --0x1.254a0216aa067p-2, --0x1.66b0f3f52b386p-1, --0x1.1e2eb31a8848bp-55, -0x1p0, --0x1.23177562aaea3p-2, --0x1.6591925f0783dp-1, --0x1.c3d64fbf5de23p-55, -0x1p0, --0x1.20e6acc6d4916p-2, --0x1.64715437f535bp-1, -0x1.7c399c15a17dp-55, -0x1p0, --0x1.1eb7a99d1250cp-2, --0x1.63503a31c1be9p-1, --0x1.1248f09e6587cp-57, -0x1p0, --0x1.1c8a6d3e37c82p-2, --0x1.622e44fec22ffp-1, --0x1.f98d8be132d57p-56, -0x1p0, --0x1.1a5ef902000d3p-2, --0x1.610b7551d2cdfp-1, -0x1.251b352ff2a37p-56, -0x1p0, --0x1.18354e3f0cd7dp-2, --0x1.5fe7cbde56a1p-1, -0x1.fcb9cc30cc01ep-55, -0x1p0, --0x1.160d6e4ae5ae6p-2, --0x1.5ec3495837074p-1, --0x1.dea89a9b8f727p-56, -0x1p0, --0x1.13e75a79f7139p-2, --0x1.5d9dee73e345cp-1, -0x1.de1165ecdf7a3p-57, -0x1p0, --0x1.11c3141f91b3ep-2, --0x1.5c77bbe65018cp-1, --0x1.069ea9c0bc32ap-55, -0x1p0, --0x1.0fa09c8de994bp-2, --0x1.5b50b264f7448p-1, --0x1.519d30d4cfebp-56, -0x1p0, --0x1.0d7ff51615437p-2, --0x1.5a28d2a5d725p-1, --0x1.57a25f8b1343p-55, -0x1p0, --0x1.0b611f080d05bp-2, --0x1.59001d5f723dfp-1, --0x1.a9f86ba0dde98p-56, -0x1p0, --0x1.09441bb2aa0a2p-2, --0x1.57d69348cecap-1, -0x1.75720992bfbb2p-55, -0x1p0, --0x1.0728ec63a599ap-2, --0x1.56ac35197649fp-1, -0x1.f7874188cb279p-55, -0x1p0, --0x1.050f92679849cp-2, --0x1.5581038975137p-1, --0x1.4570d9efe26dfp-55, -0x1p0, --0x1.02f80f09f92f4p-2, --0x1.5454ff5159dfcp-1, -0x1.4e247588bf256p-55, -0x1p0, --0x1.00e263951d11fp-2, --0x1.5328292a35596p-1, -0x1.a12eb89da0257p-56, -0x1p0, --0x1.fd9d22a46b416p-3, --0x1.51fa81cd99aa6p-1, -0x1.499f59d8560e9p-63, -0x1p0, --0x1.f9793312a14d1p-3, --0x1.50cc09f59a09bp-1, --0x1.693463a2c2e6fp-56, -0x1p0, --0x1.f558fb02ae805p-3, --0x1.4f9cc25cca486p-1, --0x1.48b5951cfc2b5p-55, -0x1p0, --0x1.f13c7d001a249p-3, --0x1.4e6cabbe3e5e9p-1, --0x1.3c293edceb327p-57, -0x1p0, --0x1.ed23bb941f019p-3, --0x1.4d3bc6d589f7fp-1, --0x1.6e4d9d6b72011p-55, -0x1p0, --0x1.e90eb945a9ccfp-3, --0x1.4c0a145ec0004p-1, --0x1.2630cfafceaa1p-58, -0x1p0, --0x1.e4fd7899579acp-3, --0x1.4ad79516722f1p-1, -0x1.1273b163000f7p-55, -0x1p0, --0x1.e0effc1174505p-3, --0x1.49a449b9b0939p-1, -0x1.27ee16d719b94p-55, -0x1p0, --0x1.dce6462df917dp-3, --0x1.48703306091ffp-1, -0x1.70813b86159fdp-57, -0x1p0, --0x1.d8e0596c8ad56p-3, --0x1.473b51b987347p-1, --0x1.ca1953514e41bp-57, -0x1p0, --0x1.d4de3848789e2p-3, --0x1.4605a692b32a2p-1, --0x1.21ca219b97107p-55, -0x1p0, --0x1.d0dfe53aba2fdp-3, --0x1.44cf325091dd6p-1, --0x1.8076a2cfdc6b3p-57, -0x1p0, --0x1.cce562b9ee6aep-3, --0x1.4397f5b2a438p-1, -0x1.7274c9e48c226p-55, -0x1p0, --0x1.c8eeb33a59cdp-3, --0x1.425ff178e6bb1p-1, --0x1.7b38d675140cap-55, -0x1p0, --0x1.c4fbd92de4eddp-3, --0x1.41272663d108cp-1, --0x1.1bbe7636fadf5p-55, -0x1p0, --0x1.c10cd7041afccp-3, --0x1.3fed9534556d4p-1, --0x1.36916608c5061p-55, -0x1p0, --0x1.bd21af2a28408p-3, --0x1.3eb33eabe068p-1, --0x1.86a2357d1a0d3p-58, -0x1p0, --0x1.b93a640ad8978p-3, --0x1.3d78238c58344p-1, -0x1.0219f5f0f79cep-55, -0x1p0, --0x1.b556f80e95facp-3, --0x1.3c3c44981c518p-1, -0x1.b5e9a9644151bp-55, -0x1p0, --0x1.b1776d9b67013p-3, --0x1.3affa292050b9p-1, --0x1.e3e25e3954964p-56, -0x1p0, --0x1.ad9bc714ed64fp-3, --0x1.39c23e3d63029p-1, -0x1.3b05b276085c1p-58, -0x1p0, --0x1.a9c406dc648a5p-3, --0x1.3884185dfeb22p-1, -0x1.a038026abe6b2p-56, -0x1p0, --0x1.a5f02f50a007cp-3, --0x1.374531b817f8dp-1, --0x1.444d2b0a747fep-55, -0x1p0, --0x1.a22042ce0a2f9p-3, --0x1.36058b10659f3p-1, -0x1.1fcb3a35857e7p-55, -0x1p0, --0x1.9e5443aea29b2p-3, --0x1.34c5252c14de1p-1, --0x1.583f49632ab2bp-55, -0x1p0, --0x1.9a8c3449fcb77p-3, --0x1.338400d0c8e57p-1, -0x1.abf2a5e95e6e5p-55, -0x1p0, --0x1.96c816f53e539p-3, --0x1.32421ec49a61fp-1, --0x1.65e25cc951bfep-55, -0x1p0, --0x1.9307ee031e2fdp-3, --0x1.30ff7fce17035p-1, -0x1.efcc626f74a6fp-57, -0x1p0, --0x1.8f4bbbc3e28f6p-3, --0x1.2fbc24b441015p-1, --0x1.dba4875410874p-57, -0x1p0, --0x1.8b9382855fcaap-3, --0x1.2e780e3e8ea17p-1, -0x1.b19fafe36587ap-55, -0x1p0, --0x1.87df4492f6e38p-3, --0x1.2d333d34e9bb8p-1, -0x1.0e2c2c5549e26p-55, -0x1p0, --0x1.842f0435941afp-3, --0x1.2bedb25faf3eap-1, -0x1.14981c796ee46p-58, -0x1p0, --0x1.8082c3b3ad887p-3, --0x1.2aa76e87aeb58p-1, --0x1.fd600833287a7p-59, -0x1p0, --0x1.7cda855141b26p-3, --0x1.2960727629ca8p-1, --0x1.56d6c7af02d5cp-56, -0x1p0, --0x1.79364b4fd6288p-3, --0x1.2818bef4d3cbap-1, -0x1.e3fffeb76568ap-56, -0x1p0, --0x1.759617ee761f9p-3, --0x1.26d054cdd12dfp-1, -0x1.5da743ef3770cp-55, -0x1p0, --0x1.71f9ed69b10eap-3, --0x1.258734cbb711p-1, --0x1.3a3f0903ce09dp-57, -0x1p0, --0x1.6e61cdfb994dfp-3, --0x1.243d5fb98ac1fp-1, --0x1.c533d0a284a8dp-56, -0x1p0, --0x1.6acdbbdbc2b73p-3, --0x1.22f2d662c13e2p-1, -0x1.d5cc7580cb6d2p-55, -0x1p0, --0x1.673db93f41479p-3, --0x1.21a799933eb59p-1, -0x1.3a7b177c68fb2p-55, -0x1p0, --0x1.63b1c858a7c2ep-3, --0x1.205baa17560d6p-1, --0x1.b7b144016c7a3p-56, -0x1p0, --0x1.6029eb580658ep-3, --0x1.1f0f08bbc861bp-1, -0x1.10d9dcafb74cbp-57, -0x1p0, --0x1.5ca6246ae94b8p-3, --0x1.1dc1b64dc4872p-1, --0x1.f15e1c468be78p-57, -0x1p0, --0x1.592675bc57974p-3, --0x1.1c73b39ae68c8p-1, --0x1.b25dd267f66p-55, -0x1p0, --0x1.55aae174d19c8p-3, --0x1.1b250171373bfp-1, -0x1.b210e95e1ca4cp-55, -0x1p0, --0x1.523369ba4fcaep-3, --0x1.19d5a09f2b9b8p-1, -0x1.33656c68a1d4ap-57, -0x1p0, --0x1.4ec010b0414e1p-3, --0x1.188591f3a46e5p-1, -0x1.bbefe5a524346p-56, -0x1p0, --0x1.4b50d8778abbdp-3, --0x1.1734d63dedb49p-1, -0x1.7eef2ccc50575p-55, -0x1p0, --0x1.47e5c32e84c45p-3, --0x1.15e36e4dbe2bcp-1, --0x1.3c545f7d79eaep-56, -0x1p0, --0x1.447ed2f0fae31p-3, --0x1.14915af336cebp-1, --0x1.f3660558a0213p-56, -0x1p0, --0x1.411c09d82a128p-3, --0x1.133e9cfee254fp-1, -0x1.a1377cfd5ce5p-56, -0x1p0, --0x1.3dbd69fabf802p-3, --0x1.11eb3541b4b23p-1, -0x1.ef23b69abe4f1p-55, -0x1p0, --0x1.3a62f56cd742ep-3, --0x1.1097248d0a957p-1, -0x1.7a58759ba80ddp-55, -0x1p0, --0x1.370cae3ffb12fp-3, --0x1.0f426bb2a8e7ep-1, -0x1.bb58fb774f8eep-55, -0x1p0, --0x1.33ba968321032p-3, --0x1.0ded0b84bc4b6p-1, -0x1.8540fa327c55cp-55, -0x1p0, --0x1.306cb042aa3bap-3, --0x1.0c9704d5d898fp-1, -0x1.8d3d7de6ee9b2p-55, -0x1p0, --0x1.2d22fd8861b6bp-3, --0x1.0b405878f85ecp-1, -0x1.ad66c3bb80da5p-55, -0x1p0, --0x1.29dd805b7afecp-3, --0x1.09e907417c5e1p-1, -0x1.fe573741a9bd4p-55, -0x1p0, --0x1.269c3ac090ee4p-3, --0x1.089112032b08cp-1, --0x1.3248ddf9fe619p-57, -0x1p0, --0x1.235f2eb9a470ap-3, --0x1.073879922ffeep-1, -0x1.a5a014347406cp-55, -0x1p0, --0x1.20265e461b45ap-3, --0x1.05df3ec31b8b7p-1, -0x1.e2dcad34d9c1dp-57, -0x1p0, --0x1.1cf1cb62bec5dp-3, --0x1.0485626ae221ap-1, --0x1.b937d9091ff7p-55, -0x1p0, --0x1.19c17809baa87p-3, --0x1.032ae55edbd96p-1, -0x1.bdb022b40107ap-55, -0x1p0, --0x1.169566329bcb7p-3, --0x1.01cfc874c3eb7p-1, -0x1.34a35e7c2368cp-56, -0x1p0, --0x1.136d97d24efccp-3, --0x1.00740c82b82e1p-1, -0x1.6d48563c60e87p-55, -0x1p0, --0x1.104a0edb1fc58p-3, --0x1.fe2f64be7121p-2, -0x1.297ab1ca2d7dbp-56, -0x1p0, --0x1.0d2acd3cb7364p-3, --0x1.fb7575c24d2dep-2, -0x1.5bfdc883c8664p-57, -0x1p0, --0x1.0a0fd4e41ab5ap-3, --0x1.f8ba4dbf89abap-2, -0x1.2ec1fc1b776b8p-60, -0x1p0, --0x1.06f927bbaacfep-3, --0x1.f5fdee656cda3p-2, -0x1.7bf9780816b05p-58, -0x1p0, --0x1.03e6c7ab2208cp-3, --0x1.f3405963fd067p-2, --0x1.06846d44a238fp-56, -0x1p0, --0x1.00d8b69793ae4p-3, --0x1.f081906bff7fep-2, -0x1.4cab2d4ff6fccp-56, -0x1p0, --0x1.fb9decc6d55b8p-4, --0x1.edc1952ef78d6p-2, -0x1.dd0f7c33edee6p-56, -0x1p0, --0x1.f59311dcd0d44p-4, --0x1.eb00695f2562p-2, --0x1.53c9fd3083e22p-56, -0x1p0, --0x1.ef90e02b47283p-4, --0x1.e83e0eaf85114p-2, -0x1.7bc380ef24ba7p-57, -0x1p0, --0x1.e9975b670e077p-4, --0x1.e57a86d3cd825p-2, -0x1.2c80dcd511e87p-57, -0x1p0, --0x1.e3a6873fa1279p-4, --0x1.e2b5d3806f63bp-2, --0x1.e0d891d3c6841p-58, -0x1p0, --0x1.ddbe675f1ffdfp-4, --0x1.dfeff66a941dep-2, -0x1.a756c6e625f96p-56, -0x1p0, --0x1.d7deff6a4b7c9p-4, --0x1.dd28f1481cc58p-2, -0x1.e7576fa6c944ep-59, -0x1p0, --0x1.d208530083d3p-4, --0x1.da60c5cfa10d9p-2, -0x1.0f38e2143c8d5p-57, -0x1p0, --0x1.cc3a65bbc6327p-4, --0x1.d79775b86e389p-2, --0x1.550ec87bc0575p-56, -0x1p0, --0x1.c6753b30aa949p-4, --0x1.d4cd02ba8609dp-2, -0x1.37f33c63033d6p-57, -0x1p0, --0x1.c0b8d6ee61867p-4, --0x1.d2016e8e9db5bp-2, -0x1.c8bce9d93efb8p-57, -0x1p0, --0x1.bb053c7eb1f68p-4, --0x1.cf34baee1cd21p-2, -0x1.118724d19d014p-56, -0x1p0, --0x1.b55a6f65f7058p-4, --0x1.cc66e9931c45ep-2, --0x1.6850e59c37f8fp-58, -0x1p0, --0x1.afb873231ddb9p-4, --0x1.c997fc3865389p-2, -0x1.6295f8b0ca33bp-56, -0x1p0, --0x1.aa1f4b2fa37fcp-4, --0x1.c6c7f4997000bp-2, -0x1.bec2669c68e74p-56, -0x1p0, --0x1.a48efaff92b3bp-4, --0x1.c3f6d47263129p-2, --0x1.9c7bd0fcdecddp-56, -0x1p0, --0x1.9f07860181d1ep-4, --0x1.c1249d8011ee7p-2, -0x1.813aabb515206p-56, -0x1p0, --0x1.9988ef9e90b04p-4, --0x1.be51517ffc0d9p-2, --0x1.2b667131a5f16p-56, -0x1p0, --0x1.94133b3a66851p-4, --0x1.bb7cf2304bd01p-2, --0x1.9e1a5bd9269d4p-57, -0x1p0, --0x1.8ea66c332fd01p-4, --0x1.b8a7814fd5693p-2, --0x1.9a9e6651cc119p-56, -0x1p0, --0x1.894285e19c468p-4, --0x1.b5d1009e15ccp-2, --0x1.5b362cb974183p-57, -0x1p0, --0x1.83e78b98dcc2bp-4, --0x1.b2f971db31972p-2, --0x1.fa971a4a41f2p-56, -0x1p0, --0x1.7e9580a6a136ep-4, --0x1.b020d6c7f4009p-2, --0x1.414ae7e555208p-58, -0x1p0, --0x1.794c685316a3cp-4, --0x1.ad473125cdc09p-2, -0x1.379ede57649dap-58, -0x1p0, --0x1.740c45e0e512p-4, --0x1.aa6c82b6d3fcap-2, -0x1.d5f106ee5ccf7p-56, -0x1p0, --0x1.6ed51c8d2d8fcp-4, --0x1.a790cd3dbf31bp-2, -0x1.7f786986d9023p-57, -0x1p0, --0x1.69a6ef8f8830ap-4, --0x1.a4b4127dea1e5p-2, -0x1.bec6f01bc22f1p-56, -0x1p0, --0x1.6481c21a02123p-4, --0x1.a1d6543b50acp-2, -0x1.0246cfd8779fbp-57, -0x1p0, --0x1.5f6597591b633p-4, --0x1.9ef7943a8ed8ap-2, --0x1.6da81290bdbabp-57, -0x1p0, --0x1.5a527273c56e1p-4, --0x1.9c17d440df9f2p-2, --0x1.923c540a9eec4p-57, -0x1p0, --0x1.5548568b60a7bp-4, --0x1.993716141bdffp-2, -0x1.15e8cce261c55p-56, -0x1p0, --0x1.504746bbbac0bp-4, --0x1.96555b7ab948fp-2, --0x1.7afd51eff33adp-56, -0x1p0, --0x1.4b4f461b0cbaap-4, --0x1.9372a63bc93d7p-2, --0x1.684319e5ad5b1p-57, -0x1p0, --0x1.466057b9f900ap-4, --0x1.908ef81ef7bd1p-2, --0x1.4c00267012357p-56, -0x1p0, --0x1.417a7ea389835p-4, --0x1.8daa52ec8a4bp-2, -0x1.72eb2db8c621ep-57, -0x1p0, --0x1.3c9dbddd2dd84p-4, --0x1.8ac4b86d5ed44p-2, --0x1.17fa7f944ad5bp-56, -0x1p0, --0x1.37ca1866b95cfp-4, --0x1.87de2a6aea963p-2, -0x1.72cedd3d5a61p-57, -0x1p0, --0x1.32ff913a615dp-4, --0x1.84f6aaaf3903fp-2, --0x1.6dcdc2bd47067p-57, -0x1p0, --0x1.2e3e2b4cbb3c3p-4, --0x1.820e3b04eaac4p-2, -0x1.92379eb01c6b6p-59, -0x1p0, --0x1.2985e98cbaa3ap-4, --0x1.7f24dd37341e4p-2, --0x1.2791a1b5eb796p-57, -0x1p0, --0x1.24d6cee3afb2ap-4, --0x1.7c3a9311dcce7p-2, --0x1.9a3f21ef3e8d9p-62, -0x1p0, --0x1.2030de354532cp-4, --0x1.794f5e613dfaep-2, --0x1.820a4b0d21fc5p-57, -0x1p0, --0x1.1b941a5f7ecffp-4, --0x1.766340f2418f6p-2, --0x1.2b2adc9041b2cp-56, -0x1p0, --0x1.1700863ab7533p-4, --0x1.73763c9261092p-2, -0x1.52324face3b1ap-57, -0x1p0, --0x1.127624999ee1dp-4, --0x1.7088530fa459fp-2, -0x1.44b19e0864c5dp-56, -0x1p0, --0x1.0df4f849393f5p-4, --0x1.6d998638a0cb6p-2, -0x1.1ca14532860dfp-61, -0x1p0, --0x1.097d0410dc132p-4, --0x1.6aa9d7dc77e17p-2, -0x1.38b470592c7b3p-56, -0x1p0, --0x1.050e4ab22d321p-4, --0x1.67b949cad63cbp-2, -0x1.a23369348d7efp-56, -0x1p0, --0x1.00a8cee920eabp-4, --0x1.64c7ddd3f27c6p-2, --0x1.10d2b4a664121p-58, -0x1p0, --0x1.f89926d7f0ab8p-5, --0x1.61d595c88c202p-2, --0x1.f6b1e333415d7p-56, -0x1p0, --0x1.eff335d67f541p-5, --0x1.5ee27379ea693p-2, --0x1.634ff2fa75245p-56, -0x1p0, --0x1.e75fd0239926cp-5, --0x1.5bee78b9db3b6p-2, --0x1.e734a63158dfdp-58, -0x1p0, --0x1.dedefb09791b4p-5, --0x1.58f9a75ab1fddp-2, -0x1.efdc0d58cf62p-62, -0x1p0, --0x1.d670bbc6e685ep-5, --0x1.5604012f467b4p-2, --0x1.a0e0b2a5b25p-56, -0x1p0, --0x1.ce15178f31db3p-5, --0x1.530d880af3c24p-2, -0x1.fab8e2103fbd6p-56, -0x1p0, --0x1.c5cc138a317afp-5, --0x1.50163dc197048p-2, -0x1.ec66cb05c7ea4p-56, -0x1p0, --0x1.bd95b4d43e819p-5, --0x1.4d1e24278e76ap-2, --0x1.2417218792858p-57, -0x1p0, --0x1.b572007e31a1bp-5, --0x1.4a253d11b82f3p-2, -0x1.2afa4d6d42a55p-58, -0x1p0, --0x1.ad60fb8d6003ap-5, --0x1.472b8a5571054p-2, -0x1.01ea0fe4dff23p-56, -0x1p0, --0x1.a562aafb982cdp-5, --0x1.44310dc8936fp-2, --0x1.8b694e91d3125p-56, -0x1p0, --0x1.9d7713b71eee1p-5, --0x1.4135c94176601p-2, --0x1.0c97c4afa2518p-56, -0x1p0, --0x1.959e3aa2ac58dp-5, --0x1.3e39be96ec271p-2, --0x1.814c6de9aaaf6p-56, -0x1p0, --0x1.8dd8249568bbbp-5, --0x1.3b3cefa0414b7p-2, --0x1.f36dc4a9c2294p-56, -0x1p0, --0x1.8624d65ae9a63p-5, --0x1.383f5e353b6abp-2, -0x1.a812a4a5c3d44p-56, -0x1p0, --0x1.7e8454b32ef34p-5, --0x1.35410c2e18152p-2, -0x1.3cb002f96e062p-56, -0x1p0, --0x1.76f6a4529fdb5p-5, --0x1.3241fb638baafp-2, --0x1.ecee8f76f8c51p-60, -0x1p0, --0x1.6f7bc9e2080d9p-5, --0x1.2f422daec0387p-2, -0x1.7501ba473da6fp-56, -0x1p0, --0x1.6813c9fe94cfbp-5, --0x1.2c41a4e95452p-2, --0x1.9cf0354aad2dcp-56, -0x1p0, --0x1.60bea939d225ap-5, --0x1.294062ed59f06p-2, -0x1.5d28da2c4612dp-56, -0x1p0, --0x1.597c6c19a8003p-5, --0x1.263e6995554bap-2, --0x1.1d350ffc5ff32p-56, -0x1p0, --0x1.524d171857726p-5, --0x1.233bbabc3bb71p-2, --0x1.99b04e23259efp-56, -0x1p0, --0x1.4b30aea477eeep-5, --0x1.2038583d727bep-2, -0x1.c69cd46300a3p-57, -0x1p0, --0x1.44273720f48bcp-5, --0x1.1d3443f4cdb3ep-2, -0x1.720d41c13519ep-57, -0x1p0, --0x1.3d30b4e5094ep-5, --0x1.1a2f7fbe8f243p-2, --0x1.6465ac86ba7b2p-56, -0x1p0, --0x1.364d2c3c407bep-5, --0x1.172a0d7765177p-2, --0x1.22575f33366bep-57, -0x1p0, --0x1.2f7ca1666ff6fp-5, --0x1.1423eefc69378p-2, --0x1.22d3368ec9b62p-56, -0x1p0, --0x1.28bf1897b69ccp-5, --0x1.111d262b1f677p-2, --0x1.824c20ab7aa9ap-56, -0x1p0, --0x1.221495f879af5p-5, --0x1.0e15b4e1749cep-2, -0x1.5b7fb156c550ap-56, -0x1p0, --0x1.1b7d1da562443p-5, --0x1.0b0d9cfdbdb9p-2, --0x1.3b3a7b8d1200dp-58, -0x1p0, --0x1.14f8b3af5abb9p-5, --0x1.0804e05eb661ep-2, --0x1.54e583d92d3d8p-56, -0x1p0, --0x1.0e875c1b8c3dap-5, --0x1.04fb80e37fdaep-2, -0x1.412cdb72583ccp-63, -0x1p0, --0x1.08291ae35c407p-5, --0x1.01f1806b9fdd2p-2, -0x1.448135394b8bap-56, -0x1p0, --0x1.01ddf3f46a139p-5, --0x1.fdcdc1adfedf9p-3, -0x1.2dba4580ed7bbp-57, -0x1p0, --0x1.f74bd66118e8dp-6, --0x1.f7b7480bd3802p-3, -0x1.9a96d967ee12ep-57, -0x1p0, --0x1.eb0208db9e51bp-6, --0x1.f19f97b215f1bp-3, -0x1.42deef11da2c4p-57, -0x1p0, --0x1.dede86ece142ep-6, --0x1.eb86b462de348p-3, -0x1.bfcde46f90b62p-57, -0x1p0, --0x1.d2e15811bf462p-6, --0x1.e56ca1e101a1bp-3, --0x1.46ac3f9fd0227p-57, -0x1p0, --0x1.c70a83af71ef5p-6, --0x1.df5163f01099ap-3, -0x1.01f7d79906e86p-57, -0x1p0, --0x1.bb5a11138a4c9p-6, --0x1.d934fe5454311p-3, --0x1.75b92277107adp-57, -0x1p0, --0x1.afd00773ec64fp-6, --0x1.d31774d2cbdeep-3, --0x1.2fdc8e5791a0bp-57, -0x1p0, --0x1.a46c6deecac5fp-6, --0x1.ccf8cb312b286p-3, --0x1.2382b0aecadf8p-58, -0x1p0, --0x1.992f4b8aa21f8p-6, --0x1.c6d90535d74ddp-3, -0x1.bfb2be2264962p-59, -0x1p0, --0x1.8e18a73634ee7p-6, --0x1.c0b826a7e4f63p-3, -0x1.af1439e521935p-62, -0x1p0, --0x1.832887c88735dp-6, --0x1.ba96334f15dadp-3, -0x1.75098c05dd18ap-57, -0x1p0, --0x1.785ef400da46cp-6, --0x1.b4732ef3d6722p-3, --0x1.bbe5d5d75cbd8p-57, -0x1p0, --0x1.6dbbf286a8971p-6, --0x1.ae4f1d5f3b9abp-3, --0x1.aa8bbcef9b68ep-57, -0x1p0, --0x1.633f89e9a1a66p-6, --0x1.a82a025b00451p-3, -0x1.87905ffd084adp-57, -0x1p0, --0x1.58e9c0a1a5f21p-6, --0x1.a203e1b1831dap-3, --0x1.c1aadb580a1ecp-58, -0x1p0, --0x1.4eba9d0ec2f7cp-6, --0x1.9bdcbf2dc4366p-3, --0x1.9632d189956fep-57, -0x1p0, --0x1.44b225792f46bp-6, --0x1.95b49e9b62afap-3, -0x1.100b3d1dbfeaap-59, -0x1p0, --0x1.3ad06011469fbp-6, --0x1.8f8b83c69a60bp-3, -0x1.26d19b9ff8d82p-57, -0x1p0, --0x1.311552ef8623cp-6, --0x1.8961727c41804p-3, --0x1.3fdab4e42640ap-58, -0x1p0, --0x1.278104148891ap-6, --0x1.83366e89c64c6p-3, -0x1.192952df10db8p-57, -0x1p0, --0x1.1e1379690291cp-6, --0x1.7d0a7bbd2cb1cp-3, -0x1.cf900f27c58efp-57, -0x1p0, --0x1.14ccb8bdbf114p-6, --0x1.76dd9de50bf31p-3, --0x1.1d5eeec501b2fp-57, -0x1p0, --0x1.0bacc7cb9babap-6, --0x1.70afd8d08c4ffp-3, --0x1.260c3f1369484p-57, -0x1p0, --0x1.02b3ac3385232p-6, --0x1.6a81304f64ab2p-3, --0x1.f0cd73fb5d8d4p-58, -0x1p0, --0x1.f3c2d6fce7cfap-7, --0x1.6451a831d830dp-3, --0x1.ad16031a34d5p-58, -0x1p0, --0x1.e26c163ad15b3p-7, --0x1.5e214448b3fc6p-3, --0x1.531ff779ddac6p-57, -0x1p0, --0x1.d16320d2d221ep-7, --0x1.57f008654cbdep-3, --0x1.908c95c4c9118p-58, -0x1p0, --0x1.c0a80146f894cp-7, --0x1.51bdf8597c5f2p-3, -0x1.9f9976af04aa5p-61, -0x1p0, --0x1.b03ac1e94fe1dp-7, --0x1.4b8b17f79fa88p-3, --0x1.b534fe588f0dp-57, -0x1p0, --0x1.a01b6cdbd995ep-7, --0x1.45576b1293e5ap-3, -0x1.285a24119f7b1p-58, -0x1p0, --0x1.904a0c10875cep-7, --0x1.3f22f57db4893p-3, --0x1.bfe7ff2274956p-59, -0x1p0, --0x1.80c6a94934dfp-7, --0x1.38edbb0cd8d14p-3, -0x1.198c21fbf7718p-57, -0x1p0, --0x1.71914e17a1bc6p-7, --0x1.32b7bf94516a7p-3, --0x1.2a24e2431ef29p-57, -0x1p0, --0x1.62aa03dd6ba58p-7, --0x1.2c8106e8e613ap-3, --0x1.13000a89a11ep-58, -0x1p0, --0x1.5410d3cc0891ep-7, --0x1.264994dfd3409p-3, --0x1.a744ce26f39cp-57, -0x1p0, --0x1.45c5c6e4c114ap-7, --0x1.20116d4ec7bcfp-3, -0x1.242c8e1053452p-57, -0x1p0, --0x1.37c8e5f8aacep-7, --0x1.19d8940be24e7p-3, --0x1.e8dcdca90cc74p-58, -0x1p0, --0x1.2a1a39a8a2fb7p-7, --0x1.139f0cedaf577p-3, -0x1.523434d1b3cfap-57, -0x1p0, --0x1.1cb9ca654924fp-7, --0x1.0d64dbcb26786p-3, -0x1.713a562132055p-58, -0x1p0, --0x1.0fa7a06ef9e81p-7, --0x1.072a047ba831dp-3, --0x1.19db1f70118cap-58, -0x1p0, --0x1.02e3c3d5c9e17p-7, --0x1.00ee8ad6fb85bp-3, --0x1.673eac8308f11p-58, -0x1p0, --0x1.ecdc78f30165cp-8, --0x1.f564e56a9730ep-4, --0x1.a2704729ae56dp-59, -0x1p0, --0x1.d48e24132851p-8, --0x1.e8eb7fde4aa3fp-4, -0x1.23758f2d5bb8bp-58, -0x1p0, --0x1.bcdc980a46f5ap-8, --0x1.dc70ecbae9fc9p-4, --0x1.2fda2d73295eep-60, -0x1p0, --0x1.a5c7e375e55dep-8, --0x1.cff533b307dc1p-4, --0x1.8feeb8f9c3334p-59, -0x1p0, --0x1.8f501492cc296p-8, --0x1.c3785c79ec2d5p-4, -0x1.4f39df133fb21p-61, -0x1p0, --0x1.7975393cfbc4dp-8, --0x1.b6fa6ec38f64cp-4, --0x1.db5d943691f09p-58, -0x1p0, --0x1.64375eefa3dd6p-8, --0x1.aa7b724495c03p-4, --0x1.e5399ba0967b8p-58, -0x1p0, --0x1.4f9692c51b0fbp-8, --0x1.9dfb6eb24a85cp-4, --0x1.e96b47b8c44e6p-59, -0x1p0, --0x1.3b92e176d6d31p-8, --0x1.917a6bc29b42cp-4, -0x1.e2718d26ed688p-60, -0x1p0, --0x1.282c575d639fcp-8, --0x1.84f8712c130a1p-4, -0x1.e626ebafe374ep-58, -0x1p0, --0x1.156300705d51bp-8, --0x1.787586a5d5b21p-4, --0x1.5f7589f083399p-58, -0x1p0, --0x1.0336e84667c66p-8, --0x1.6bf1b3e79b129p-4, -0x1.14b6da08765p-58, -0x1p0, --0x1.e350342a4f6e6p-9, --0x1.5f6d00a9aa419p-4, -0x1.f4022d03f6c9ap-59, -0x1p0, --0x1.c16d4162779e5p-9, --0x1.52e774a4d4d0ap-4, --0x1.b2edf18c730cbp-60, -0x1p0, --0x1.a0c50d1c6bf93p-9, --0x1.4661179272096p-4, -0x1.4b109f2406c4cp-58, -0x1p0, --0x1.8157ab7d29fd9p-9, --0x1.39d9f12c5a299p-4, --0x1.1287ff27ae554p-62, -0x1p0, --0x1.63252fe77c5ebp-9, --0x1.2d52092ce19f6p-4, -0x1.9a088a8bf6b2cp-59, -0x1p0, --0x1.462dacfbef0f3p-9, --0x1.20c9674ed444dp-4, -0x1.f9d48faba7974p-58, -0x1p0, --0x1.2a713498c3c3dp-9, --0x1.1440134d709b3p-4, -0x1.fec446daea6adp-58, -0x1p0, --0x1.0fefd7d9e6ed8p-9, --0x1.07b614e463064p-4, -0x1.384f8c3ee7605p-58, -0x1p0, --0x1.ed534e31ca57fp-10, --0x1.f656e79f820ep-5, -0x1.2e1ebe392bffep-61, -0x1p0, --0x1.bd3d63d9c26efp-10, --0x1.dd406f9808ec9p-5, --0x1.1313a4b4068bdp-62, -0x1p0, --0x1.8f9e0e5514865p-10, --0x1.c428d12c0d7e3p-5, -0x1.89bc74b58c513p-60, -0x1p0, --0x1.647569c825ae1p-10, --0x1.ab101bd5f8317p-5, -0x1.65c6175c6dc68p-59, -0x1p0, --0x1.3bc390d250439p-10, --0x1.91f65f10dd814p-5, -0x1.912bd0d569a9p-61, -0x1p0, --0x1.15889c8dd385fp-10, --0x1.78dbaa5874686p-5, -0x1.4a0ef4035c29cp-60, -0x1p0, --0x1.e389491f8833ap-11, --0x1.5fc00d290cd43p-5, --0x1.a2669a693a8e1p-59, -0x1p0, --0x1.a0ef7dcffafabp-11, --0x1.46a396ff86179p-5, --0x1.136ac00fa2da9p-61, -0x1p0, --0x1.6344004228d8bp-11, --0x1.2d865759455cdp-5, --0x1.686f65ba93acp-61, -0x1p0, --0x1.2a86f68094692p-11, --0x1.14685db42c17fp-5, -0x1.2890d277cb974p-59, -0x1p0, --0x1.ed71071603e86p-12, --0x1.f693731d1cf01p-6, -0x1.3fe9bc66286c7p-66, -0x1p0, --0x1.8fb18eacc3af8p-12, --0x1.c454f4ce53b1dp-6, -0x1.d63d7fef0e36cp-60, -0x1p0, --0x1.3bcfbd9979a27p-12, --0x1.92155f7a3667ep-6, -0x1.b1d63091a013p-64, -0x1p0, --0x1.e3978f34889d9p-13, --0x1.5fd4d21fab226p-6, -0x1.0c0a91c37851cp-61, -0x1p0, --0x1.634bb4ae5ed49p-13, --0x1.2d936bbe30efdp-6, --0x1.b5f91ee371d64p-61, -0x1p0, --0x1.ed7875885ea3ap-14, --0x1.f6a296ab997cbp-7, -0x1.f2943d8fe7033p-61, -0x1p0, --0x1.3bd2c8da49511p-14, --0x1.921d1fcdec784p-7, --0x1.9878ebe836d9dp-61, -0x1p0, --0x1.634da1cec522dp-15, --0x1.2d96b0e509703p-7, -0x1.1e9131ff52dc9p-63, -0x1p0, --0x1.3bd38bab6d94cp-16, --0x1.921f0fe670071p-8, --0x1.ab967fe6b7a9bp-64, -0x1p0, --0x1.3bd3bc5fc5ab4p-18, --0x1.921f8becca4bap-9, --0x1.2ba407bcab5b2p-63, -0x1p0 -}; -template <> HWY_ALIGN constexpr double kCosApproxTable[] = { -0, -0x1p0, -0, -0, -0x1.b781d04cd6d17p-11, -0x1.ffff621621d02p-1, --0x1.6acfcebc82813p-56, --0x1p-8, -0x1.b783c0663fe3cp-10, -0x1.fffd8858e8a92p-1, -0x1.359c71883bcf7p-55, --0x1p-7, --0x1.6cb587284b817p-10, -0x1.fffa72c978c4fp-1, --0x1.22cb000328f91p-55, --0x1p-7, -0x1.b78b80c84e1eep-9, -0x1.fff62169b92dbp-1, -0x1.5dda3c81fbd0dp-55, --0x1p-6, -0x1.2bad2a8cd06bp-12, -0x1.fff0943c53bd1p-1, --0x1.47399f361d158p-55, --0x1p-6, --0x1.6c9b5df1877eap-9, -0x1.ffe9cb44b51a1p-1, -0x1.5b43366df667p-56, --0x1p-6, --0x1.7f53487eac897p-8, -0x1.ffe1c6870cb77p-1, -0x1.89aa14768323ep-55, --0x1p-6, -0x1.b7aa821726608p-8, -0x1.ffd886084cd0dp-1, --0x1.1354d4556e4cbp-55, --0x1p-5, -0x1.dd58598d6271cp-9, -0x1.ffce09ce2a679p-1, --0x1.7bd62ab5ee228p-55, --0x1p-5, -0x1.2d919c5c61fep-11, -0x1.ffc251df1d3f8p-1, -0x1.7a7d209f32d43p-56, --0x1p-5, --0x1.4685db42c17ebp-9, -0x1.ffb55e425fdaep-1, -0x1.6da7ec781c225p-55, --0x1p-5, --0x1.6c32baca2ae69p-8, -0x1.ffa72effef75dp-1, --0x1.8b4cdcdb25956p-55, --0x1p-5, --0x1.1a8e5bfe185e4p-7, -0x1.ff97c4208c014p-1, -0x1.52ab2b947e843p-57, --0x1p-5, --0x1.7f0034a43350ep-7, -0x1.ff871dadb81dfp-1, -0x1.8b1c676208aa4p-56, --0x1p-5, -0x1.0e48ab4f172f4p-6, -0x1.ff753bb1b9164p-1, --0x1.7c330129f56efp-56, --0x1p-4, -0x1.b82683bc89fbp-7, -0x1.ff621e3796d7ep-1, --0x1.c57bc2e24aa15p-57, --0x1p-4, -0x1.53bf90a81f3a5p-7, -0x1.ff4dc54b1bed3p-1, --0x1.c1169ccd1e92ep-55, --0x1p-4, -0x1.deb9769f940eap-8, -0x1.ff3830f8d575cp-1, --0x1.95e1e79d335f7p-56, --0x1p-4, -0x1.15fc833fb89b8p-8, -0x1.ff21614e131edp-1, --0x1.de692a167353p-55, --0x1p-4, -0x1.35230c0fbe402p-10, -0x1.ff095658e71adp-1, -0x1.01a8ce18a4b9ep-55, --0x1p-4, --0x1.ed853918c18ecp-10, -0x1.fef0102826191p-1, -0x1.3c3ea4f30addap-56, --0x1p-4, --0x1.440134d709b28p-8, -0x1.fed58ecb673c4p-1, --0x1.e6e462a7ae686p-56, --0x1p-4, --0x1.064b3a76a2264p-7, -0x1.feb9d2530410fp-1, -0x1.9d429eeda9bb9p-58, --0x1p-4, --0x1.6a9049670cfaep-7, -0x1.fe9cdad01883ap-1, -0x1.521ecd0c67e35p-57, --0x1p-4, --0x1.cecf8962d14c8p-7, -0x1.fe7ea85482d6p-1, -0x1.34b085c1828f7p-56, --0x1p-4, --0x1.19845e49c8257p-6, -0x1.fe5f3af2e394p-1, -0x1.b213f18c9cf17p-55, --0x1p-4, --0x1.4b9dd29353428p-6, -0x1.fe3e92be9d886p-1, -0x1.afeb2e264d46bp-57, --0x1p-4, --0x1.7db402a6a9063p-6, -0x1.fe1cafcbd5b09p-1, -0x1.a23e3202a884ep-57, --0x1p-4, -0x1.281c9830c9dafp-5, -0x1.fdf9922f73307p-1, -0x1.a5e0abd3a9b65p-56, --0x1p-3, -0x1.0f14f2b4549bdp-5, -0x1.fdd539ff1f456p-1, --0x1.ab13cbbec1781p-56, --0x1p-3, -0x1.ec1e3b4fb3d7ep-6, -0x1.fdafa7514538cp-1, -0x1.d97c45ca4d398p-59, --0x1p-3, -0x1.ba1650f592f5p-6, -0x1.fd88da3d12526p-1, --0x1.87df6378811c7p-55, --0x1p-3, -0x1.88124536d5e8fp-6, -0x1.fd60d2da75c9ep-1, -0x1.36dedb314f0ebp-58, --0x1p-3, -0x1.561236eda8ff2p-6, -0x1.fd37914220b84p-1, -0x1.52e9d7b772791p-55, --0x1p-3, -0x1.241644f1c26cep-6, -0x1.fd0d158d86087p-1, -0x1.9705a7b864883p-55, --0x1p-3, -0x1.e43d1c309e958p-7, -0x1.fce15fd6da67bp-1, --0x1.5dd6f830d4c09p-56, --0x1p-3, -0x1.80566267c11f6p-7, -0x1.fcb4703914354p-1, -0x1.126aa7d51b25cp-55, --0x1p-3, -0x1.1c789a28b01b7p-7, -0x1.fc8646cfeb721p-1, -0x1.3143dc43a9b9dp-55, --0x1p-3, -0x1.7148021b55c15p-8, -0x1.fc56e3b7d9af6p-1, --0x1.03ff7a673d3bdp-56, --0x1p-3, -0x1.536352ad19e39p-9, -0x1.fc26470e19fd3p-1, -0x1.1ec8668ecaceep-55, --0x1p-3, --0x1.dd15adf70b65ap-12, -0x1.fbf470f0a8d88p-1, --0x1.6bb200d1d70b7p-55, --0x1p-3, --0x1.ca811eea0c749p-9, -0x1.fbc1617e44186p-1, --0x1.58ec496dc4ecbp-59, --0x1p-3, --0x1.ac9b7964cf0bap-8, -0x1.fb8d18d66adb7p-1, --0x1.d0b66224cce2ep-56, --0x1p-3, --0x1.39f0cedaf576bp-7, -0x1.fb5797195d741p-1, -0x1.1bfac7397cc08p-56, --0x1p-3, --0x1.9d8940be24e74p-7, -0x1.fb20dc681d54dp-1, --0x1.ff148ec7c5fafp-55, --0x1p-3, --0x1.008b6a763de76p-6, -0x1.fae8e8e46cfbbp-1, --0x1.3a9e414732d97p-56, --0x1p-3, --0x1.324ca6fe9a04bp-6, -0x1.faafbcb0cfddcp-1, --0x1.e349cb4d3e866p-55, --0x1p-3, --0x1.64083747309d1p-6, -0x1.fa7557f08a517p-1, --0x1.7a0a8ca13571fp-55, --0x1p-3, --0x1.95bdfca28b53ap-6, -0x1.fa39bac7a1791p-1, --0x1.94f388f1b4e1ep-57, --0x1p-3, --0x1.c76dd866c689ep-6, -0x1.f9fce55adb2c8p-1, -0x1.f2a06fab9f9d1p-56, --0x1p-3, --0x1.f917abeda4499p-6, -0x1.f9bed7cfbde29p-1, --0x1.b35b1f9bcf70bp-56, --0x1p-3, --0x1.155dac4a4f967p-5, -0x1.f97f924c9099bp-1, --0x1.e2ae0eea5963bp-55, --0x1p-3, --0x1.2e2c5fde7ea22p-5, -0x1.f93f14f85ac08p-1, --0x1.cfd153e9a9c1ap-55, --0x1p-3, --0x1.46f7e165f17c8p-5, -0x1.f8fd5ffae41dbp-1, --0x1.8cfd77fd970d2p-56, --0x1p-3, --0x1.5fc0219532f79p-5, -0x1.f8ba737cb4b78p-1, --0x1.da71f96d5a49cp-55, --0x1p-3, --0x1.78851122cff19p-5, -0x1.f8764fa714ba9p-1, -0x1.ab256778ffcb6p-56, --0x1p-3, --0x1.9146a0c760c35p-5, -0x1.f830f4a40c60cp-1, -0x1.8528676925128p-57, --0x1p-3, -0x1.2afd9f6136a9cp-4, -0x1.f7ea629e63d6ep-1, -0x1.ba92d57ebfeddp-55, --0x1p-2, -0x1.1ea04e5ee7601p-4, -0x1.f7a299c1a322ap-1, -0x1.6e7190c94899ep-56, --0x1p-2, -0x1.1244c435e819dp-4, -0x1.f7599a3a12077p-1, -0x1.84f31d743195cp-55, --0x1p-2, -0x1.05eb0885a69c9p-4, -0x1.f70f6434b7eb7p-1, -0x1.1775df66f0ec4p-56, --0x1p-2, -0x1.f32645d8e6ce9p-5, -0x1.f6c3f7df5bbb7p-1, -0x1.8561ce9d5ef5bp-56, --0x1p-2, -0x1.da7a360ef9fefp-5, -0x1.f677556883ceep-1, -0x1.ef696a8d070f4p-57, --0x1p-2, -0x1.c1d1f0e5967d5p-5, -0x1.f6297cff75cbp-1, -0x1.562172a361fd3p-56, --0x1p-2, -0x1.a92d859275418p-5, -0x1.f5da6ed43685dp-1, --0x1.536fc33bf9dd8p-55, --0x1p-2, -0x1.908d0348ef266p-5, -0x1.f58a2b1789e84p-1, -0x1.1f4a188aa368p-56, --0x1p-2, -0x1.77f07939f3897p-5, -0x1.f538b1faf2d07p-1, --0x1.5f7cd5099519cp-59, --0x1p-2, -0x1.5f57f693feebep-5, -0x1.f4e603b0b2f2dp-1, --0x1.8ee01e695ac05p-56, --0x1p-2, -0x1.46c38a8311952p-5, -0x1.f492206bcabb4p-1, -0x1.d1e921bbe3bd3p-55, --0x1p-2, -0x1.2e334430a6376p-5, -0x1.f43d085ff92ddp-1, --0x1.8fde71e361c05p-55, --0x1p-2, -0x1.15a732c3a894dp-5, -0x1.f3e6bbc1bbc65p-1, -0x1.5774bb7e8a21ep-57, --0x1p-2, -0x1.fa3ecac0d84e8p-6, -0x1.f38f3ac64e589p-1, --0x1.d7bafb51f72e6p-56, --0x1p-2, -0x1.c937d65145919p-6, -0x1.f33685a3aaefp-1, -0x1.eb78685d850f8p-56, --0x1p-2, -0x1.9839a676a6bcfp-6, -0x1.f2dc9c9089a9dp-1, -0x1.5407460bdfc07p-59, --0x1p-2, -0x1.67445969a108ep-6, -0x1.f2817fc4609cep-1, --0x1.dd1f8eaf65689p-55, --0x1p-2, -0x1.36580d5d5e775p-6, -0x1.f2252f7763adap-1, --0x1.20cb81c8d94abp-55, --0x1p-2, -0x1.0574e07f7b332p-6, -0x1.f1c7abe284708p-1, -0x1.504b80c8a63fcp-55, --0x1p-2, -0x1.a935e1efe5e4bp-7, -0x1.f168f53f7205dp-1, --0x1.26a6c1f015601p-57, --0x1p-2, -0x1.4794b9d21cb87p-7, -0x1.f1090bc898f5fp-1, --0x1.baa64ab102a93p-55, --0x1p-2, -0x1.cc0d09bd41caap-8, -0x1.f0a7efb9230d7p-1, -0x1.52c7adc6b4989p-56, --0x1p-2, -0x1.0916fe858ffcdp-8, -0x1.f045a14cf738cp-1, --0x1.a52c44f45216cp-55, --0x1p-2, -0x1.191f2900903a6p-10, -0x1.efe220c0b95ecp-1, -0x1.c853b7bf7e0cdp-55, --0x1p-2, --0x1.f1806b9fdd1afp-10, -0x1.ef7d6e51ca3cp-1, --0x1.a3c67c3d3f604p-55, --0x1p-2, --0x1.3ee038dff6b8p-8, -0x1.ef178a3e473c2p-1, -0x1.6310a67fe774fp-55, --0x1p-2, --0x1.009c0bd6cc3cbp-7, -0x1.eeb074c50a544p-1, -0x1.d925f656c43b4p-55, --0x1p-2, --0x1.61b39fb7b7202p-7, -0x1.ee482e25a9dbcp-1, --0x1.b6066ef81af2ap-56, --0x1p-2, --0x1.c2b69c2e939b5p-7, -0x1.eddeb6a078651p-1, --0x1.3b579af740a74p-55, --0x1p-2, --0x1.11d262b1f6776p-6, -0x1.ed740e7684963p-1, -0x1.e82c791f59cc2p-56, --0x1p-2, --0x1.423eefc693785p-6, -0x1.ed0835e999009p-1, -0x1.499d188aa32fap-57, --0x1p-2, --0x1.72a0d77651772p-6, -0x1.ec9b2d3c3bf84p-1, -0x1.19119d358de05p-56, --0x1p-2, --0x1.a2f7fbe8f2436p-6, -0x1.ec2cf4b1af6b2p-1, -0x1.34ee3f2caa62dp-59, --0x1p-2, --0x1.d3443f4cdb3ddp-6, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c615e7277p-56, --0x1p-2, --0x1.01c2c1eb93deep-5, -0x1.eb4cf515b8811p-1, -0x1.95da1ba97ec5ep-57, --0x1p-2, --0x1.19ddd5e1ddb8bp-5, -0x1.eadb2e8e7a88ep-1, --0x1.92ec52ea226a3p-55, --0x1p-2, --0x1.31f34caaaa5d2p-5, -0x1.ea68393e658p-1, --0x1.467259bb7b556p-56, --0x1p-2, --0x1.4a03176acf82dp-5, -0x1.e9f4156c62ddap-1, -0x1.760b1e2e3f81ep-55, --0x1p-2, --0x1.620d274aa2903p-5, -0x1.e97ec36016b3p-1, -0x1.5bc48562557d3p-55, --0x1p-2, --0x1.7a116d7601c35p-5, -0x1.e9084361df7f2p-1, -0x1.cdfc7ce9dc3e9p-55, --0x1p-2, --0x1.920fdb1c5d578p-5, -0x1.e89095bad6025p-1, --0x1.5a4cc0fcbccap-55, --0x1p-2, --0x1.aa086170c0a8ep-5, -0x1.e817bab4cd10dp-1, --0x1.d0afe686b5e0ap-56, --0x1p-2, --0x1.c1faf1a9db555p-5, -0x1.e79db29a5165ap-1, --0x1.75e710aca58p-56, --0x1p-2, --0x1.d9e77d020a5bcp-5, -0x1.e7227db6a9744p-1, -0x1.2128794da5a5p-55, --0x1p-2, --0x1.f1cdf4b76138bp-5, -0x1.e6a61c55d53a7p-1, -0x1.660d981acdcf7p-56, --0x1p-2, --0x1.04d72505d9805p-4, -0x1.e6288ec48e112p-1, --0x1.16b56f2847754p-57, --0x1p-2, --0x1.10c437224dbc2p-4, -0x1.e5a9d550467d3p-1, -0x1.7d431be53f92fp-56, --0x1p-2, --0x1.1cae2955c414fp-4, -0x1.e529f04729ffcp-1, -0x1.9075d6e6dfc8bp-55, --0x1p-2, --0x1.2894f446e0bccp-4, -0x1.e4a8dff81ce5ep-1, -0x1.43578776c0f46p-55, --0x1p-2, --0x1.3478909e39da9p-4, -0x1.e426a4b2bc17ep-1, -0x1.a873889744882p-55, --0x1p-2, --0x1.4058f7065c11ep-4, -0x1.e3a33ec75ce85p-1, -0x1.45089cd46bbb8p-57, --0x1p-2, --0x1.4c36202bcf08ep-4, -0x1.e31eae870ce25p-1, --0x1.bc7094538d678p-56, --0x1p-2, --0x1.581004bd19ed2p-4, -0x1.e298f4439197ap-1, -0x1.e84e601038eb2p-57, --0x1p-2, --0x1.63e69d6ac7f74p-4, -0x1.e212104f686e5p-1, --0x1.014c76c126527p-55, --0x1p-2, --0x1.6fb9e2e76ced8p-4, -0x1.e18a02fdc66d9p-1, -0x1.07e272abd88cfp-55, --0x1p-2, --0x1.7b89cde7a9a4dp-4, -0x1.e100cca2980acp-1, --0x1.02d182acdf825p-57, --0x1p-2, --0x1.875657223080ap-4, -0x1.e0766d9280f54p-1, -0x1.f44c969cf62e3p-55, --0x1p-2, --0x1.931f774fc9f18p-4, -0x1.dfeae622dbe2bp-1, --0x1.514ea88425567p-55, --0x1p-2, --0x1.9ee5272b58f2ap-4, -0x1.df5e36a9ba59cp-1, --0x1.e01f8bceb43d3p-57, --0x1p-2, -0x1.2aac5047103d3p-3, -0x1.ded05f7de47dap-1, --0x1.2cc4c1f8ba966p-55, --0x1p-1, -0x1.24ccf38ebe694p-3, -0x1.de4160f6d8d81p-1, -0x1.9bf11cc5f8776p-55, --0x1p-1, -0x1.1eef59e0b74c3p-3, -0x1.ddb13b6ccc23cp-1, -0x1.83c37c6107db3p-55, --0x1p-1, -0x1.191386db3dedcp-3, -0x1.dd1fef38a915ap-1, --0x1.782f169e17f3bp-55, --0x1p-1, -0x1.13397e1b7ce13p-3, -0x1.dc8d7cb41026p-1, -0x1.6b7872773830dp-56, --0x1p-1, -0x1.0d61433d840a4p-3, -0x1.dbf9e4395759ap-1, -0x1.d8ff7350f75fdp-55, --0x1p-1, -0x1.078ad9dc46632p-3, -0x1.db6526238a09bp-1, --0x1.adee7eae6946p-56, --0x1p-1, -0x1.01b6459197c38p-3, -0x1.dacf42ce68ab9p-1, --0x1.fe8d76efdf896p-56, --0x1p-1, -0x1.f7c713ec554fp-4, -0x1.da383a9668988p-1, --0x1.5811000b39d84p-55, --0x1p-1, -0x1.ec2555431bf03p-4, -0x1.d9a00dd8b3d46p-1, -0x1.bea0e4bac8e16p-58, --0x1p-1, -0x1.e087565455a75p-4, -0x1.d906bcf328d46p-1, -0x1.457e610231ac2p-56, --0x1p-1, -0x1.d4ed1e4a84aefp-4, -0x1.d86c48445a44fp-1, -0x1.e8813c023d71fp-55, --0x1p-1, -0x1.c956b44dd6d41p-4, -0x1.d7d0b02b8ecf9p-1, -0x1.800f4ce65cd6ep-55, --0x1p-1, -0x1.bdc41f84210bbp-4, -0x1.d733f508c0dffp-1, --0x1.007928e770cd5p-55, --0x1p-1, -0x1.b2356710db0a3p-4, -0x1.d696173c9e68bp-1, --0x1.e8c61c6393d55p-56, --0x1p-1, -0x1.a6aa92151adc3p-4, -0x1.d5f7172888a7fp-1, --0x1.68663e2225755p-55, --0x1p-1, -0x1.9b23a7af90805p-4, -0x1.d556f52e93eb1p-1, --0x1.80ed9233a963p-55, --0x1p-1, -0x1.8fa0aefc81837p-4, -0x1.d4b5b1b187524p-1, --0x1.f56be6b42b76dp-57, --0x1p-1, -0x1.8421af15c49d7p-4, -0x1.d4134d14dc93ap-1, --0x1.4ef5295d25af2p-55, --0x1p-1, -0x1.78a6af12bd501p-4, -0x1.d36fc7bcbfbdcp-1, --0x1.ba196d95a177dp-55, --0x1p-1, -0x1.6d2fb6085786ep-4, -0x1.d2cb220e0ef9fp-1, --0x1.f07656d4e6652p-56, --0x1p-1, -0x1.61bccb0903395p-4, -0x1.d2255c6e5a4e1p-1, --0x1.d129a71ecafc9p-55, --0x1p-1, -0x1.564df524b00dap-4, -0x1.d17e7743e35dcp-1, --0x1.101da3540130ap-58, --0x1p-1, -0x1.4ae33b68c8fdcp-4, -0x1.d0d672f59d2b9p-1, --0x1.c83009f0c39dep-55, --0x1p-1, -0x1.3f7ca4e02ffdcp-4, -0x1.d02d4feb2bd92p-1, -0x1.195ff41bc55fep-55, --0x1p-1, -0x1.341a389339a36p-4, -0x1.cf830e8ce467bp-1, --0x1.7b9202780d49dp-55, --0x1p-1, -0x1.28bbfd87a8cffp-4, -0x1.ced7af43cc773p-1, --0x1.e7b6bb5ab58aep-58, --0x1p-1, -0x1.1d61fac0aa5b2p-4, -0x1.ce2b32799a06p-1, --0x1.631d457e46317p-56, --0x1p-1, -0x1.120c373ed0bfbp-4, -0x1.cd7d9898b32f6p-1, --0x1.f2fa062496738p-57, --0x1p-1, -0x1.06baba000fc9bp-4, -0x1.cccee20c2deap-1, --0x1.d3116ae0e69e4p-55, --0x1p-1, -0x1.f6db13ff708cbp-5, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57613b68f6abp-56, --0x1p-1, -0x1.e0495c6ce76b5p-5, -0x1.cb6e20a00da99p-1, --0x1.4fb24b5194c1bp-55, --0x1p-1, -0x1.c9c05b347ffabp-5, -0x1.cabc169a0b9p-1, -0x1.c42d3e10851d1p-55, --0x1p-1, -0x1.b3401e3cd63bbp-5, -0x1.ca08f19b9c449p-1, --0x1.431e0a5a737fdp-56, --0x1p-1, -0x1.9cc8b3671dd0fp-5, -0x1.c954b213411f5p-1, --0x1.2fb761e946603p-58, --0x1p-1, -0x1.865a288f196fap-5, -0x1.c89f587029c13p-1, -0x1.588358ed6e78fp-58, --0x1p-1, -0x1.6ff48b8b1252ap-5, -0x1.c7e8e52233cf3p-1, -0x1.b2ad324aa35c1p-57, --0x1p-1, -0x1.5997ea2bcfb19p-5, -0x1.c7315899eaad7p-1, --0x1.9be5dcd047da7p-57, --0x1p-1, -0x1.4344523c8e3b5p-5, -0x1.c678b3488739bp-1, -0x1.d86cac7c5ff5bp-57, --0x1p-1, -0x1.2cf9d182f7939p-5, -0x1.c5bef59fef85ap-1, --0x1.f0a406c8b7468p-58, --0x1p-1, -0x1.16b875bf19d4p-5, -0x1.c5042012b6907p-1, --0x1.5c058dd8eaba5p-57, --0x1p-1, -0x1.00804cab5f113p-5, -0x1.c44833141c004p-1, -0x1.23e0521df01a2p-56, --0x1p-1, -0x1.d4a2c7f909c4ep-6, -0x1.c38b2f180bdb1p-1, --0x1.6e0b1757c8d07p-56, --0x1p-1, -0x1.a85792c327db2p-6, -0x1.c2cd14931e3f1p-1, -0x1.2ce2f9d4600f5p-56, --0x1p-1, -0x1.7c1f1507aeec3p-6, -0x1.c20de3fa971bp-1, --0x1.b4ca2bab1322cp-55, --0x1p-1, -0x1.4ff96a0da9dfbp-6, -0x1.c14d9dc465e57p-1, -0x1.ce36b64c7f3ccp-55, --0x1p-1, -0x1.23e6ad10872a7p-6, -0x1.c08c426725549p-1, -0x1.b157fd80e2946p-58, --0x1p-1, -0x1.efcdf2801004ap-7, -0x1.bfc9d25a1b147p-1, --0x1.51bf4ee01357p-61, --0x1p-1, -0x1.97f4d3805f318p-7, -0x1.bf064e15377ddp-1, -0x1.2156026a1e028p-57, --0x1p-1, -0x1.4042335264ba3p-7, -0x1.be41b611154c1p-1, --0x1.fdcdad3a6877ep-55, --0x1p-1, -0x1.d16c901d95181p-8, -0x1.bd7c0ac6f952ap-1, --0x1.825a732ac700ap-55, --0x1p-1, -0x1.22a28f6cb488bp-8, -0x1.bcb54cb0d2327p-1, -0x1.410923c55523ep-62, --0x1p-1, -0x1.d09b418edf04ap-10, -0x1.bbed7c49380eap-1, -0x1.beacbd88500b4p-59, --0x1p-1, --0x1.d0320ae0b8293p-11, -0x1.bb249a0b6c40dp-1, --0x1.d6318ee919f7ap-58, --0x1p-1, --0x1.cfc874c3eb6d9p-9, -0x1.ba5aa673590d2p-1, -0x1.7ea4e370753b6p-55, --0x1p-1, --0x1.9572af6decac8p-8, -0x1.b98fa1fd9155ep-1, -0x1.5559034fe85a4p-55, --0x1p-1, --0x1.21589ab88869cp-7, -0x1.b8c38d27504e9p-1, --0x1.1529abff40e45p-55, --0x1p-1, --0x1.77cfb0c6e2db8p-7, -0x1.b7f6686e792e9p-1, -0x1.87665bfea06aap-55, --0x1p-1, --0x1.ce1e648bffb66p-7, -0x1.b728345196e3ep-1, --0x1.bc69f324e6d61p-55, --0x1p-1, --0x1.1222406561182p-6, -0x1.b658f14fdbc47p-1, -0x1.52b5308f397dep-57, --0x1p-1, --0x1.3d20e82f8bc1p-6, -0x1.b5889fe921405p-1, --0x1.df49b307c8602p-57, --0x1p-1, --0x1.680b0f1f0bd73p-6, -0x1.b4b7409de7925p-1, -0x1.f4e257bde73d8p-56, --0x1p-1, --0x1.92e09abb131d4p-6, -0x1.b3e4d3ef55712p-1, --0x1.eb6b8bf11a493p-55, --0x1p-1, --0x1.bda17097896b4p-6, -0x1.b3115a5f37bf3p-1, -0x1.dde2726e34fe1p-55, --0x1p-1, --0x1.e84d76551cfb2p-6, -0x1.b23cd470013b4p-1, -0x1.5a1bb35ad6d2ep-56, --0x1p-1, --0x1.097248d0a956ap-5, -0x1.b16742a4ca2f5p-1, --0x1.ba70972b80438p-55, --0x1p-1, --0x1.1eb3541b4b228p-5, -0x1.b090a581502p-1, --0x1.926da300ffccep-55, --0x1p-1, --0x1.33e9cfee254edp-5, -0x1.afb8fd89f57b6p-1, -0x1.1ced12d2899b8p-60, --0x1p-1, --0x1.4915af336ceb4p-5, -0x1.aee04b43c1474p-1, --0x1.3a79a438bf8ccp-55, --0x1p-1, --0x1.5e36e4dbe2bc2p-5, -0x1.ae068f345ecefp-1, --0x1.33934c4029a4cp-56, --0x1p-1, --0x1.734d63dedb48ap-5, -0x1.ad2bc9e21d511p-1, --0x1.47fbe07bea548p-55, --0x1p-1, --0x1.88591f3a46e4dp-5, -0x1.ac4ffbd3efac8p-1, --0x1.818504103fa16p-56, --0x1p-1, --0x1.9d5a09f2b9b7fp-5, -0x1.ab7325916c0d4p-1, -0x1.a8b8c85baaa9bp-55, --0x1p-1, --0x1.b250171373be9p-5, -0x1.aa9547a2cb98ep-1, -0x1.87d00ae97abaap-60, --0x1p-1, --0x1.c73b39ae68c87p-5, -0x1.a9b66290ea1a3p-1, -0x1.9f630e8b6dac8p-60, --0x1p-1, --0x1.dc1b64dc48722p-5, -0x1.a8d676e545ad2p-1, --0x1.b11dcce2e74bdp-59, --0x1p-1, --0x1.f0f08bbc861afp-5, -0x1.a7f58529fe69dp-1, --0x1.97a441584a179p-55, --0x1p-1, --0x1.02dd50bab06b2p-4, -0x1.a7138de9d60f5p-1, --0x1.f1ab82a9c5f2dp-55, --0x1p-1, --0x1.0d3ccc99f5ac6p-4, -0x1.a63091b02fae2p-1, --0x1.e911152248d1p-56, --0x1p-1, --0x1.1796b31609f0cp-4, -0x1.a54c91090f523p-1, -0x1.184300fd1c1cep-56, --0x1p-1, --0x1.21eafdcc560fap-4, -0x1.a4678c8119ac8p-1, -0x1.1b4c0dd3f212ap-55, --0x1p-1, --0x1.2c39a65db8881p-4, -0x1.a38184a593bc6p-1, --0x1.bc92c5bd2d288p-55, --0x1p-1, --0x1.3682a66e896f5p-4, -0x1.a29a7a0462782p-1, --0x1.128bb015df175p-56, --0x1p-1, --0x1.40c5f7a69e5cep-4, -0x1.a1b26d2c0a75ep-1, -0x1.30ef431d627a6p-57, --0x1p-1, --0x1.4b0393b14e541p-4, -0x1.a0c95eabaf937p-1, --0x1.e0ca3acbd049ap-55, --0x1p-1, --0x1.553b743d75acp-4, -0x1.9fdf4f13149dep-1, -0x1.1e6d79006ec09p-55, --0x1p-1, --0x1.5f6d92fd79f5p-4, -0x1.9ef43ef29af94p-1, -0x1.b1dfcb60445c2p-56, --0x1p-1, --0x1.6999e9a74ddbep-4, -0x1.9e082edb42472p-1, -0x1.5809a4e121e22p-57, --0x1p-1, --0x1.73c071f4750b5p-4, -0x1.9d1b1f5ea80d5p-1, -0x1.c5fadd5ffb36fp-55, --0x1p-1, --0x1.7de125a2080a9p-4, -0x1.9c2d110f075c2p-1, -0x1.d9c9f1c8c30dp-55, --0x1p-1, --0x1.87fbfe70b81a7p-4, -0x1.9b3e047f38741p-1, --0x1.30ee286712474p-55, --0x1p-1, --0x1.9210f624d30fbp-4, -0x1.9a4dfa42b06b2p-1, --0x1.829b6b8b1c947p-56, --0x1p-1, --0x1.9c200686472b5p-4, -0x1.995cf2ed80d22p-1, -0x1.7783e907fbd7bp-56, --0x1p-1, --0x1.a6292960a6f0bp-4, -0x1.986aef1457594p-1, --0x1.af03e318f38fcp-55, --0x1p-1, --0x1.b02c58832cf96p-4, -0x1.9777ef4c7d742p-1, --0x1.15479a240665ep-55, --0x1p-1, --0x1.ba298dc0bfc6bp-4, -0x1.9683f42bd7fe1p-1, --0x1.11bad933c835ep-57, --0x1p-1, --0x1.c420c2eff590ep-4, -0x1.958efe48e6dd7p-1, --0x1.561335da0f4e7p-55, --0x1p-1, --0x1.ce11f1eb18148p-4, -0x1.94990e3ac4a6cp-1, -0x1.a95328edeb3e6p-56, --0x1p-1, --0x1.d7fd1490285cap-4, -0x1.93a22499263fbp-1, -0x1.3d419a920df0bp-55, --0x1p-1, --0x1.e1e224c0e28bdp-4, -0x1.92aa41fc5a815p-1, --0x1.68f89e2d23db7p-57, --0x1p-1, --0x1.ebc11c62c1a1ep-4, -0x1.91b166fd49da2p-1, --0x1.3be953a7fe996p-57, --0x1p-1, --0x1.f599f55f034p-4, -0x1.90b7943575efep-1, -0x1.4ecb0c5273706p-57, --0x1p-1, --0x1.ff6ca9a2ab6a2p-4, -0x1.8fbcca3ef940dp-1, --0x1.6dfa99c86f2f1p-57, --0x1p-1, --0x1.049c998f44231p-3, -0x1.8ec109b486c49p-1, --0x1.cb2a3eb6af617p-56, --0x1p-1, --0x1.097fc5e39aec5p-3, -0x1.8dc45331698ccp-1, -0x1.1d9fcd83634d7p-57, --0x1p-1, --0x1.0e5fd6ca90dffp-3, -0x1.8cc6a75184655p-1, --0x1.e18b3657e2285p-55, --0x1p-1, --0x1.133cc94247758p-3, -0x1.8bc806b151741p-1, --0x1.2c5e12ed1336dp-55, --0x1p-1, --0x1.18169a4acca89p-3, -0x1.8ac871ede1d88p-1, --0x1.9afaa5b7cfc55p-55, --0x1p-1, --0x1.1ced46e61cd1cp-3, -0x1.89c7e9a4dd4aap-1, -0x1.db6ea04a8678fp-55, --0x1p-1, --0x1.21c0cc18247fcp-3, -0x1.88c66e7481ba1p-1, --0x1.5c6228970cf35p-56, --0x1p-1, --0x1.269126e6c24e3p-3, -0x1.87c400fba2ebfp-1, --0x1.2dabc0c3f64cdp-55, --0x1p-1, --0x1.2b5e5459c8bc3p-3, -0x1.86c0a1d9aa195p-1, -0x1.84564f09c3726p-59, --0x1p-1, --0x1.3028517b0001p-3, -0x1.85bc51ae958ccp-1, -0x1.45ba6478086ccp-55, --0x1p-1, --0x1.34ef1b5627dfdp-3, -0x1.84b7111af83fap-1, --0x1.63a47df0b21bap-55, --0x1p-1, --0x1.39b2aef8f97a4p-3, -0x1.83b0e0bff976ep-1, --0x1.6f420f8ea3475p-56, --0x1p-1, --0x1.3e73097329219p-3, -0x1.82a9c13f545ffp-1, --0x1.65e87a7a8cde9p-56, --0x1p-1, --0x1.433027d66826dp-3, -0x1.81a1b33b57accp-1, --0x1.5dea12d66bb66p-55, --0x1p-1, --0x1.47ea073666a98p-3, -0x1.8098b756e52fap-1, -0x1.9136e834b4707p-55, --0x1p-1, --0x1.4ca0a4a8d5657p-3, -0x1.7f8ece3571771p-1, --0x1.9c8d8ce93c917p-55, --0x1p-1, --0x1.5153fd45677efp-3, -0x1.7e83f87b03686p-1, -0x1.b61a8ccabad6p-57, --0x1p-1, --0x1.56040e25d44ddp-3, -0x1.7d7836cc33db2p-1, -0x1.162715ef03f85p-56, --0x1p-1, --0x1.5ab0d465d927ap-3, -0x1.7c6b89ce2d333p-1, --0x1.cfd628084982cp-56, --0x1p-1, --0x1.5f5a4d233b27fp-3, -0x1.7b5df226aafafp-1, --0x1.0f537acdf0ad7p-56, --0x1p-1, --0x1.6400757dc8f7dp-3, -0x1.7a4f707bf97d2p-1, -0x1.3c9751b491eafp-55, --0x1p-1, --0x1.68a34a975c941p-3, -0x1.79400574f55e5p-1, --0x1.0adadbdb4c65ap-55, --0x1p-1, --0x1.6d42c993dd121p-3, -0x1.782fb1b90b35bp-1, --0x1.3e46c1dfd001cp-55, --0x1p-1, --0x1.71deef9940631p-3, -0x1.771e75f037261p-1, -0x1.5cfce8d84068fp-56, --0x1p-1, --0x1.7677b9cf8d17p-3, -0x1.760c52c304764p-1, --0x1.11d76f8e50f1fp-55, --0x1p-1, --0x1.7b0d2560dc1d1p-3, -0x1.74f948da8d28dp-1, -0x1.19900a3b9a3a2p-63, --0x1p-1, --0x1.7f9f2f795a83ep-3, -0x1.73e558e079942p-1, --0x1.2663126697f5ep-55, --0x1p-1, --0x1.842dd5474b37bp-3, -0x1.72d0837efff96p-1, -0x1.0d4ef0f1d915cp-55, --0x1p-1, --0x1.88b913fb08bfdp-3, -0x1.71bac960e41bfp-1, --0x1.b858d90b0f7d8p-56, --0x1p-1, --0x1.8d40e8c706fa4p-3, -0x1.70a42b3176d7ap-1, --0x1.d9e3fbe2e15ap-56, --0x1p-1, --0x1.91c550dfd4d6bp-3, -0x1.6f8ca99c95b75p-1, -0x1.f22e7a35723f4p-56, --0x1p-1, --0x1.9646497c1e0f6p-3, -0x1.6e74454eaa8afp-1, --0x1.dbc03c84e226ep-55, --0x1p-1, --0x1.9ac3cfd4ace19p-3, -0x1.6d5afef4aafcdp-1, --0x1.868a696b8835ep-55, --0x1p-1, --0x1.9f3de1246bc4p-3, -0x1.6c40d73c18275p-1, -0x1.25d4f802be257p-57, --0x1p-1, --0x1.a3b47aa8671c5p-3, -0x1.6b25ced2fe29cp-1, --0x1.5ac64116beda5p-55, --0x1p-1, -0, -0x1.6a09e667f3bcdp-1, --0x1.bdd3413b26456p-55, -0, -0x1.29b4625a03ac9p-2, -0x1.68ed1eaa19c71p-1, -0x1.fd4a85350f69p-56, --0x1p0, -0x1.277e5187cfb16p-2, -0x1.67cf78491af1p-1, -0x1.750ab23477b61p-59, --0x1p0, -0x1.254a0216aa067p-2, -0x1.66b0f3f52b386p-1, -0x1.1e2eb31a8848bp-55, --0x1p0, -0x1.23177562aaea3p-2, -0x1.6591925f0783dp-1, -0x1.c3d64fbf5de23p-55, --0x1p0, -0x1.20e6acc6d4916p-2, -0x1.64715437f535bp-1, --0x1.7c399c15a17dp-55, --0x1p0, -0x1.1eb7a99d1250cp-2, -0x1.63503a31c1be9p-1, -0x1.1248f09e6587cp-57, --0x1p0, -0x1.1c8a6d3e37c82p-2, -0x1.622e44fec22ffp-1, -0x1.f98d8be132d57p-56, --0x1p0, -0x1.1a5ef902000d3p-2, -0x1.610b7551d2cdfp-1, --0x1.251b352ff2a37p-56, --0x1p0, -0x1.18354e3f0cd7dp-2, -0x1.5fe7cbde56a1p-1, --0x1.fcb9cc30cc01ep-55, --0x1p0, -0x1.160d6e4ae5ae6p-2, -0x1.5ec3495837074p-1, -0x1.dea89a9b8f727p-56, --0x1p0, -0x1.13e75a79f7139p-2, -0x1.5d9dee73e345cp-1, --0x1.de1165ecdf7a3p-57, --0x1p0, -0x1.11c3141f91b3ep-2, -0x1.5c77bbe65018cp-1, -0x1.069ea9c0bc32ap-55, --0x1p0, -0x1.0fa09c8de994bp-2, -0x1.5b50b264f7448p-1, -0x1.519d30d4cfebp-56, --0x1p0, -0x1.0d7ff51615437p-2, -0x1.5a28d2a5d725p-1, -0x1.57a25f8b1343p-55, --0x1p0, -0x1.0b611f080d05bp-2, -0x1.59001d5f723dfp-1, -0x1.a9f86ba0dde98p-56, --0x1p0, -0x1.09441bb2aa0a2p-2, -0x1.57d69348cecap-1, --0x1.75720992bfbb2p-55, --0x1p0, -0x1.0728ec63a599ap-2, -0x1.56ac35197649fp-1, --0x1.f7874188cb279p-55, --0x1p0, -0x1.050f92679849cp-2, -0x1.5581038975137p-1, -0x1.4570d9efe26dfp-55, --0x1p0, -0x1.02f80f09f92f4p-2, -0x1.5454ff5159dfcp-1, --0x1.4e247588bf256p-55, --0x1p0, -0x1.00e263951d11fp-2, -0x1.5328292a35596p-1, --0x1.a12eb89da0257p-56, --0x1p0, -0x1.fd9d22a46b416p-3, -0x1.51fa81cd99aa6p-1, --0x1.499f59d8560e9p-63, --0x1p0, -0x1.f9793312a14d1p-3, -0x1.50cc09f59a09bp-1, -0x1.693463a2c2e6fp-56, --0x1p0, -0x1.f558fb02ae805p-3, -0x1.4f9cc25cca486p-1, -0x1.48b5951cfc2b5p-55, --0x1p0, -0x1.f13c7d001a249p-3, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293edceb327p-57, --0x1p0, -0x1.ed23bb941f019p-3, -0x1.4d3bc6d589f7fp-1, -0x1.6e4d9d6b72011p-55, --0x1p0, -0x1.e90eb945a9ccfp-3, -0x1.4c0a145ec0004p-1, -0x1.2630cfafceaa1p-58, --0x1p0, -0x1.e4fd7899579acp-3, -0x1.4ad79516722f1p-1, --0x1.1273b163000f7p-55, --0x1p0, -0x1.e0effc1174505p-3, -0x1.49a449b9b0939p-1, --0x1.27ee16d719b94p-55, --0x1p0, -0x1.dce6462df917dp-3, -0x1.48703306091ffp-1, --0x1.70813b86159fdp-57, --0x1p0, -0x1.d8e0596c8ad56p-3, -0x1.473b51b987347p-1, -0x1.ca1953514e41bp-57, --0x1p0, -0x1.d4de3848789e2p-3, -0x1.4605a692b32a2p-1, -0x1.21ca219b97107p-55, --0x1p0, -0x1.d0dfe53aba2fdp-3, -0x1.44cf325091dd6p-1, -0x1.8076a2cfdc6b3p-57, --0x1p0, -0x1.cce562b9ee6aep-3, -0x1.4397f5b2a438p-1, --0x1.7274c9e48c226p-55, --0x1p0, -0x1.c8eeb33a59cdp-3, -0x1.425ff178e6bb1p-1, -0x1.7b38d675140cap-55, --0x1p0, -0x1.c4fbd92de4eddp-3, -0x1.41272663d108cp-1, -0x1.1bbe7636fadf5p-55, --0x1p0, -0x1.c10cd7041afccp-3, -0x1.3fed9534556d4p-1, -0x1.36916608c5061p-55, --0x1p0, -0x1.bd21af2a28408p-3, -0x1.3eb33eabe068p-1, -0x1.86a2357d1a0d3p-58, --0x1p0, -0x1.b93a640ad8978p-3, -0x1.3d78238c58344p-1, --0x1.0219f5f0f79cep-55, --0x1p0, -0x1.b556f80e95facp-3, -0x1.3c3c44981c518p-1, --0x1.b5e9a9644151bp-55, --0x1p0, -0x1.b1776d9b67013p-3, -0x1.3affa292050b9p-1, -0x1.e3e25e3954964p-56, --0x1p0, -0x1.ad9bc714ed64fp-3, -0x1.39c23e3d63029p-1, --0x1.3b05b276085c1p-58, --0x1p0, -0x1.a9c406dc648a5p-3, -0x1.3884185dfeb22p-1, --0x1.a038026abe6b2p-56, --0x1p0, -0x1.a5f02f50a007cp-3, -0x1.374531b817f8dp-1, -0x1.444d2b0a747fep-55, --0x1p0, -0x1.a22042ce0a2f9p-3, -0x1.36058b10659f3p-1, --0x1.1fcb3a35857e7p-55, --0x1p0, -0x1.9e5443aea29b2p-3, -0x1.34c5252c14de1p-1, -0x1.583f49632ab2bp-55, --0x1p0, -0x1.9a8c3449fcb77p-3, -0x1.338400d0c8e57p-1, --0x1.abf2a5e95e6e5p-55, --0x1p0, -0x1.96c816f53e539p-3, -0x1.32421ec49a61fp-1, -0x1.65e25cc951bfep-55, --0x1p0, -0x1.9307ee031e2fdp-3, -0x1.30ff7fce17035p-1, --0x1.efcc626f74a6fp-57, --0x1p0, -0x1.8f4bbbc3e28f6p-3, -0x1.2fbc24b441015p-1, -0x1.dba4875410874p-57, --0x1p0, -0x1.8b9382855fcaap-3, -0x1.2e780e3e8ea17p-1, --0x1.b19fafe36587ap-55, --0x1p0, -0x1.87df4492f6e38p-3, -0x1.2d333d34e9bb8p-1, --0x1.0e2c2c5549e26p-55, --0x1p0, -0x1.842f0435941afp-3, -0x1.2bedb25faf3eap-1, --0x1.14981c796ee46p-58, --0x1p0, -0x1.8082c3b3ad887p-3, -0x1.2aa76e87aeb58p-1, -0x1.fd600833287a7p-59, --0x1p0, -0x1.7cda855141b26p-3, -0x1.2960727629ca8p-1, -0x1.56d6c7af02d5cp-56, --0x1p0, -0x1.79364b4fd6288p-3, -0x1.2818bef4d3cbap-1, --0x1.e3fffeb76568ap-56, --0x1p0, -0x1.759617ee761f9p-3, -0x1.26d054cdd12dfp-1, --0x1.5da743ef3770cp-55, --0x1p0, -0x1.71f9ed69b10eap-3, -0x1.258734cbb711p-1, -0x1.3a3f0903ce09dp-57, --0x1p0, -0x1.6e61cdfb994dfp-3, -0x1.243d5fb98ac1fp-1, -0x1.c533d0a284a8dp-56, --0x1p0, -0x1.6acdbbdbc2b73p-3, -0x1.22f2d662c13e2p-1, --0x1.d5cc7580cb6d2p-55, --0x1p0, -0x1.673db93f41479p-3, -0x1.21a799933eb59p-1, --0x1.3a7b177c68fb2p-55, --0x1p0, -0x1.63b1c858a7c2ep-3, -0x1.205baa17560d6p-1, -0x1.b7b144016c7a3p-56, --0x1p0, -0x1.6029eb580658ep-3, -0x1.1f0f08bbc861bp-1, --0x1.10d9dcafb74cbp-57, --0x1p0, -0x1.5ca6246ae94b8p-3, -0x1.1dc1b64dc4872p-1, -0x1.f15e1c468be78p-57, --0x1p0, -0x1.592675bc57974p-3, -0x1.1c73b39ae68c8p-1, -0x1.b25dd267f66p-55, --0x1p0, -0x1.55aae174d19c8p-3, -0x1.1b250171373bfp-1, --0x1.b210e95e1ca4cp-55, --0x1p0, -0x1.523369ba4fcaep-3, -0x1.19d5a09f2b9b8p-1, --0x1.33656c68a1d4ap-57, --0x1p0, -0x1.4ec010b0414e1p-3, -0x1.188591f3a46e5p-1, --0x1.bbefe5a524346p-56, --0x1p0, -0x1.4b50d8778abbdp-3, -0x1.1734d63dedb49p-1, --0x1.7eef2ccc50575p-55, --0x1p0, -0x1.47e5c32e84c45p-3, -0x1.15e36e4dbe2bcp-1, -0x1.3c545f7d79eaep-56, --0x1p0, -0x1.447ed2f0fae31p-3, -0x1.14915af336cebp-1, -0x1.f3660558a0213p-56, --0x1p0, -0x1.411c09d82a128p-3, -0x1.133e9cfee254fp-1, --0x1.a1377cfd5ce5p-56, --0x1p0, -0x1.3dbd69fabf802p-3, -0x1.11eb3541b4b23p-1, --0x1.ef23b69abe4f1p-55, --0x1p0, -0x1.3a62f56cd742ep-3, -0x1.1097248d0a957p-1, --0x1.7a58759ba80ddp-55, --0x1p0, -0x1.370cae3ffb12fp-3, -0x1.0f426bb2a8e7ep-1, --0x1.bb58fb774f8eep-55, --0x1p0, -0x1.33ba968321032p-3, -0x1.0ded0b84bc4b6p-1, --0x1.8540fa327c55cp-55, --0x1p0, -0x1.306cb042aa3bap-3, -0x1.0c9704d5d898fp-1, --0x1.8d3d7de6ee9b2p-55, --0x1p0, -0x1.2d22fd8861b6bp-3, -0x1.0b405878f85ecp-1, --0x1.ad66c3bb80da5p-55, --0x1p0, -0x1.29dd805b7afecp-3, -0x1.09e907417c5e1p-1, --0x1.fe573741a9bd4p-55, --0x1p0, -0x1.269c3ac090ee4p-3, -0x1.089112032b08cp-1, -0x1.3248ddf9fe619p-57, --0x1p0, -0x1.235f2eb9a470ap-3, -0x1.073879922ffeep-1, --0x1.a5a014347406cp-55, --0x1p0, -0x1.20265e461b45ap-3, -0x1.05df3ec31b8b7p-1, --0x1.e2dcad34d9c1dp-57, --0x1p0, -0x1.1cf1cb62bec5dp-3, -0x1.0485626ae221ap-1, -0x1.b937d9091ff7p-55, --0x1p0, -0x1.19c17809baa87p-3, -0x1.032ae55edbd96p-1, --0x1.bdb022b40107ap-55, --0x1p0, -0x1.169566329bcb7p-3, -0x1.01cfc874c3eb7p-1, --0x1.34a35e7c2368cp-56, --0x1p0, -0x1.136d97d24efccp-3, -0x1.00740c82b82e1p-1, --0x1.6d48563c60e87p-55, --0x1p0, -0x1.104a0edb1fc58p-3, -0x1.fe2f64be7121p-2, --0x1.297ab1ca2d7dbp-56, --0x1p0, -0x1.0d2acd3cb7364p-3, -0x1.fb7575c24d2dep-2, --0x1.5bfdc883c8664p-57, --0x1p0, -0x1.0a0fd4e41ab5ap-3, -0x1.f8ba4dbf89abap-2, --0x1.2ec1fc1b776b8p-60, --0x1p0, -0x1.06f927bbaacfep-3, -0x1.f5fdee656cda3p-2, --0x1.7bf9780816b05p-58, --0x1p0, -0x1.03e6c7ab2208cp-3, -0x1.f3405963fd067p-2, -0x1.06846d44a238fp-56, --0x1p0, -0x1.00d8b69793ae4p-3, -0x1.f081906bff7fep-2, --0x1.4cab2d4ff6fccp-56, --0x1p0, -0x1.fb9decc6d55b8p-4, -0x1.edc1952ef78d6p-2, --0x1.dd0f7c33edee6p-56, --0x1p0, -0x1.f59311dcd0d44p-4, -0x1.eb00695f2562p-2, -0x1.53c9fd3083e22p-56, --0x1p0, -0x1.ef90e02b47283p-4, -0x1.e83e0eaf85114p-2, --0x1.7bc380ef24ba7p-57, --0x1p0, -0x1.e9975b670e077p-4, -0x1.e57a86d3cd825p-2, --0x1.2c80dcd511e87p-57, --0x1p0, -0x1.e3a6873fa1279p-4, -0x1.e2b5d3806f63bp-2, -0x1.e0d891d3c6841p-58, --0x1p0, -0x1.ddbe675f1ffdfp-4, -0x1.dfeff66a941dep-2, --0x1.a756c6e625f96p-56, --0x1p0, -0x1.d7deff6a4b7c9p-4, -0x1.dd28f1481cc58p-2, --0x1.e7576fa6c944ep-59, --0x1p0, -0x1.d208530083d3p-4, -0x1.da60c5cfa10d9p-2, --0x1.0f38e2143c8d5p-57, --0x1p0, -0x1.cc3a65bbc6327p-4, -0x1.d79775b86e389p-2, -0x1.550ec87bc0575p-56, --0x1p0, -0x1.c6753b30aa949p-4, -0x1.d4cd02ba8609dp-2, --0x1.37f33c63033d6p-57, --0x1p0, -0x1.c0b8d6ee61867p-4, -0x1.d2016e8e9db5bp-2, --0x1.c8bce9d93efb8p-57, --0x1p0, -0x1.bb053c7eb1f68p-4, -0x1.cf34baee1cd21p-2, --0x1.118724d19d014p-56, --0x1p0, -0x1.b55a6f65f7058p-4, -0x1.cc66e9931c45ep-2, -0x1.6850e59c37f8fp-58, --0x1p0, -0x1.afb873231ddb9p-4, -0x1.c997fc3865389p-2, --0x1.6295f8b0ca33bp-56, --0x1p0, -0x1.aa1f4b2fa37fcp-4, -0x1.c6c7f4997000bp-2, --0x1.bec2669c68e74p-56, --0x1p0, -0x1.a48efaff92b3bp-4, -0x1.c3f6d47263129p-2, -0x1.9c7bd0fcdecddp-56, --0x1p0, -0x1.9f07860181d1ep-4, -0x1.c1249d8011ee7p-2, --0x1.813aabb515206p-56, --0x1p0, -0x1.9988ef9e90b04p-4, -0x1.be51517ffc0d9p-2, -0x1.2b667131a5f16p-56, --0x1p0, -0x1.94133b3a66851p-4, -0x1.bb7cf2304bd01p-2, -0x1.9e1a5bd9269d4p-57, --0x1p0, -0x1.8ea66c332fd01p-4, -0x1.b8a7814fd5693p-2, -0x1.9a9e6651cc119p-56, --0x1p0, -0x1.894285e19c468p-4, -0x1.b5d1009e15ccp-2, -0x1.5b362cb974183p-57, --0x1p0, -0x1.83e78b98dcc2bp-4, -0x1.b2f971db31972p-2, -0x1.fa971a4a41f2p-56, --0x1p0, -0x1.7e9580a6a136ep-4, -0x1.b020d6c7f4009p-2, -0x1.414ae7e555208p-58, --0x1p0, -0x1.794c685316a3cp-4, -0x1.ad473125cdc09p-2, --0x1.379ede57649dap-58, --0x1p0, -0x1.740c45e0e512p-4, -0x1.aa6c82b6d3fcap-2, --0x1.d5f106ee5ccf7p-56, --0x1p0, -0x1.6ed51c8d2d8fcp-4, -0x1.a790cd3dbf31bp-2, --0x1.7f786986d9023p-57, --0x1p0, -0x1.69a6ef8f8830ap-4, -0x1.a4b4127dea1e5p-2, --0x1.bec6f01bc22f1p-56, --0x1p0, -0x1.6481c21a02123p-4, -0x1.a1d6543b50acp-2, --0x1.0246cfd8779fbp-57, --0x1p0, -0x1.5f6597591b633p-4, -0x1.9ef7943a8ed8ap-2, -0x1.6da81290bdbabp-57, --0x1p0, -0x1.5a527273c56e1p-4, -0x1.9c17d440df9f2p-2, -0x1.923c540a9eec4p-57, --0x1p0, -0x1.5548568b60a7bp-4, -0x1.993716141bdffp-2, --0x1.15e8cce261c55p-56, --0x1p0, -0x1.504746bbbac0bp-4, -0x1.96555b7ab948fp-2, -0x1.7afd51eff33adp-56, --0x1p0, -0x1.4b4f461b0cbaap-4, -0x1.9372a63bc93d7p-2, -0x1.684319e5ad5b1p-57, --0x1p0, -0x1.466057b9f900ap-4, -0x1.908ef81ef7bd1p-2, -0x1.4c00267012357p-56, --0x1p0, -0x1.417a7ea389835p-4, -0x1.8daa52ec8a4bp-2, --0x1.72eb2db8c621ep-57, --0x1p0, -0x1.3c9dbddd2dd84p-4, -0x1.8ac4b86d5ed44p-2, -0x1.17fa7f944ad5bp-56, --0x1p0, -0x1.37ca1866b95cfp-4, -0x1.87de2a6aea963p-2, --0x1.72cedd3d5a61p-57, --0x1p0, -0x1.32ff913a615dp-4, -0x1.84f6aaaf3903fp-2, -0x1.6dcdc2bd47067p-57, --0x1p0, -0x1.2e3e2b4cbb3c3p-4, -0x1.820e3b04eaac4p-2, --0x1.92379eb01c6b6p-59, --0x1p0, -0x1.2985e98cbaa3ap-4, -0x1.7f24dd37341e4p-2, -0x1.2791a1b5eb796p-57, --0x1p0, -0x1.24d6cee3afb2ap-4, -0x1.7c3a9311dcce7p-2, -0x1.9a3f21ef3e8d9p-62, --0x1p0, -0x1.2030de354532cp-4, -0x1.794f5e613dfaep-2, -0x1.820a4b0d21fc5p-57, --0x1p0, -0x1.1b941a5f7ecffp-4, -0x1.766340f2418f6p-2, -0x1.2b2adc9041b2cp-56, --0x1p0, -0x1.1700863ab7533p-4, -0x1.73763c9261092p-2, --0x1.52324face3b1ap-57, --0x1p0, -0x1.127624999ee1dp-4, -0x1.7088530fa459fp-2, --0x1.44b19e0864c5dp-56, --0x1p0, -0x1.0df4f849393f5p-4, -0x1.6d998638a0cb6p-2, --0x1.1ca14532860dfp-61, --0x1p0, -0x1.097d0410dc132p-4, -0x1.6aa9d7dc77e17p-2, --0x1.38b470592c7b3p-56, --0x1p0, -0x1.050e4ab22d321p-4, -0x1.67b949cad63cbp-2, --0x1.a23369348d7efp-56, --0x1p0, -0x1.00a8cee920eabp-4, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4a664121p-58, --0x1p0, -0x1.f89926d7f0ab8p-5, -0x1.61d595c88c202p-2, -0x1.f6b1e333415d7p-56, --0x1p0, -0x1.eff335d67f541p-5, -0x1.5ee27379ea693p-2, -0x1.634ff2fa75245p-56, --0x1p0, -0x1.e75fd0239926cp-5, -0x1.5bee78b9db3b6p-2, -0x1.e734a63158dfdp-58, --0x1p0, -0x1.dedefb09791b4p-5, -0x1.58f9a75ab1fddp-2, --0x1.efdc0d58cf62p-62, --0x1p0, -0x1.d670bbc6e685ep-5, -0x1.5604012f467b4p-2, -0x1.a0e0b2a5b25p-56, --0x1p0, -0x1.ce15178f31db3p-5, -0x1.530d880af3c24p-2, --0x1.fab8e2103fbd6p-56, --0x1p0, -0x1.c5cc138a317afp-5, -0x1.50163dc197048p-2, --0x1.ec66cb05c7ea4p-56, --0x1p0, -0x1.bd95b4d43e819p-5, -0x1.4d1e24278e76ap-2, -0x1.2417218792858p-57, --0x1p0, -0x1.b572007e31a1bp-5, -0x1.4a253d11b82f3p-2, --0x1.2afa4d6d42a55p-58, --0x1p0, -0x1.ad60fb8d6003ap-5, -0x1.472b8a5571054p-2, --0x1.01ea0fe4dff23p-56, --0x1p0, -0x1.a562aafb982cdp-5, -0x1.44310dc8936fp-2, -0x1.8b694e91d3125p-56, --0x1p0, -0x1.9d7713b71eee1p-5, -0x1.4135c94176601p-2, -0x1.0c97c4afa2518p-56, --0x1p0, -0x1.959e3aa2ac58dp-5, -0x1.3e39be96ec271p-2, -0x1.814c6de9aaaf6p-56, --0x1p0, -0x1.8dd8249568bbbp-5, -0x1.3b3cefa0414b7p-2, -0x1.f36dc4a9c2294p-56, --0x1p0, -0x1.8624d65ae9a63p-5, -0x1.383f5e353b6abp-2, --0x1.a812a4a5c3d44p-56, --0x1p0, -0x1.7e8454b32ef34p-5, -0x1.35410c2e18152p-2, --0x1.3cb002f96e062p-56, --0x1p0, -0x1.76f6a4529fdb5p-5, -0x1.3241fb638baafp-2, -0x1.ecee8f76f8c51p-60, --0x1p0, -0x1.6f7bc9e2080d9p-5, -0x1.2f422daec0387p-2, --0x1.7501ba473da6fp-56, --0x1p0, -0x1.6813c9fe94cfbp-5, -0x1.2c41a4e95452p-2, -0x1.9cf0354aad2dcp-56, --0x1p0, -0x1.60bea939d225ap-5, -0x1.294062ed59f06p-2, --0x1.5d28da2c4612dp-56, --0x1p0, -0x1.597c6c19a8003p-5, -0x1.263e6995554bap-2, -0x1.1d350ffc5ff32p-56, --0x1p0, -0x1.524d171857726p-5, -0x1.233bbabc3bb71p-2, -0x1.99b04e23259efp-56, --0x1p0, -0x1.4b30aea477eeep-5, -0x1.2038583d727bep-2, --0x1.c69cd46300a3p-57, --0x1p0, -0x1.44273720f48bcp-5, -0x1.1d3443f4cdb3ep-2, --0x1.720d41c13519ep-57, --0x1p0, -0x1.3d30b4e5094ep-5, -0x1.1a2f7fbe8f243p-2, -0x1.6465ac86ba7b2p-56, --0x1p0, -0x1.364d2c3c407bep-5, -0x1.172a0d7765177p-2, -0x1.22575f33366bep-57, --0x1p0, -0x1.2f7ca1666ff6fp-5, -0x1.1423eefc69378p-2, -0x1.22d3368ec9b62p-56, --0x1p0, -0x1.28bf1897b69ccp-5, -0x1.111d262b1f677p-2, -0x1.824c20ab7aa9ap-56, --0x1p0, -0x1.221495f879af5p-5, -0x1.0e15b4e1749cep-2, --0x1.5b7fb156c550ap-56, --0x1p0, -0x1.1b7d1da562443p-5, -0x1.0b0d9cfdbdb9p-2, -0x1.3b3a7b8d1200dp-58, --0x1p0, -0x1.14f8b3af5abb9p-5, -0x1.0804e05eb661ep-2, -0x1.54e583d92d3d8p-56, --0x1p0, -0x1.0e875c1b8c3dap-5, -0x1.04fb80e37fdaep-2, --0x1.412cdb72583ccp-63, --0x1p0, -0x1.08291ae35c407p-5, -0x1.01f1806b9fdd2p-2, --0x1.448135394b8bap-56, --0x1p0, -0x1.01ddf3f46a139p-5, -0x1.fdcdc1adfedf9p-3, --0x1.2dba4580ed7bbp-57, --0x1p0, -0x1.f74bd66118e8dp-6, -0x1.f7b7480bd3802p-3, --0x1.9a96d967ee12ep-57, --0x1p0, -0x1.eb0208db9e51bp-6, -0x1.f19f97b215f1bp-3, --0x1.42deef11da2c4p-57, --0x1p0, -0x1.dede86ece142ep-6, -0x1.eb86b462de348p-3, --0x1.bfcde46f90b62p-57, --0x1p0, -0x1.d2e15811bf462p-6, -0x1.e56ca1e101a1bp-3, -0x1.46ac3f9fd0227p-57, --0x1p0, -0x1.c70a83af71ef5p-6, -0x1.df5163f01099ap-3, --0x1.01f7d79906e86p-57, --0x1p0, -0x1.bb5a11138a4c9p-6, -0x1.d934fe5454311p-3, -0x1.75b92277107adp-57, --0x1p0, -0x1.afd00773ec64fp-6, -0x1.d31774d2cbdeep-3, -0x1.2fdc8e5791a0bp-57, --0x1p0, -0x1.a46c6deecac5fp-6, -0x1.ccf8cb312b286p-3, -0x1.2382b0aecadf8p-58, --0x1p0, -0x1.992f4b8aa21f8p-6, -0x1.c6d90535d74ddp-3, --0x1.bfb2be2264962p-59, --0x1p0, -0x1.8e18a73634ee7p-6, -0x1.c0b826a7e4f63p-3, --0x1.af1439e521935p-62, --0x1p0, -0x1.832887c88735dp-6, -0x1.ba96334f15dadp-3, --0x1.75098c05dd18ap-57, --0x1p0, -0x1.785ef400da46cp-6, -0x1.b4732ef3d6722p-3, -0x1.bbe5d5d75cbd8p-57, --0x1p0, -0x1.6dbbf286a8971p-6, -0x1.ae4f1d5f3b9abp-3, -0x1.aa8bbcef9b68ep-57, --0x1p0, -0x1.633f89e9a1a66p-6, -0x1.a82a025b00451p-3, --0x1.87905ffd084adp-57, --0x1p0, -0x1.58e9c0a1a5f21p-6, -0x1.a203e1b1831dap-3, -0x1.c1aadb580a1ecp-58, --0x1p0, -0x1.4eba9d0ec2f7cp-6, -0x1.9bdcbf2dc4366p-3, -0x1.9632d189956fep-57, --0x1p0, -0x1.44b225792f46bp-6, -0x1.95b49e9b62afap-3, --0x1.100b3d1dbfeaap-59, --0x1p0, -0x1.3ad06011469fbp-6, -0x1.8f8b83c69a60bp-3, --0x1.26d19b9ff8d82p-57, --0x1p0, -0x1.311552ef8623cp-6, -0x1.8961727c41804p-3, -0x1.3fdab4e42640ap-58, --0x1p0, -0x1.278104148891ap-6, -0x1.83366e89c64c6p-3, --0x1.192952df10db8p-57, --0x1p0, -0x1.1e1379690291cp-6, -0x1.7d0a7bbd2cb1cp-3, --0x1.cf900f27c58efp-57, --0x1p0, -0x1.14ccb8bdbf114p-6, -0x1.76dd9de50bf31p-3, -0x1.1d5eeec501b2fp-57, --0x1p0, -0x1.0bacc7cb9babap-6, -0x1.70afd8d08c4ffp-3, -0x1.260c3f1369484p-57, --0x1p0, -0x1.02b3ac3385232p-6, -0x1.6a81304f64ab2p-3, -0x1.f0cd73fb5d8d4p-58, --0x1p0, -0x1.f3c2d6fce7cfap-7, -0x1.6451a831d830dp-3, -0x1.ad16031a34d5p-58, --0x1p0, -0x1.e26c163ad15b3p-7, -0x1.5e214448b3fc6p-3, -0x1.531ff779ddac6p-57, --0x1p0, -0x1.d16320d2d221ep-7, -0x1.57f008654cbdep-3, -0x1.908c95c4c9118p-58, --0x1p0, -0x1.c0a80146f894cp-7, -0x1.51bdf8597c5f2p-3, --0x1.9f9976af04aa5p-61, --0x1p0, -0x1.b03ac1e94fe1dp-7, -0x1.4b8b17f79fa88p-3, -0x1.b534fe588f0dp-57, --0x1p0, -0x1.a01b6cdbd995ep-7, -0x1.45576b1293e5ap-3, --0x1.285a24119f7b1p-58, --0x1p0, -0x1.904a0c10875cep-7, -0x1.3f22f57db4893p-3, -0x1.bfe7ff2274956p-59, --0x1p0, -0x1.80c6a94934dfp-7, -0x1.38edbb0cd8d14p-3, --0x1.198c21fbf7718p-57, --0x1p0, -0x1.71914e17a1bc6p-7, -0x1.32b7bf94516a7p-3, -0x1.2a24e2431ef29p-57, --0x1p0, -0x1.62aa03dd6ba58p-7, -0x1.2c8106e8e613ap-3, -0x1.13000a89a11ep-58, --0x1p0, -0x1.5410d3cc0891ep-7, -0x1.264994dfd3409p-3, -0x1.a744ce26f39cp-57, --0x1p0, -0x1.45c5c6e4c114ap-7, -0x1.20116d4ec7bcfp-3, --0x1.242c8e1053452p-57, --0x1p0, -0x1.37c8e5f8aacep-7, -0x1.19d8940be24e7p-3, -0x1.e8dcdca90cc74p-58, --0x1p0, -0x1.2a1a39a8a2fb7p-7, -0x1.139f0cedaf577p-3, --0x1.523434d1b3cfap-57, --0x1p0, -0x1.1cb9ca654924fp-7, -0x1.0d64dbcb26786p-3, --0x1.713a562132055p-58, --0x1p0, -0x1.0fa7a06ef9e81p-7, -0x1.072a047ba831dp-3, -0x1.19db1f70118cap-58, --0x1p0, -0x1.02e3c3d5c9e17p-7, -0x1.00ee8ad6fb85bp-3, -0x1.673eac8308f11p-58, --0x1p0, -0x1.ecdc78f30165cp-8, -0x1.f564e56a9730ep-4, -0x1.a2704729ae56dp-59, --0x1p0, -0x1.d48e24132851p-8, -0x1.e8eb7fde4aa3fp-4, --0x1.23758f2d5bb8bp-58, --0x1p0, -0x1.bcdc980a46f5ap-8, -0x1.dc70ecbae9fc9p-4, -0x1.2fda2d73295eep-60, --0x1p0, -0x1.a5c7e375e55dep-8, -0x1.cff533b307dc1p-4, -0x1.8feeb8f9c3334p-59, --0x1p0, -0x1.8f501492cc296p-8, -0x1.c3785c79ec2d5p-4, --0x1.4f39df133fb21p-61, --0x1p0, -0x1.7975393cfbc4dp-8, -0x1.b6fa6ec38f64cp-4, -0x1.db5d943691f09p-58, --0x1p0, -0x1.64375eefa3dd6p-8, -0x1.aa7b724495c03p-4, -0x1.e5399ba0967b8p-58, --0x1p0, -0x1.4f9692c51b0fbp-8, -0x1.9dfb6eb24a85cp-4, -0x1.e96b47b8c44e6p-59, --0x1p0, -0x1.3b92e176d6d31p-8, -0x1.917a6bc29b42cp-4, --0x1.e2718d26ed688p-60, --0x1p0, -0x1.282c575d639fcp-8, -0x1.84f8712c130a1p-4, --0x1.e626ebafe374ep-58, --0x1p0, -0x1.156300705d51bp-8, -0x1.787586a5d5b21p-4, -0x1.5f7589f083399p-58, --0x1p0, -0x1.0336e84667c66p-8, -0x1.6bf1b3e79b129p-4, --0x1.14b6da08765p-58, --0x1p0, -0x1.e350342a4f6e6p-9, -0x1.5f6d00a9aa419p-4, --0x1.f4022d03f6c9ap-59, --0x1p0, -0x1.c16d4162779e5p-9, -0x1.52e774a4d4d0ap-4, -0x1.b2edf18c730cbp-60, --0x1p0, -0x1.a0c50d1c6bf93p-9, -0x1.4661179272096p-4, --0x1.4b109f2406c4cp-58, --0x1p0, -0x1.8157ab7d29fd9p-9, -0x1.39d9f12c5a299p-4, -0x1.1287ff27ae554p-62, --0x1p0, -0x1.63252fe77c5ebp-9, -0x1.2d52092ce19f6p-4, --0x1.9a088a8bf6b2cp-59, --0x1p0, -0x1.462dacfbef0f3p-9, -0x1.20c9674ed444dp-4, --0x1.f9d48faba7974p-58, --0x1p0, -0x1.2a713498c3c3dp-9, -0x1.1440134d709b3p-4, --0x1.fec446daea6adp-58, --0x1p0, -0x1.0fefd7d9e6ed8p-9, -0x1.07b614e463064p-4, --0x1.384f8c3ee7605p-58, --0x1p0, -0x1.ed534e31ca57fp-10, -0x1.f656e79f820ep-5, --0x1.2e1ebe392bffep-61, --0x1p0, -0x1.bd3d63d9c26efp-10, -0x1.dd406f9808ec9p-5, -0x1.1313a4b4068bdp-62, --0x1p0, -0x1.8f9e0e5514865p-10, -0x1.c428d12c0d7e3p-5, --0x1.89bc74b58c513p-60, --0x1p0, -0x1.647569c825ae1p-10, -0x1.ab101bd5f8317p-5, --0x1.65c6175c6dc68p-59, --0x1p0, -0x1.3bc390d250439p-10, -0x1.91f65f10dd814p-5, --0x1.912bd0d569a9p-61, --0x1p0, -0x1.15889c8dd385fp-10, -0x1.78dbaa5874686p-5, --0x1.4a0ef4035c29cp-60, --0x1p0, -0x1.e389491f8833ap-11, -0x1.5fc00d290cd43p-5, -0x1.a2669a693a8e1p-59, --0x1p0, -0x1.a0ef7dcffafabp-11, -0x1.46a396ff86179p-5, -0x1.136ac00fa2da9p-61, --0x1p0, -0x1.6344004228d8bp-11, -0x1.2d865759455cdp-5, -0x1.686f65ba93acp-61, --0x1p0, -0x1.2a86f68094692p-11, -0x1.14685db42c17fp-5, --0x1.2890d277cb974p-59, --0x1p0, -0x1.ed71071603e86p-12, -0x1.f693731d1cf01p-6, --0x1.3fe9bc66286c7p-66, --0x1p0, -0x1.8fb18eacc3af8p-12, -0x1.c454f4ce53b1dp-6, --0x1.d63d7fef0e36cp-60, --0x1p0, -0x1.3bcfbd9979a27p-12, -0x1.92155f7a3667ep-6, --0x1.b1d63091a013p-64, --0x1p0, -0x1.e3978f34889d9p-13, -0x1.5fd4d21fab226p-6, --0x1.0c0a91c37851cp-61, --0x1p0, -0x1.634bb4ae5ed49p-13, -0x1.2d936bbe30efdp-6, -0x1.b5f91ee371d64p-61, --0x1p0, -0x1.ed7875885ea3ap-14, -0x1.f6a296ab997cbp-7, --0x1.f2943d8fe7033p-61, --0x1p0, -0x1.3bd2c8da49511p-14, -0x1.921d1fcdec784p-7, -0x1.9878ebe836d9dp-61, --0x1p0, -0x1.634da1cec522dp-15, -0x1.2d96b0e509703p-7, --0x1.1e9131ff52dc9p-63, --0x1p0, -0x1.3bd38bab6d94cp-16, -0x1.921f0fe670071p-8, -0x1.ab967fe6b7a9bp-64, --0x1p0, -0x1.3bd3bc5fc5ab4p-18, -0x1.921f8becca4bap-9, -0x1.2ba407bcab5b2p-63, --0x1p0, -0, -0, -0, --0x1p0, -0x1.3bd3bc5fc5ab4p-18, --0x1.921f8becca4bap-9, --0x1.2ba407bcab5b2p-63, --0x1p0, -0x1.3bd38bab6d94cp-16, --0x1.921f0fe670071p-8, --0x1.ab967fe6b7a9bp-64, --0x1p0, -0x1.634da1cec522dp-15, --0x1.2d96b0e509703p-7, -0x1.1e9131ff52dc9p-63, --0x1p0, -0x1.3bd2c8da49511p-14, --0x1.921d1fcdec784p-7, --0x1.9878ebe836d9dp-61, --0x1p0, -0x1.ed7875885ea3ap-14, --0x1.f6a296ab997cbp-7, -0x1.f2943d8fe7033p-61, --0x1p0, -0x1.634bb4ae5ed49p-13, --0x1.2d936bbe30efdp-6, --0x1.b5f91ee371d64p-61, --0x1p0, -0x1.e3978f34889d9p-13, --0x1.5fd4d21fab226p-6, -0x1.0c0a91c37851cp-61, --0x1p0, -0x1.3bcfbd9979a27p-12, --0x1.92155f7a3667ep-6, -0x1.b1d63091a013p-64, --0x1p0, -0x1.8fb18eacc3af8p-12, --0x1.c454f4ce53b1dp-6, -0x1.d63d7fef0e36cp-60, --0x1p0, -0x1.ed71071603e86p-12, --0x1.f693731d1cf01p-6, -0x1.3fe9bc66286c7p-66, --0x1p0, -0x1.2a86f68094692p-11, --0x1.14685db42c17fp-5, -0x1.2890d277cb974p-59, --0x1p0, -0x1.6344004228d8bp-11, --0x1.2d865759455cdp-5, --0x1.686f65ba93acp-61, --0x1p0, -0x1.a0ef7dcffafabp-11, --0x1.46a396ff86179p-5, --0x1.136ac00fa2da9p-61, --0x1p0, -0x1.e389491f8833ap-11, --0x1.5fc00d290cd43p-5, --0x1.a2669a693a8e1p-59, --0x1p0, -0x1.15889c8dd385fp-10, --0x1.78dbaa5874686p-5, -0x1.4a0ef4035c29cp-60, --0x1p0, -0x1.3bc390d250439p-10, --0x1.91f65f10dd814p-5, -0x1.912bd0d569a9p-61, --0x1p0, -0x1.647569c825ae1p-10, --0x1.ab101bd5f8317p-5, -0x1.65c6175c6dc68p-59, --0x1p0, -0x1.8f9e0e5514865p-10, --0x1.c428d12c0d7e3p-5, -0x1.89bc74b58c513p-60, --0x1p0, -0x1.bd3d63d9c26efp-10, --0x1.dd406f9808ec9p-5, --0x1.1313a4b4068bdp-62, --0x1p0, -0x1.ed534e31ca57fp-10, --0x1.f656e79f820ep-5, -0x1.2e1ebe392bffep-61, --0x1p0, -0x1.0fefd7d9e6ed8p-9, --0x1.07b614e463064p-4, -0x1.384f8c3ee7605p-58, --0x1p0, -0x1.2a713498c3c3dp-9, --0x1.1440134d709b3p-4, -0x1.fec446daea6adp-58, --0x1p0, -0x1.462dacfbef0f3p-9, --0x1.20c9674ed444dp-4, -0x1.f9d48faba7974p-58, --0x1p0, -0x1.63252fe77c5ebp-9, --0x1.2d52092ce19f6p-4, -0x1.9a088a8bf6b2cp-59, --0x1p0, -0x1.8157ab7d29fd9p-9, --0x1.39d9f12c5a299p-4, --0x1.1287ff27ae554p-62, --0x1p0, -0x1.a0c50d1c6bf93p-9, --0x1.4661179272096p-4, -0x1.4b109f2406c4cp-58, --0x1p0, -0x1.c16d4162779e5p-9, --0x1.52e774a4d4d0ap-4, --0x1.b2edf18c730cbp-60, --0x1p0, -0x1.e350342a4f6e6p-9, --0x1.5f6d00a9aa419p-4, -0x1.f4022d03f6c9ap-59, --0x1p0, -0x1.0336e84667c66p-8, --0x1.6bf1b3e79b129p-4, -0x1.14b6da08765p-58, --0x1p0, -0x1.156300705d51bp-8, --0x1.787586a5d5b21p-4, --0x1.5f7589f083399p-58, --0x1p0, -0x1.282c575d639fcp-8, --0x1.84f8712c130a1p-4, -0x1.e626ebafe374ep-58, --0x1p0, -0x1.3b92e176d6d31p-8, --0x1.917a6bc29b42cp-4, -0x1.e2718d26ed688p-60, --0x1p0, -0x1.4f9692c51b0fbp-8, --0x1.9dfb6eb24a85cp-4, --0x1.e96b47b8c44e6p-59, --0x1p0, -0x1.64375eefa3dd6p-8, --0x1.aa7b724495c03p-4, --0x1.e5399ba0967b8p-58, --0x1p0, -0x1.7975393cfbc4dp-8, --0x1.b6fa6ec38f64cp-4, --0x1.db5d943691f09p-58, --0x1p0, -0x1.8f501492cc296p-8, --0x1.c3785c79ec2d5p-4, -0x1.4f39df133fb21p-61, --0x1p0, -0x1.a5c7e375e55dep-8, --0x1.cff533b307dc1p-4, --0x1.8feeb8f9c3334p-59, --0x1p0, -0x1.bcdc980a46f5ap-8, --0x1.dc70ecbae9fc9p-4, --0x1.2fda2d73295eep-60, --0x1p0, -0x1.d48e24132851p-8, --0x1.e8eb7fde4aa3fp-4, -0x1.23758f2d5bb8bp-58, --0x1p0, -0x1.ecdc78f30165cp-8, --0x1.f564e56a9730ep-4, --0x1.a2704729ae56dp-59, --0x1p0, -0x1.02e3c3d5c9e17p-7, --0x1.00ee8ad6fb85bp-3, --0x1.673eac8308f11p-58, --0x1p0, -0x1.0fa7a06ef9e81p-7, --0x1.072a047ba831dp-3, --0x1.19db1f70118cap-58, --0x1p0, -0x1.1cb9ca654924fp-7, --0x1.0d64dbcb26786p-3, -0x1.713a562132055p-58, --0x1p0, -0x1.2a1a39a8a2fb7p-7, --0x1.139f0cedaf577p-3, -0x1.523434d1b3cfap-57, --0x1p0, -0x1.37c8e5f8aacep-7, --0x1.19d8940be24e7p-3, --0x1.e8dcdca90cc74p-58, --0x1p0, -0x1.45c5c6e4c114ap-7, --0x1.20116d4ec7bcfp-3, -0x1.242c8e1053452p-57, --0x1p0, -0x1.5410d3cc0891ep-7, --0x1.264994dfd3409p-3, --0x1.a744ce26f39cp-57, --0x1p0, -0x1.62aa03dd6ba58p-7, --0x1.2c8106e8e613ap-3, --0x1.13000a89a11ep-58, --0x1p0, -0x1.71914e17a1bc6p-7, --0x1.32b7bf94516a7p-3, --0x1.2a24e2431ef29p-57, --0x1p0, -0x1.80c6a94934dfp-7, --0x1.38edbb0cd8d14p-3, -0x1.198c21fbf7718p-57, --0x1p0, -0x1.904a0c10875cep-7, --0x1.3f22f57db4893p-3, --0x1.bfe7ff2274956p-59, --0x1p0, -0x1.a01b6cdbd995ep-7, --0x1.45576b1293e5ap-3, -0x1.285a24119f7b1p-58, --0x1p0, -0x1.b03ac1e94fe1dp-7, --0x1.4b8b17f79fa88p-3, --0x1.b534fe588f0dp-57, --0x1p0, -0x1.c0a80146f894cp-7, --0x1.51bdf8597c5f2p-3, -0x1.9f9976af04aa5p-61, --0x1p0, -0x1.d16320d2d221ep-7, --0x1.57f008654cbdep-3, --0x1.908c95c4c9118p-58, --0x1p0, -0x1.e26c163ad15b3p-7, --0x1.5e214448b3fc6p-3, --0x1.531ff779ddac6p-57, --0x1p0, -0x1.f3c2d6fce7cfap-7, --0x1.6451a831d830dp-3, --0x1.ad16031a34d5p-58, --0x1p0, -0x1.02b3ac3385232p-6, --0x1.6a81304f64ab2p-3, --0x1.f0cd73fb5d8d4p-58, --0x1p0, -0x1.0bacc7cb9babap-6, --0x1.70afd8d08c4ffp-3, --0x1.260c3f1369484p-57, --0x1p0, -0x1.14ccb8bdbf114p-6, --0x1.76dd9de50bf31p-3, --0x1.1d5eeec501b2fp-57, --0x1p0, -0x1.1e1379690291cp-6, --0x1.7d0a7bbd2cb1cp-3, -0x1.cf900f27c58efp-57, --0x1p0, -0x1.278104148891ap-6, --0x1.83366e89c64c6p-3, -0x1.192952df10db8p-57, --0x1p0, -0x1.311552ef8623cp-6, --0x1.8961727c41804p-3, --0x1.3fdab4e42640ap-58, --0x1p0, -0x1.3ad06011469fbp-6, --0x1.8f8b83c69a60bp-3, -0x1.26d19b9ff8d82p-57, --0x1p0, -0x1.44b225792f46bp-6, --0x1.95b49e9b62afap-3, -0x1.100b3d1dbfeaap-59, --0x1p0, -0x1.4eba9d0ec2f7cp-6, --0x1.9bdcbf2dc4366p-3, --0x1.9632d189956fep-57, --0x1p0, -0x1.58e9c0a1a5f21p-6, --0x1.a203e1b1831dap-3, --0x1.c1aadb580a1ecp-58, --0x1p0, -0x1.633f89e9a1a66p-6, --0x1.a82a025b00451p-3, -0x1.87905ffd084adp-57, --0x1p0, -0x1.6dbbf286a8971p-6, --0x1.ae4f1d5f3b9abp-3, --0x1.aa8bbcef9b68ep-57, --0x1p0, -0x1.785ef400da46cp-6, --0x1.b4732ef3d6722p-3, --0x1.bbe5d5d75cbd8p-57, --0x1p0, -0x1.832887c88735dp-6, --0x1.ba96334f15dadp-3, -0x1.75098c05dd18ap-57, --0x1p0, -0x1.8e18a73634ee7p-6, --0x1.c0b826a7e4f63p-3, -0x1.af1439e521935p-62, --0x1p0, -0x1.992f4b8aa21f8p-6, --0x1.c6d90535d74ddp-3, -0x1.bfb2be2264962p-59, --0x1p0, -0x1.a46c6deecac5fp-6, --0x1.ccf8cb312b286p-3, --0x1.2382b0aecadf8p-58, --0x1p0, -0x1.afd00773ec64fp-6, --0x1.d31774d2cbdeep-3, --0x1.2fdc8e5791a0bp-57, --0x1p0, -0x1.bb5a11138a4c9p-6, --0x1.d934fe5454311p-3, --0x1.75b92277107adp-57, --0x1p0, -0x1.c70a83af71ef5p-6, --0x1.df5163f01099ap-3, -0x1.01f7d79906e86p-57, --0x1p0, -0x1.d2e15811bf462p-6, --0x1.e56ca1e101a1bp-3, --0x1.46ac3f9fd0227p-57, --0x1p0, -0x1.dede86ece142ep-6, --0x1.eb86b462de348p-3, -0x1.bfcde46f90b62p-57, --0x1p0, -0x1.eb0208db9e51bp-6, --0x1.f19f97b215f1bp-3, -0x1.42deef11da2c4p-57, --0x1p0, -0x1.f74bd66118e8dp-6, --0x1.f7b7480bd3802p-3, -0x1.9a96d967ee12ep-57, --0x1p0, -0x1.01ddf3f46a139p-5, --0x1.fdcdc1adfedf9p-3, -0x1.2dba4580ed7bbp-57, --0x1p0, -0x1.08291ae35c407p-5, --0x1.01f1806b9fdd2p-2, -0x1.448135394b8bap-56, --0x1p0, -0x1.0e875c1b8c3dap-5, --0x1.04fb80e37fdaep-2, -0x1.412cdb72583ccp-63, --0x1p0, -0x1.14f8b3af5abb9p-5, --0x1.0804e05eb661ep-2, --0x1.54e583d92d3d8p-56, --0x1p0, -0x1.1b7d1da562443p-5, --0x1.0b0d9cfdbdb9p-2, --0x1.3b3a7b8d1200dp-58, --0x1p0, -0x1.221495f879af5p-5, --0x1.0e15b4e1749cep-2, -0x1.5b7fb156c550ap-56, --0x1p0, -0x1.28bf1897b69ccp-5, --0x1.111d262b1f677p-2, --0x1.824c20ab7aa9ap-56, --0x1p0, -0x1.2f7ca1666ff6fp-5, --0x1.1423eefc69378p-2, --0x1.22d3368ec9b62p-56, --0x1p0, -0x1.364d2c3c407bep-5, --0x1.172a0d7765177p-2, --0x1.22575f33366bep-57, --0x1p0, -0x1.3d30b4e5094ep-5, --0x1.1a2f7fbe8f243p-2, --0x1.6465ac86ba7b2p-56, --0x1p0, -0x1.44273720f48bcp-5, --0x1.1d3443f4cdb3ep-2, -0x1.720d41c13519ep-57, --0x1p0, -0x1.4b30aea477eeep-5, --0x1.2038583d727bep-2, -0x1.c69cd46300a3p-57, --0x1p0, -0x1.524d171857726p-5, --0x1.233bbabc3bb71p-2, --0x1.99b04e23259efp-56, --0x1p0, -0x1.597c6c19a8003p-5, --0x1.263e6995554bap-2, --0x1.1d350ffc5ff32p-56, --0x1p0, -0x1.60bea939d225ap-5, --0x1.294062ed59f06p-2, -0x1.5d28da2c4612dp-56, --0x1p0, -0x1.6813c9fe94cfbp-5, --0x1.2c41a4e95452p-2, --0x1.9cf0354aad2dcp-56, --0x1p0, -0x1.6f7bc9e2080d9p-5, --0x1.2f422daec0387p-2, -0x1.7501ba473da6fp-56, --0x1p0, -0x1.76f6a4529fdb5p-5, --0x1.3241fb638baafp-2, --0x1.ecee8f76f8c51p-60, --0x1p0, -0x1.7e8454b32ef34p-5, --0x1.35410c2e18152p-2, -0x1.3cb002f96e062p-56, --0x1p0, -0x1.8624d65ae9a63p-5, --0x1.383f5e353b6abp-2, -0x1.a812a4a5c3d44p-56, --0x1p0, -0x1.8dd8249568bbbp-5, --0x1.3b3cefa0414b7p-2, --0x1.f36dc4a9c2294p-56, --0x1p0, -0x1.959e3aa2ac58dp-5, --0x1.3e39be96ec271p-2, --0x1.814c6de9aaaf6p-56, --0x1p0, -0x1.9d7713b71eee1p-5, --0x1.4135c94176601p-2, --0x1.0c97c4afa2518p-56, --0x1p0, -0x1.a562aafb982cdp-5, --0x1.44310dc8936fp-2, --0x1.8b694e91d3125p-56, --0x1p0, -0x1.ad60fb8d6003ap-5, --0x1.472b8a5571054p-2, -0x1.01ea0fe4dff23p-56, --0x1p0, -0x1.b572007e31a1bp-5, --0x1.4a253d11b82f3p-2, -0x1.2afa4d6d42a55p-58, --0x1p0, -0x1.bd95b4d43e819p-5, --0x1.4d1e24278e76ap-2, --0x1.2417218792858p-57, --0x1p0, -0x1.c5cc138a317afp-5, --0x1.50163dc197048p-2, -0x1.ec66cb05c7ea4p-56, --0x1p0, -0x1.ce15178f31db3p-5, --0x1.530d880af3c24p-2, -0x1.fab8e2103fbd6p-56, --0x1p0, -0x1.d670bbc6e685ep-5, --0x1.5604012f467b4p-2, --0x1.a0e0b2a5b25p-56, --0x1p0, -0x1.dedefb09791b4p-5, --0x1.58f9a75ab1fddp-2, -0x1.efdc0d58cf62p-62, --0x1p0, -0x1.e75fd0239926cp-5, --0x1.5bee78b9db3b6p-2, --0x1.e734a63158dfdp-58, --0x1p0, -0x1.eff335d67f541p-5, --0x1.5ee27379ea693p-2, --0x1.634ff2fa75245p-56, --0x1p0, -0x1.f89926d7f0ab8p-5, --0x1.61d595c88c202p-2, --0x1.f6b1e333415d7p-56, --0x1p0, -0x1.00a8cee920eabp-4, --0x1.64c7ddd3f27c6p-2, --0x1.10d2b4a664121p-58, --0x1p0, -0x1.050e4ab22d321p-4, --0x1.67b949cad63cbp-2, -0x1.a23369348d7efp-56, --0x1p0, -0x1.097d0410dc132p-4, --0x1.6aa9d7dc77e17p-2, -0x1.38b470592c7b3p-56, --0x1p0, -0x1.0df4f849393f5p-4, --0x1.6d998638a0cb6p-2, -0x1.1ca14532860dfp-61, --0x1p0, -0x1.127624999ee1dp-4, --0x1.7088530fa459fp-2, -0x1.44b19e0864c5dp-56, --0x1p0, -0x1.1700863ab7533p-4, --0x1.73763c9261092p-2, -0x1.52324face3b1ap-57, --0x1p0, -0x1.1b941a5f7ecffp-4, --0x1.766340f2418f6p-2, --0x1.2b2adc9041b2cp-56, --0x1p0, -0x1.2030de354532cp-4, --0x1.794f5e613dfaep-2, --0x1.820a4b0d21fc5p-57, --0x1p0, -0x1.24d6cee3afb2ap-4, --0x1.7c3a9311dcce7p-2, --0x1.9a3f21ef3e8d9p-62, --0x1p0, -0x1.2985e98cbaa3ap-4, --0x1.7f24dd37341e4p-2, --0x1.2791a1b5eb796p-57, --0x1p0, -0x1.2e3e2b4cbb3c3p-4, --0x1.820e3b04eaac4p-2, -0x1.92379eb01c6b6p-59, --0x1p0, -0x1.32ff913a615dp-4, --0x1.84f6aaaf3903fp-2, --0x1.6dcdc2bd47067p-57, --0x1p0, -0x1.37ca1866b95cfp-4, --0x1.87de2a6aea963p-2, -0x1.72cedd3d5a61p-57, --0x1p0, -0x1.3c9dbddd2dd84p-4, --0x1.8ac4b86d5ed44p-2, --0x1.17fa7f944ad5bp-56, --0x1p0, -0x1.417a7ea389835p-4, --0x1.8daa52ec8a4bp-2, -0x1.72eb2db8c621ep-57, --0x1p0, -0x1.466057b9f900ap-4, --0x1.908ef81ef7bd1p-2, --0x1.4c00267012357p-56, --0x1p0, -0x1.4b4f461b0cbaap-4, --0x1.9372a63bc93d7p-2, --0x1.684319e5ad5b1p-57, --0x1p0, -0x1.504746bbbac0bp-4, --0x1.96555b7ab948fp-2, --0x1.7afd51eff33adp-56, --0x1p0, -0x1.5548568b60a7bp-4, --0x1.993716141bdffp-2, -0x1.15e8cce261c55p-56, --0x1p0, -0x1.5a527273c56e1p-4, --0x1.9c17d440df9f2p-2, --0x1.923c540a9eec4p-57, --0x1p0, -0x1.5f6597591b633p-4, --0x1.9ef7943a8ed8ap-2, --0x1.6da81290bdbabp-57, --0x1p0, -0x1.6481c21a02123p-4, --0x1.a1d6543b50acp-2, -0x1.0246cfd8779fbp-57, --0x1p0, -0x1.69a6ef8f8830ap-4, --0x1.a4b4127dea1e5p-2, -0x1.bec6f01bc22f1p-56, --0x1p0, -0x1.6ed51c8d2d8fcp-4, --0x1.a790cd3dbf31bp-2, -0x1.7f786986d9023p-57, --0x1p0, -0x1.740c45e0e512p-4, --0x1.aa6c82b6d3fcap-2, -0x1.d5f106ee5ccf7p-56, --0x1p0, -0x1.794c685316a3cp-4, --0x1.ad473125cdc09p-2, -0x1.379ede57649dap-58, --0x1p0, -0x1.7e9580a6a136ep-4, --0x1.b020d6c7f4009p-2, --0x1.414ae7e555208p-58, --0x1p0, -0x1.83e78b98dcc2bp-4, --0x1.b2f971db31972p-2, --0x1.fa971a4a41f2p-56, --0x1p0, -0x1.894285e19c468p-4, --0x1.b5d1009e15ccp-2, --0x1.5b362cb974183p-57, --0x1p0, -0x1.8ea66c332fd01p-4, --0x1.b8a7814fd5693p-2, --0x1.9a9e6651cc119p-56, --0x1p0, -0x1.94133b3a66851p-4, --0x1.bb7cf2304bd01p-2, --0x1.9e1a5bd9269d4p-57, --0x1p0, -0x1.9988ef9e90b04p-4, --0x1.be51517ffc0d9p-2, --0x1.2b667131a5f16p-56, --0x1p0, -0x1.9f07860181d1ep-4, --0x1.c1249d8011ee7p-2, -0x1.813aabb515206p-56, --0x1p0, -0x1.a48efaff92b3bp-4, --0x1.c3f6d47263129p-2, --0x1.9c7bd0fcdecddp-56, --0x1p0, -0x1.aa1f4b2fa37fcp-4, --0x1.c6c7f4997000bp-2, -0x1.bec2669c68e74p-56, --0x1p0, -0x1.afb873231ddb9p-4, --0x1.c997fc3865389p-2, -0x1.6295f8b0ca33bp-56, --0x1p0, -0x1.b55a6f65f7058p-4, --0x1.cc66e9931c45ep-2, --0x1.6850e59c37f8fp-58, --0x1p0, -0x1.bb053c7eb1f68p-4, --0x1.cf34baee1cd21p-2, -0x1.118724d19d014p-56, --0x1p0, -0x1.c0b8d6ee61867p-4, --0x1.d2016e8e9db5bp-2, -0x1.c8bce9d93efb8p-57, --0x1p0, -0x1.c6753b30aa949p-4, --0x1.d4cd02ba8609dp-2, -0x1.37f33c63033d6p-57, --0x1p0, -0x1.cc3a65bbc6327p-4, --0x1.d79775b86e389p-2, --0x1.550ec87bc0575p-56, --0x1p0, -0x1.d208530083d3p-4, --0x1.da60c5cfa10d9p-2, -0x1.0f38e2143c8d5p-57, --0x1p0, -0x1.d7deff6a4b7c9p-4, --0x1.dd28f1481cc58p-2, -0x1.e7576fa6c944ep-59, --0x1p0, -0x1.ddbe675f1ffdfp-4, --0x1.dfeff66a941dep-2, -0x1.a756c6e625f96p-56, --0x1p0, -0x1.e3a6873fa1279p-4, --0x1.e2b5d3806f63bp-2, --0x1.e0d891d3c6841p-58, --0x1p0, -0x1.e9975b670e077p-4, --0x1.e57a86d3cd825p-2, -0x1.2c80dcd511e87p-57, --0x1p0, -0x1.ef90e02b47283p-4, --0x1.e83e0eaf85114p-2, -0x1.7bc380ef24ba7p-57, --0x1p0, -0x1.f59311dcd0d44p-4, --0x1.eb00695f2562p-2, --0x1.53c9fd3083e22p-56, --0x1p0, -0x1.fb9decc6d55b8p-4, --0x1.edc1952ef78d6p-2, -0x1.dd0f7c33edee6p-56, --0x1p0, -0x1.00d8b69793ae4p-3, --0x1.f081906bff7fep-2, -0x1.4cab2d4ff6fccp-56, --0x1p0, -0x1.03e6c7ab2208cp-3, --0x1.f3405963fd067p-2, --0x1.06846d44a238fp-56, --0x1p0, -0x1.06f927bbaacfep-3, --0x1.f5fdee656cda3p-2, -0x1.7bf9780816b05p-58, --0x1p0, -0x1.0a0fd4e41ab5ap-3, --0x1.f8ba4dbf89abap-2, -0x1.2ec1fc1b776b8p-60, --0x1p0, -0x1.0d2acd3cb7364p-3, --0x1.fb7575c24d2dep-2, -0x1.5bfdc883c8664p-57, --0x1p0, -0x1.104a0edb1fc58p-3, --0x1.fe2f64be7121p-2, -0x1.297ab1ca2d7dbp-56, --0x1p0, -0x1.136d97d24efccp-3, --0x1.00740c82b82e1p-1, -0x1.6d48563c60e87p-55, --0x1p0, -0x1.169566329bcb7p-3, --0x1.01cfc874c3eb7p-1, -0x1.34a35e7c2368cp-56, --0x1p0, -0x1.19c17809baa87p-3, --0x1.032ae55edbd96p-1, -0x1.bdb022b40107ap-55, --0x1p0, -0x1.1cf1cb62bec5dp-3, --0x1.0485626ae221ap-1, --0x1.b937d9091ff7p-55, --0x1p0, -0x1.20265e461b45ap-3, --0x1.05df3ec31b8b7p-1, -0x1.e2dcad34d9c1dp-57, --0x1p0, -0x1.235f2eb9a470ap-3, --0x1.073879922ffeep-1, -0x1.a5a014347406cp-55, --0x1p0, -0x1.269c3ac090ee4p-3, --0x1.089112032b08cp-1, --0x1.3248ddf9fe619p-57, --0x1p0, -0x1.29dd805b7afecp-3, --0x1.09e907417c5e1p-1, -0x1.fe573741a9bd4p-55, --0x1p0, -0x1.2d22fd8861b6bp-3, --0x1.0b405878f85ecp-1, -0x1.ad66c3bb80da5p-55, --0x1p0, -0x1.306cb042aa3bap-3, --0x1.0c9704d5d898fp-1, -0x1.8d3d7de6ee9b2p-55, --0x1p0, -0x1.33ba968321032p-3, --0x1.0ded0b84bc4b6p-1, -0x1.8540fa327c55cp-55, --0x1p0, -0x1.370cae3ffb12fp-3, --0x1.0f426bb2a8e7ep-1, -0x1.bb58fb774f8eep-55, --0x1p0, -0x1.3a62f56cd742ep-3, --0x1.1097248d0a957p-1, -0x1.7a58759ba80ddp-55, --0x1p0, -0x1.3dbd69fabf802p-3, --0x1.11eb3541b4b23p-1, -0x1.ef23b69abe4f1p-55, --0x1p0, -0x1.411c09d82a128p-3, --0x1.133e9cfee254fp-1, -0x1.a1377cfd5ce5p-56, --0x1p0, -0x1.447ed2f0fae31p-3, --0x1.14915af336cebp-1, --0x1.f3660558a0213p-56, --0x1p0, -0x1.47e5c32e84c45p-3, --0x1.15e36e4dbe2bcp-1, --0x1.3c545f7d79eaep-56, --0x1p0, -0x1.4b50d8778abbdp-3, --0x1.1734d63dedb49p-1, -0x1.7eef2ccc50575p-55, --0x1p0, -0x1.4ec010b0414e1p-3, --0x1.188591f3a46e5p-1, -0x1.bbefe5a524346p-56, --0x1p0, -0x1.523369ba4fcaep-3, --0x1.19d5a09f2b9b8p-1, -0x1.33656c68a1d4ap-57, --0x1p0, -0x1.55aae174d19c8p-3, --0x1.1b250171373bfp-1, -0x1.b210e95e1ca4cp-55, --0x1p0, -0x1.592675bc57974p-3, --0x1.1c73b39ae68c8p-1, --0x1.b25dd267f66p-55, --0x1p0, -0x1.5ca6246ae94b8p-3, --0x1.1dc1b64dc4872p-1, --0x1.f15e1c468be78p-57, --0x1p0, -0x1.6029eb580658ep-3, --0x1.1f0f08bbc861bp-1, -0x1.10d9dcafb74cbp-57, --0x1p0, -0x1.63b1c858a7c2ep-3, --0x1.205baa17560d6p-1, --0x1.b7b144016c7a3p-56, --0x1p0, -0x1.673db93f41479p-3, --0x1.21a799933eb59p-1, -0x1.3a7b177c68fb2p-55, --0x1p0, -0x1.6acdbbdbc2b73p-3, --0x1.22f2d662c13e2p-1, -0x1.d5cc7580cb6d2p-55, --0x1p0, -0x1.6e61cdfb994dfp-3, --0x1.243d5fb98ac1fp-1, --0x1.c533d0a284a8dp-56, --0x1p0, -0x1.71f9ed69b10eap-3, --0x1.258734cbb711p-1, --0x1.3a3f0903ce09dp-57, --0x1p0, -0x1.759617ee761f9p-3, --0x1.26d054cdd12dfp-1, -0x1.5da743ef3770cp-55, --0x1p0, -0x1.79364b4fd6288p-3, --0x1.2818bef4d3cbap-1, -0x1.e3fffeb76568ap-56, --0x1p0, -0x1.7cda855141b26p-3, --0x1.2960727629ca8p-1, --0x1.56d6c7af02d5cp-56, --0x1p0, -0x1.8082c3b3ad887p-3, --0x1.2aa76e87aeb58p-1, --0x1.fd600833287a7p-59, --0x1p0, -0x1.842f0435941afp-3, --0x1.2bedb25faf3eap-1, -0x1.14981c796ee46p-58, --0x1p0, -0x1.87df4492f6e38p-3, --0x1.2d333d34e9bb8p-1, -0x1.0e2c2c5549e26p-55, --0x1p0, -0x1.8b9382855fcaap-3, --0x1.2e780e3e8ea17p-1, -0x1.b19fafe36587ap-55, --0x1p0, -0x1.8f4bbbc3e28f6p-3, --0x1.2fbc24b441015p-1, --0x1.dba4875410874p-57, --0x1p0, -0x1.9307ee031e2fdp-3, --0x1.30ff7fce17035p-1, -0x1.efcc626f74a6fp-57, --0x1p0, -0x1.96c816f53e539p-3, --0x1.32421ec49a61fp-1, --0x1.65e25cc951bfep-55, --0x1p0, -0x1.9a8c3449fcb77p-3, --0x1.338400d0c8e57p-1, -0x1.abf2a5e95e6e5p-55, --0x1p0, -0x1.9e5443aea29b2p-3, --0x1.34c5252c14de1p-1, --0x1.583f49632ab2bp-55, --0x1p0, -0x1.a22042ce0a2f9p-3, --0x1.36058b10659f3p-1, -0x1.1fcb3a35857e7p-55, --0x1p0, -0x1.a5f02f50a007cp-3, --0x1.374531b817f8dp-1, --0x1.444d2b0a747fep-55, --0x1p0, -0x1.a9c406dc648a5p-3, --0x1.3884185dfeb22p-1, -0x1.a038026abe6b2p-56, --0x1p0, -0x1.ad9bc714ed64fp-3, --0x1.39c23e3d63029p-1, -0x1.3b05b276085c1p-58, --0x1p0, -0x1.b1776d9b67013p-3, --0x1.3affa292050b9p-1, --0x1.e3e25e3954964p-56, --0x1p0, -0x1.b556f80e95facp-3, --0x1.3c3c44981c518p-1, -0x1.b5e9a9644151bp-55, --0x1p0, -0x1.b93a640ad8978p-3, --0x1.3d78238c58344p-1, -0x1.0219f5f0f79cep-55, --0x1p0, -0x1.bd21af2a28408p-3, --0x1.3eb33eabe068p-1, --0x1.86a2357d1a0d3p-58, --0x1p0, -0x1.c10cd7041afccp-3, --0x1.3fed9534556d4p-1, --0x1.36916608c5061p-55, --0x1p0, -0x1.c4fbd92de4eddp-3, --0x1.41272663d108cp-1, --0x1.1bbe7636fadf5p-55, --0x1p0, -0x1.c8eeb33a59cdp-3, --0x1.425ff178e6bb1p-1, --0x1.7b38d675140cap-55, --0x1p0, -0x1.cce562b9ee6aep-3, --0x1.4397f5b2a438p-1, -0x1.7274c9e48c226p-55, --0x1p0, -0x1.d0dfe53aba2fdp-3, --0x1.44cf325091dd6p-1, --0x1.8076a2cfdc6b3p-57, --0x1p0, -0x1.d4de3848789e2p-3, --0x1.4605a692b32a2p-1, --0x1.21ca219b97107p-55, --0x1p0, -0x1.d8e0596c8ad56p-3, --0x1.473b51b987347p-1, --0x1.ca1953514e41bp-57, --0x1p0, -0x1.dce6462df917dp-3, --0x1.48703306091ffp-1, -0x1.70813b86159fdp-57, --0x1p0, -0x1.e0effc1174505p-3, --0x1.49a449b9b0939p-1, -0x1.27ee16d719b94p-55, --0x1p0, -0x1.e4fd7899579acp-3, --0x1.4ad79516722f1p-1, -0x1.1273b163000f7p-55, --0x1p0, -0x1.e90eb945a9ccfp-3, --0x1.4c0a145ec0004p-1, --0x1.2630cfafceaa1p-58, --0x1p0, -0x1.ed23bb941f019p-3, --0x1.4d3bc6d589f7fp-1, --0x1.6e4d9d6b72011p-55, --0x1p0, -0x1.f13c7d001a249p-3, --0x1.4e6cabbe3e5e9p-1, --0x1.3c293edceb327p-57, --0x1p0, -0x1.f558fb02ae805p-3, --0x1.4f9cc25cca486p-1, --0x1.48b5951cfc2b5p-55, --0x1p0, -0x1.f9793312a14d1p-3, --0x1.50cc09f59a09bp-1, --0x1.693463a2c2e6fp-56, --0x1p0, -0x1.fd9d22a46b416p-3, --0x1.51fa81cd99aa6p-1, -0x1.499f59d8560e9p-63, --0x1p0, -0x1.00e263951d11fp-2, --0x1.5328292a35596p-1, -0x1.a12eb89da0257p-56, --0x1p0, -0x1.02f80f09f92f4p-2, --0x1.5454ff5159dfcp-1, -0x1.4e247588bf256p-55, --0x1p0, -0x1.050f92679849cp-2, --0x1.5581038975137p-1, --0x1.4570d9efe26dfp-55, --0x1p0, -0x1.0728ec63a599ap-2, --0x1.56ac35197649fp-1, -0x1.f7874188cb279p-55, --0x1p0, -0x1.09441bb2aa0a2p-2, --0x1.57d69348cecap-1, -0x1.75720992bfbb2p-55, --0x1p0, -0x1.0b611f080d05bp-2, --0x1.59001d5f723dfp-1, --0x1.a9f86ba0dde98p-56, --0x1p0, -0x1.0d7ff51615437p-2, --0x1.5a28d2a5d725p-1, --0x1.57a25f8b1343p-55, --0x1p0, -0x1.0fa09c8de994bp-2, --0x1.5b50b264f7448p-1, --0x1.519d30d4cfebp-56, --0x1p0, -0x1.11c3141f91b3ep-2, --0x1.5c77bbe65018cp-1, --0x1.069ea9c0bc32ap-55, --0x1p0, -0x1.13e75a79f7139p-2, --0x1.5d9dee73e345cp-1, -0x1.de1165ecdf7a3p-57, --0x1p0, -0x1.160d6e4ae5ae6p-2, --0x1.5ec3495837074p-1, --0x1.dea89a9b8f727p-56, --0x1p0, -0x1.18354e3f0cd7dp-2, --0x1.5fe7cbde56a1p-1, -0x1.fcb9cc30cc01ep-55, --0x1p0, -0x1.1a5ef902000d3p-2, --0x1.610b7551d2cdfp-1, -0x1.251b352ff2a37p-56, --0x1p0, -0x1.1c8a6d3e37c82p-2, --0x1.622e44fec22ffp-1, --0x1.f98d8be132d57p-56, --0x1p0, -0x1.1eb7a99d1250cp-2, --0x1.63503a31c1be9p-1, --0x1.1248f09e6587cp-57, --0x1p0, -0x1.20e6acc6d4916p-2, --0x1.64715437f535bp-1, -0x1.7c399c15a17dp-55, --0x1p0, -0x1.23177562aaea3p-2, --0x1.6591925f0783dp-1, --0x1.c3d64fbf5de23p-55, --0x1p0, -0x1.254a0216aa067p-2, --0x1.66b0f3f52b386p-1, --0x1.1e2eb31a8848bp-55, --0x1p0, -0x1.277e5187cfb16p-2, --0x1.67cf78491af1p-1, --0x1.750ab23477b61p-59, --0x1p0, -0x1.29b4625a03ac9p-2, --0x1.68ed1eaa19c71p-1, --0x1.fd4a85350f69p-56, --0x1p0, -0, --0x1.6a09e667f3bcdp-1, -0x1.bdd3413b26456p-55, -0, --0x1.a3b47aa8671c5p-3, --0x1.6b25ced2fe29cp-1, -0x1.5ac64116beda5p-55, --0x1p-1, --0x1.9f3de1246bc4p-3, --0x1.6c40d73c18275p-1, --0x1.25d4f802be257p-57, --0x1p-1, --0x1.9ac3cfd4ace19p-3, --0x1.6d5afef4aafcdp-1, -0x1.868a696b8835ep-55, --0x1p-1, --0x1.9646497c1e0f6p-3, --0x1.6e74454eaa8afp-1, -0x1.dbc03c84e226ep-55, --0x1p-1, --0x1.91c550dfd4d6bp-3, --0x1.6f8ca99c95b75p-1, --0x1.f22e7a35723f4p-56, --0x1p-1, --0x1.8d40e8c706fa4p-3, --0x1.70a42b3176d7ap-1, -0x1.d9e3fbe2e15ap-56, --0x1p-1, --0x1.88b913fb08bfdp-3, --0x1.71bac960e41bfp-1, -0x1.b858d90b0f7d8p-56, --0x1p-1, --0x1.842dd5474b37bp-3, --0x1.72d0837efff96p-1, --0x1.0d4ef0f1d915cp-55, --0x1p-1, --0x1.7f9f2f795a83ep-3, --0x1.73e558e079942p-1, -0x1.2663126697f5ep-55, --0x1p-1, --0x1.7b0d2560dc1d1p-3, --0x1.74f948da8d28dp-1, --0x1.19900a3b9a3a2p-63, --0x1p-1, --0x1.7677b9cf8d17p-3, --0x1.760c52c304764p-1, -0x1.11d76f8e50f1fp-55, --0x1p-1, --0x1.71deef9940631p-3, --0x1.771e75f037261p-1, --0x1.5cfce8d84068fp-56, --0x1p-1, --0x1.6d42c993dd121p-3, --0x1.782fb1b90b35bp-1, -0x1.3e46c1dfd001cp-55, --0x1p-1, --0x1.68a34a975c941p-3, --0x1.79400574f55e5p-1, -0x1.0adadbdb4c65ap-55, --0x1p-1, --0x1.6400757dc8f7dp-3, --0x1.7a4f707bf97d2p-1, --0x1.3c9751b491eafp-55, --0x1p-1, --0x1.5f5a4d233b27fp-3, --0x1.7b5df226aafafp-1, -0x1.0f537acdf0ad7p-56, --0x1p-1, --0x1.5ab0d465d927ap-3, --0x1.7c6b89ce2d333p-1, -0x1.cfd628084982cp-56, --0x1p-1, --0x1.56040e25d44ddp-3, --0x1.7d7836cc33db2p-1, --0x1.162715ef03f85p-56, --0x1p-1, --0x1.5153fd45677efp-3, --0x1.7e83f87b03686p-1, --0x1.b61a8ccabad6p-57, --0x1p-1, --0x1.4ca0a4a8d5657p-3, --0x1.7f8ece3571771p-1, -0x1.9c8d8ce93c917p-55, --0x1p-1, --0x1.47ea073666a98p-3, --0x1.8098b756e52fap-1, --0x1.9136e834b4707p-55, --0x1p-1, --0x1.433027d66826dp-3, --0x1.81a1b33b57accp-1, -0x1.5dea12d66bb66p-55, --0x1p-1, --0x1.3e73097329219p-3, --0x1.82a9c13f545ffp-1, -0x1.65e87a7a8cde9p-56, --0x1p-1, --0x1.39b2aef8f97a4p-3, --0x1.83b0e0bff976ep-1, -0x1.6f420f8ea3475p-56, --0x1p-1, --0x1.34ef1b5627dfdp-3, --0x1.84b7111af83fap-1, -0x1.63a47df0b21bap-55, --0x1p-1, --0x1.3028517b0001p-3, --0x1.85bc51ae958ccp-1, --0x1.45ba6478086ccp-55, --0x1p-1, --0x1.2b5e5459c8bc3p-3, --0x1.86c0a1d9aa195p-1, --0x1.84564f09c3726p-59, --0x1p-1, --0x1.269126e6c24e3p-3, --0x1.87c400fba2ebfp-1, -0x1.2dabc0c3f64cdp-55, --0x1p-1, --0x1.21c0cc18247fcp-3, --0x1.88c66e7481ba1p-1, -0x1.5c6228970cf35p-56, --0x1p-1, --0x1.1ced46e61cd1cp-3, --0x1.89c7e9a4dd4aap-1, --0x1.db6ea04a8678fp-55, --0x1p-1, --0x1.18169a4acca89p-3, --0x1.8ac871ede1d88p-1, -0x1.9afaa5b7cfc55p-55, --0x1p-1, --0x1.133cc94247758p-3, --0x1.8bc806b151741p-1, -0x1.2c5e12ed1336dp-55, --0x1p-1, --0x1.0e5fd6ca90dffp-3, --0x1.8cc6a75184655p-1, -0x1.e18b3657e2285p-55, --0x1p-1, --0x1.097fc5e39aec5p-3, --0x1.8dc45331698ccp-1, --0x1.1d9fcd83634d7p-57, --0x1p-1, --0x1.049c998f44231p-3, --0x1.8ec109b486c49p-1, -0x1.cb2a3eb6af617p-56, --0x1p-1, --0x1.ff6ca9a2ab6a2p-4, --0x1.8fbcca3ef940dp-1, -0x1.6dfa99c86f2f1p-57, --0x1p-1, --0x1.f599f55f034p-4, --0x1.90b7943575efep-1, --0x1.4ecb0c5273706p-57, --0x1p-1, --0x1.ebc11c62c1a1ep-4, --0x1.91b166fd49da2p-1, -0x1.3be953a7fe996p-57, --0x1p-1, --0x1.e1e224c0e28bdp-4, --0x1.92aa41fc5a815p-1, -0x1.68f89e2d23db7p-57, --0x1p-1, --0x1.d7fd1490285cap-4, --0x1.93a22499263fbp-1, --0x1.3d419a920df0bp-55, --0x1p-1, --0x1.ce11f1eb18148p-4, --0x1.94990e3ac4a6cp-1, --0x1.a95328edeb3e6p-56, --0x1p-1, --0x1.c420c2eff590ep-4, --0x1.958efe48e6dd7p-1, -0x1.561335da0f4e7p-55, --0x1p-1, --0x1.ba298dc0bfc6bp-4, --0x1.9683f42bd7fe1p-1, -0x1.11bad933c835ep-57, --0x1p-1, --0x1.b02c58832cf96p-4, --0x1.9777ef4c7d742p-1, -0x1.15479a240665ep-55, --0x1p-1, --0x1.a6292960a6f0bp-4, --0x1.986aef1457594p-1, -0x1.af03e318f38fcp-55, --0x1p-1, --0x1.9c200686472b5p-4, --0x1.995cf2ed80d22p-1, --0x1.7783e907fbd7bp-56, --0x1p-1, --0x1.9210f624d30fbp-4, --0x1.9a4dfa42b06b2p-1, -0x1.829b6b8b1c947p-56, --0x1p-1, --0x1.87fbfe70b81a7p-4, --0x1.9b3e047f38741p-1, -0x1.30ee286712474p-55, --0x1p-1, --0x1.7de125a2080a9p-4, --0x1.9c2d110f075c2p-1, --0x1.d9c9f1c8c30dp-55, --0x1p-1, --0x1.73c071f4750b5p-4, --0x1.9d1b1f5ea80d5p-1, --0x1.c5fadd5ffb36fp-55, --0x1p-1, --0x1.6999e9a74ddbep-4, --0x1.9e082edb42472p-1, --0x1.5809a4e121e22p-57, --0x1p-1, --0x1.5f6d92fd79f5p-4, --0x1.9ef43ef29af94p-1, --0x1.b1dfcb60445c2p-56, --0x1p-1, --0x1.553b743d75acp-4, --0x1.9fdf4f13149dep-1, --0x1.1e6d79006ec09p-55, --0x1p-1, --0x1.4b0393b14e541p-4, --0x1.a0c95eabaf937p-1, -0x1.e0ca3acbd049ap-55, --0x1p-1, --0x1.40c5f7a69e5cep-4, --0x1.a1b26d2c0a75ep-1, --0x1.30ef431d627a6p-57, --0x1p-1, --0x1.3682a66e896f5p-4, --0x1.a29a7a0462782p-1, -0x1.128bb015df175p-56, --0x1p-1, --0x1.2c39a65db8881p-4, --0x1.a38184a593bc6p-1, -0x1.bc92c5bd2d288p-55, --0x1p-1, --0x1.21eafdcc560fap-4, --0x1.a4678c8119ac8p-1, --0x1.1b4c0dd3f212ap-55, --0x1p-1, --0x1.1796b31609f0cp-4, --0x1.a54c91090f523p-1, --0x1.184300fd1c1cep-56, --0x1p-1, --0x1.0d3ccc99f5ac6p-4, --0x1.a63091b02fae2p-1, -0x1.e911152248d1p-56, --0x1p-1, --0x1.02dd50bab06b2p-4, --0x1.a7138de9d60f5p-1, -0x1.f1ab82a9c5f2dp-55, --0x1p-1, --0x1.f0f08bbc861afp-5, --0x1.a7f58529fe69dp-1, -0x1.97a441584a179p-55, --0x1p-1, --0x1.dc1b64dc48722p-5, --0x1.a8d676e545ad2p-1, -0x1.b11dcce2e74bdp-59, --0x1p-1, --0x1.c73b39ae68c87p-5, --0x1.a9b66290ea1a3p-1, --0x1.9f630e8b6dac8p-60, --0x1p-1, --0x1.b250171373be9p-5, --0x1.aa9547a2cb98ep-1, --0x1.87d00ae97abaap-60, --0x1p-1, --0x1.9d5a09f2b9b7fp-5, --0x1.ab7325916c0d4p-1, --0x1.a8b8c85baaa9bp-55, --0x1p-1, --0x1.88591f3a46e4dp-5, --0x1.ac4ffbd3efac8p-1, -0x1.818504103fa16p-56, --0x1p-1, --0x1.734d63dedb48ap-5, --0x1.ad2bc9e21d511p-1, -0x1.47fbe07bea548p-55, --0x1p-1, --0x1.5e36e4dbe2bc2p-5, --0x1.ae068f345ecefp-1, -0x1.33934c4029a4cp-56, --0x1p-1, --0x1.4915af336ceb4p-5, --0x1.aee04b43c1474p-1, -0x1.3a79a438bf8ccp-55, --0x1p-1, --0x1.33e9cfee254edp-5, --0x1.afb8fd89f57b6p-1, --0x1.1ced12d2899b8p-60, --0x1p-1, --0x1.1eb3541b4b228p-5, --0x1.b090a581502p-1, -0x1.926da300ffccep-55, --0x1p-1, --0x1.097248d0a956ap-5, --0x1.b16742a4ca2f5p-1, -0x1.ba70972b80438p-55, --0x1p-1, --0x1.e84d76551cfb2p-6, --0x1.b23cd470013b4p-1, --0x1.5a1bb35ad6d2ep-56, --0x1p-1, --0x1.bda17097896b4p-6, --0x1.b3115a5f37bf3p-1, --0x1.dde2726e34fe1p-55, --0x1p-1, --0x1.92e09abb131d4p-6, --0x1.b3e4d3ef55712p-1, -0x1.eb6b8bf11a493p-55, --0x1p-1, --0x1.680b0f1f0bd73p-6, --0x1.b4b7409de7925p-1, --0x1.f4e257bde73d8p-56, --0x1p-1, --0x1.3d20e82f8bc1p-6, --0x1.b5889fe921405p-1, -0x1.df49b307c8602p-57, --0x1p-1, --0x1.1222406561182p-6, --0x1.b658f14fdbc47p-1, --0x1.52b5308f397dep-57, --0x1p-1, --0x1.ce1e648bffb66p-7, --0x1.b728345196e3ep-1, -0x1.bc69f324e6d61p-55, --0x1p-1, --0x1.77cfb0c6e2db8p-7, --0x1.b7f6686e792e9p-1, --0x1.87665bfea06aap-55, --0x1p-1, --0x1.21589ab88869cp-7, --0x1.b8c38d27504e9p-1, -0x1.1529abff40e45p-55, --0x1p-1, --0x1.9572af6decac8p-8, --0x1.b98fa1fd9155ep-1, --0x1.5559034fe85a4p-55, --0x1p-1, --0x1.cfc874c3eb6d9p-9, --0x1.ba5aa673590d2p-1, --0x1.7ea4e370753b6p-55, --0x1p-1, --0x1.d0320ae0b8293p-11, --0x1.bb249a0b6c40dp-1, -0x1.d6318ee919f7ap-58, --0x1p-1, -0x1.d09b418edf04ap-10, --0x1.bbed7c49380eap-1, --0x1.beacbd88500b4p-59, --0x1p-1, -0x1.22a28f6cb488bp-8, --0x1.bcb54cb0d2327p-1, --0x1.410923c55523ep-62, --0x1p-1, -0x1.d16c901d95181p-8, --0x1.bd7c0ac6f952ap-1, -0x1.825a732ac700ap-55, --0x1p-1, -0x1.4042335264ba3p-7, --0x1.be41b611154c1p-1, -0x1.fdcdad3a6877ep-55, --0x1p-1, -0x1.97f4d3805f318p-7, --0x1.bf064e15377ddp-1, --0x1.2156026a1e028p-57, --0x1p-1, -0x1.efcdf2801004ap-7, --0x1.bfc9d25a1b147p-1, -0x1.51bf4ee01357p-61, --0x1p-1, -0x1.23e6ad10872a7p-6, --0x1.c08c426725549p-1, --0x1.b157fd80e2946p-58, --0x1p-1, -0x1.4ff96a0da9dfbp-6, --0x1.c14d9dc465e57p-1, --0x1.ce36b64c7f3ccp-55, --0x1p-1, -0x1.7c1f1507aeec3p-6, --0x1.c20de3fa971bp-1, -0x1.b4ca2bab1322cp-55, --0x1p-1, -0x1.a85792c327db2p-6, --0x1.c2cd14931e3f1p-1, --0x1.2ce2f9d4600f5p-56, --0x1p-1, -0x1.d4a2c7f909c4ep-6, --0x1.c38b2f180bdb1p-1, -0x1.6e0b1757c8d07p-56, --0x1p-1, -0x1.00804cab5f113p-5, --0x1.c44833141c004p-1, --0x1.23e0521df01a2p-56, --0x1p-1, -0x1.16b875bf19d4p-5, --0x1.c5042012b6907p-1, -0x1.5c058dd8eaba5p-57, --0x1p-1, -0x1.2cf9d182f7939p-5, --0x1.c5bef59fef85ap-1, -0x1.f0a406c8b7468p-58, --0x1p-1, -0x1.4344523c8e3b5p-5, --0x1.c678b3488739bp-1, --0x1.d86cac7c5ff5bp-57, --0x1p-1, -0x1.5997ea2bcfb19p-5, --0x1.c7315899eaad7p-1, -0x1.9be5dcd047da7p-57, --0x1p-1, -0x1.6ff48b8b1252ap-5, --0x1.c7e8e52233cf3p-1, --0x1.b2ad324aa35c1p-57, --0x1p-1, -0x1.865a288f196fap-5, --0x1.c89f587029c13p-1, --0x1.588358ed6e78fp-58, --0x1p-1, -0x1.9cc8b3671dd0fp-5, --0x1.c954b213411f5p-1, -0x1.2fb761e946603p-58, --0x1p-1, -0x1.b3401e3cd63bbp-5, --0x1.ca08f19b9c449p-1, -0x1.431e0a5a737fdp-56, --0x1p-1, -0x1.c9c05b347ffabp-5, --0x1.cabc169a0b9p-1, --0x1.c42d3e10851d1p-55, --0x1p-1, -0x1.e0495c6ce76b5p-5, --0x1.cb6e20a00da99p-1, -0x1.4fb24b5194c1bp-55, --0x1p-1, -0x1.f6db13ff708cbp-5, --0x1.cc1f0f3fcfc5cp-1, --0x1.e57613b68f6abp-56, --0x1p-1, -0x1.06baba000fc9bp-4, --0x1.cccee20c2deap-1, -0x1.d3116ae0e69e4p-55, --0x1p-1, -0x1.120c373ed0bfbp-4, --0x1.cd7d9898b32f6p-1, -0x1.f2fa062496738p-57, --0x1p-1, -0x1.1d61fac0aa5b2p-4, --0x1.ce2b32799a06p-1, -0x1.631d457e46317p-56, --0x1p-1, -0x1.28bbfd87a8cffp-4, --0x1.ced7af43cc773p-1, -0x1.e7b6bb5ab58aep-58, --0x1p-1, -0x1.341a389339a36p-4, --0x1.cf830e8ce467bp-1, -0x1.7b9202780d49dp-55, --0x1p-1, -0x1.3f7ca4e02ffdcp-4, --0x1.d02d4feb2bd92p-1, --0x1.195ff41bc55fep-55, --0x1p-1, -0x1.4ae33b68c8fdcp-4, --0x1.d0d672f59d2b9p-1, -0x1.c83009f0c39dep-55, --0x1p-1, -0x1.564df524b00dap-4, --0x1.d17e7743e35dcp-1, -0x1.101da3540130ap-58, --0x1p-1, -0x1.61bccb0903395p-4, --0x1.d2255c6e5a4e1p-1, -0x1.d129a71ecafc9p-55, --0x1p-1, -0x1.6d2fb6085786ep-4, --0x1.d2cb220e0ef9fp-1, -0x1.f07656d4e6652p-56, --0x1p-1, -0x1.78a6af12bd501p-4, --0x1.d36fc7bcbfbdcp-1, -0x1.ba196d95a177dp-55, --0x1p-1, -0x1.8421af15c49d7p-4, --0x1.d4134d14dc93ap-1, -0x1.4ef5295d25af2p-55, --0x1p-1, -0x1.8fa0aefc81837p-4, --0x1.d4b5b1b187524p-1, -0x1.f56be6b42b76dp-57, --0x1p-1, -0x1.9b23a7af90805p-4, --0x1.d556f52e93eb1p-1, -0x1.80ed9233a963p-55, --0x1p-1, -0x1.a6aa92151adc3p-4, --0x1.d5f7172888a7fp-1, -0x1.68663e2225755p-55, --0x1p-1, -0x1.b2356710db0a3p-4, --0x1.d696173c9e68bp-1, -0x1.e8c61c6393d55p-56, --0x1p-1, -0x1.bdc41f84210bbp-4, --0x1.d733f508c0dffp-1, -0x1.007928e770cd5p-55, --0x1p-1, -0x1.c956b44dd6d41p-4, --0x1.d7d0b02b8ecf9p-1, --0x1.800f4ce65cd6ep-55, --0x1p-1, -0x1.d4ed1e4a84aefp-4, --0x1.d86c48445a44fp-1, --0x1.e8813c023d71fp-55, --0x1p-1, -0x1.e087565455a75p-4, --0x1.d906bcf328d46p-1, --0x1.457e610231ac2p-56, --0x1p-1, -0x1.ec2555431bf03p-4, --0x1.d9a00dd8b3d46p-1, --0x1.bea0e4bac8e16p-58, --0x1p-1, -0x1.f7c713ec554fp-4, --0x1.da383a9668988p-1, -0x1.5811000b39d84p-55, --0x1p-1, -0x1.01b6459197c38p-3, --0x1.dacf42ce68ab9p-1, -0x1.fe8d76efdf896p-56, --0x1p-1, -0x1.078ad9dc46632p-3, --0x1.db6526238a09bp-1, -0x1.adee7eae6946p-56, --0x1p-1, -0x1.0d61433d840a4p-3, --0x1.dbf9e4395759ap-1, --0x1.d8ff7350f75fdp-55, --0x1p-1, -0x1.13397e1b7ce13p-3, --0x1.dc8d7cb41026p-1, --0x1.6b7872773830dp-56, --0x1p-1, -0x1.191386db3dedcp-3, --0x1.dd1fef38a915ap-1, -0x1.782f169e17f3bp-55, --0x1p-1, -0x1.1eef59e0b74c3p-3, --0x1.ddb13b6ccc23cp-1, --0x1.83c37c6107db3p-55, --0x1p-1, -0x1.24ccf38ebe694p-3, --0x1.de4160f6d8d81p-1, --0x1.9bf11cc5f8776p-55, --0x1p-1, -0x1.2aac5047103d3p-3, --0x1.ded05f7de47dap-1, -0x1.2cc4c1f8ba966p-55, --0x1p-1, --0x1.9ee5272b58f2ap-4, --0x1.df5e36a9ba59cp-1, -0x1.e01f8bceb43d3p-57, --0x1p-2, --0x1.931f774fc9f18p-4, --0x1.dfeae622dbe2bp-1, -0x1.514ea88425567p-55, --0x1p-2, --0x1.875657223080ap-4, --0x1.e0766d9280f54p-1, --0x1.f44c969cf62e3p-55, --0x1p-2, --0x1.7b89cde7a9a4dp-4, --0x1.e100cca2980acp-1, -0x1.02d182acdf825p-57, --0x1p-2, --0x1.6fb9e2e76ced8p-4, --0x1.e18a02fdc66d9p-1, --0x1.07e272abd88cfp-55, --0x1p-2, --0x1.63e69d6ac7f74p-4, --0x1.e212104f686e5p-1, -0x1.014c76c126527p-55, --0x1p-2, --0x1.581004bd19ed2p-4, --0x1.e298f4439197ap-1, --0x1.e84e601038eb2p-57, --0x1p-2, --0x1.4c36202bcf08ep-4, --0x1.e31eae870ce25p-1, -0x1.bc7094538d678p-56, --0x1p-2, --0x1.4058f7065c11ep-4, --0x1.e3a33ec75ce85p-1, --0x1.45089cd46bbb8p-57, --0x1p-2, --0x1.3478909e39da9p-4, --0x1.e426a4b2bc17ep-1, --0x1.a873889744882p-55, --0x1p-2, --0x1.2894f446e0bccp-4, --0x1.e4a8dff81ce5ep-1, --0x1.43578776c0f46p-55, --0x1p-2, --0x1.1cae2955c414fp-4, --0x1.e529f04729ffcp-1, --0x1.9075d6e6dfc8bp-55, --0x1p-2, --0x1.10c437224dbc2p-4, --0x1.e5a9d550467d3p-1, --0x1.7d431be53f92fp-56, --0x1p-2, --0x1.04d72505d9805p-4, --0x1.e6288ec48e112p-1, -0x1.16b56f2847754p-57, --0x1p-2, --0x1.f1cdf4b76138bp-5, --0x1.e6a61c55d53a7p-1, --0x1.660d981acdcf7p-56, --0x1p-2, --0x1.d9e77d020a5bcp-5, --0x1.e7227db6a9744p-1, --0x1.2128794da5a5p-55, --0x1p-2, --0x1.c1faf1a9db555p-5, --0x1.e79db29a5165ap-1, -0x1.75e710aca58p-56, --0x1p-2, --0x1.aa086170c0a8ep-5, --0x1.e817bab4cd10dp-1, -0x1.d0afe686b5e0ap-56, --0x1p-2, --0x1.920fdb1c5d578p-5, --0x1.e89095bad6025p-1, -0x1.5a4cc0fcbccap-55, --0x1p-2, --0x1.7a116d7601c35p-5, --0x1.e9084361df7f2p-1, --0x1.cdfc7ce9dc3e9p-55, --0x1p-2, --0x1.620d274aa2903p-5, --0x1.e97ec36016b3p-1, --0x1.5bc48562557d3p-55, --0x1p-2, --0x1.4a03176acf82dp-5, --0x1.e9f4156c62ddap-1, --0x1.760b1e2e3f81ep-55, --0x1p-2, --0x1.31f34caaaa5d2p-5, --0x1.ea68393e658p-1, -0x1.467259bb7b556p-56, --0x1p-2, --0x1.19ddd5e1ddb8bp-5, --0x1.eadb2e8e7a88ep-1, -0x1.92ec52ea226a3p-55, --0x1p-2, --0x1.01c2c1eb93deep-5, --0x1.eb4cf515b8811p-1, --0x1.95da1ba97ec5ep-57, --0x1p-2, --0x1.d3443f4cdb3ddp-6, --0x1.ebbd8c8df0b74p-1, --0x1.c6c8c615e7277p-56, --0x1p-2, --0x1.a2f7fbe8f2436p-6, --0x1.ec2cf4b1af6b2p-1, --0x1.34ee3f2caa62dp-59, --0x1p-2, --0x1.72a0d77651772p-6, --0x1.ec9b2d3c3bf84p-1, --0x1.19119d358de05p-56, --0x1p-2, --0x1.423eefc693785p-6, --0x1.ed0835e999009p-1, --0x1.499d188aa32fap-57, --0x1p-2, --0x1.11d262b1f6776p-6, --0x1.ed740e7684963p-1, --0x1.e82c791f59cc2p-56, --0x1p-2, --0x1.c2b69c2e939b5p-7, --0x1.eddeb6a078651p-1, -0x1.3b579af740a74p-55, --0x1p-2, --0x1.61b39fb7b7202p-7, --0x1.ee482e25a9dbcp-1, -0x1.b6066ef81af2ap-56, --0x1p-2, --0x1.009c0bd6cc3cbp-7, --0x1.eeb074c50a544p-1, --0x1.d925f656c43b4p-55, --0x1p-2, --0x1.3ee038dff6b8p-8, --0x1.ef178a3e473c2p-1, --0x1.6310a67fe774fp-55, --0x1p-2, --0x1.f1806b9fdd1afp-10, --0x1.ef7d6e51ca3cp-1, -0x1.a3c67c3d3f604p-55, --0x1p-2, -0x1.191f2900903a6p-10, --0x1.efe220c0b95ecp-1, --0x1.c853b7bf7e0cdp-55, --0x1p-2, -0x1.0916fe858ffcdp-8, --0x1.f045a14cf738cp-1, -0x1.a52c44f45216cp-55, --0x1p-2, -0x1.cc0d09bd41caap-8, --0x1.f0a7efb9230d7p-1, --0x1.52c7adc6b4989p-56, --0x1p-2, -0x1.4794b9d21cb87p-7, --0x1.f1090bc898f5fp-1, -0x1.baa64ab102a93p-55, --0x1p-2, -0x1.a935e1efe5e4bp-7, --0x1.f168f53f7205dp-1, -0x1.26a6c1f015601p-57, --0x1p-2, -0x1.0574e07f7b332p-6, --0x1.f1c7abe284708p-1, --0x1.504b80c8a63fcp-55, --0x1p-2, -0x1.36580d5d5e775p-6, --0x1.f2252f7763adap-1, -0x1.20cb81c8d94abp-55, --0x1p-2, -0x1.67445969a108ep-6, --0x1.f2817fc4609cep-1, -0x1.dd1f8eaf65689p-55, --0x1p-2, -0x1.9839a676a6bcfp-6, --0x1.f2dc9c9089a9dp-1, --0x1.5407460bdfc07p-59, --0x1p-2, -0x1.c937d65145919p-6, --0x1.f33685a3aaefp-1, --0x1.eb78685d850f8p-56, --0x1p-2, -0x1.fa3ecac0d84e8p-6, --0x1.f38f3ac64e589p-1, -0x1.d7bafb51f72e6p-56, --0x1p-2, -0x1.15a732c3a894dp-5, --0x1.f3e6bbc1bbc65p-1, --0x1.5774bb7e8a21ep-57, --0x1p-2, -0x1.2e334430a6376p-5, --0x1.f43d085ff92ddp-1, -0x1.8fde71e361c05p-55, --0x1p-2, -0x1.46c38a8311952p-5, --0x1.f492206bcabb4p-1, --0x1.d1e921bbe3bd3p-55, --0x1p-2, -0x1.5f57f693feebep-5, --0x1.f4e603b0b2f2dp-1, -0x1.8ee01e695ac05p-56, --0x1p-2, -0x1.77f07939f3897p-5, --0x1.f538b1faf2d07p-1, -0x1.5f7cd5099519cp-59, --0x1p-2, -0x1.908d0348ef266p-5, --0x1.f58a2b1789e84p-1, --0x1.1f4a188aa368p-56, --0x1p-2, -0x1.a92d859275418p-5, --0x1.f5da6ed43685dp-1, -0x1.536fc33bf9dd8p-55, --0x1p-2, -0x1.c1d1f0e5967d5p-5, --0x1.f6297cff75cbp-1, --0x1.562172a361fd3p-56, --0x1p-2, -0x1.da7a360ef9fefp-5, --0x1.f677556883ceep-1, --0x1.ef696a8d070f4p-57, --0x1p-2, -0x1.f32645d8e6ce9p-5, --0x1.f6c3f7df5bbb7p-1, --0x1.8561ce9d5ef5bp-56, --0x1p-2, -0x1.05eb0885a69c9p-4, --0x1.f70f6434b7eb7p-1, --0x1.1775df66f0ec4p-56, --0x1p-2, -0x1.1244c435e819dp-4, --0x1.f7599a3a12077p-1, --0x1.84f31d743195cp-55, --0x1p-2, -0x1.1ea04e5ee7601p-4, --0x1.f7a299c1a322ap-1, --0x1.6e7190c94899ep-56, --0x1p-2, -0x1.2afd9f6136a9cp-4, --0x1.f7ea629e63d6ep-1, --0x1.ba92d57ebfeddp-55, --0x1p-2, --0x1.9146a0c760c35p-5, --0x1.f830f4a40c60cp-1, --0x1.8528676925128p-57, --0x1p-3, --0x1.78851122cff19p-5, --0x1.f8764fa714ba9p-1, --0x1.ab256778ffcb6p-56, --0x1p-3, --0x1.5fc0219532f79p-5, --0x1.f8ba737cb4b78p-1, -0x1.da71f96d5a49cp-55, --0x1p-3, --0x1.46f7e165f17c8p-5, --0x1.f8fd5ffae41dbp-1, -0x1.8cfd77fd970d2p-56, --0x1p-3, --0x1.2e2c5fde7ea22p-5, --0x1.f93f14f85ac08p-1, -0x1.cfd153e9a9c1ap-55, --0x1p-3, --0x1.155dac4a4f967p-5, --0x1.f97f924c9099bp-1, -0x1.e2ae0eea5963bp-55, --0x1p-3, --0x1.f917abeda4499p-6, --0x1.f9bed7cfbde29p-1, -0x1.b35b1f9bcf70bp-56, --0x1p-3, --0x1.c76dd866c689ep-6, --0x1.f9fce55adb2c8p-1, --0x1.f2a06fab9f9d1p-56, --0x1p-3, --0x1.95bdfca28b53ap-6, --0x1.fa39bac7a1791p-1, -0x1.94f388f1b4e1ep-57, --0x1p-3, --0x1.64083747309d1p-6, --0x1.fa7557f08a517p-1, -0x1.7a0a8ca13571fp-55, --0x1p-3, --0x1.324ca6fe9a04bp-6, --0x1.faafbcb0cfddcp-1, -0x1.e349cb4d3e866p-55, --0x1p-3, --0x1.008b6a763de76p-6, --0x1.fae8e8e46cfbbp-1, -0x1.3a9e414732d97p-56, --0x1p-3, --0x1.9d8940be24e74p-7, --0x1.fb20dc681d54dp-1, -0x1.ff148ec7c5fafp-55, --0x1p-3, --0x1.39f0cedaf576bp-7, --0x1.fb5797195d741p-1, --0x1.1bfac7397cc08p-56, --0x1p-3, --0x1.ac9b7964cf0bap-8, --0x1.fb8d18d66adb7p-1, -0x1.d0b66224cce2ep-56, --0x1p-3, --0x1.ca811eea0c749p-9, --0x1.fbc1617e44186p-1, -0x1.58ec496dc4ecbp-59, --0x1p-3, --0x1.dd15adf70b65ap-12, --0x1.fbf470f0a8d88p-1, -0x1.6bb200d1d70b7p-55, --0x1p-3, -0x1.536352ad19e39p-9, --0x1.fc26470e19fd3p-1, --0x1.1ec8668ecaceep-55, --0x1p-3, -0x1.7148021b55c15p-8, --0x1.fc56e3b7d9af6p-1, -0x1.03ff7a673d3bdp-56, --0x1p-3, -0x1.1c789a28b01b7p-7, --0x1.fc8646cfeb721p-1, --0x1.3143dc43a9b9dp-55, --0x1p-3, -0x1.80566267c11f6p-7, --0x1.fcb4703914354p-1, --0x1.126aa7d51b25cp-55, --0x1p-3, -0x1.e43d1c309e958p-7, --0x1.fce15fd6da67bp-1, -0x1.5dd6f830d4c09p-56, --0x1p-3, -0x1.241644f1c26cep-6, --0x1.fd0d158d86087p-1, --0x1.9705a7b864883p-55, --0x1p-3, -0x1.561236eda8ff2p-6, --0x1.fd37914220b84p-1, --0x1.52e9d7b772791p-55, --0x1p-3, -0x1.88124536d5e8fp-6, --0x1.fd60d2da75c9ep-1, --0x1.36dedb314f0ebp-58, --0x1p-3, -0x1.ba1650f592f5p-6, --0x1.fd88da3d12526p-1, -0x1.87df6378811c7p-55, --0x1p-3, -0x1.ec1e3b4fb3d7ep-6, --0x1.fdafa7514538cp-1, --0x1.d97c45ca4d398p-59, --0x1p-3, -0x1.0f14f2b4549bdp-5, --0x1.fdd539ff1f456p-1, -0x1.ab13cbbec1781p-56, --0x1p-3, -0x1.281c9830c9dafp-5, --0x1.fdf9922f73307p-1, --0x1.a5e0abd3a9b65p-56, --0x1p-3, --0x1.7db402a6a9063p-6, --0x1.fe1cafcbd5b09p-1, --0x1.a23e3202a884ep-57, --0x1p-4, --0x1.4b9dd29353428p-6, --0x1.fe3e92be9d886p-1, --0x1.afeb2e264d46bp-57, --0x1p-4, --0x1.19845e49c8257p-6, --0x1.fe5f3af2e394p-1, --0x1.b213f18c9cf17p-55, --0x1p-4, --0x1.cecf8962d14c8p-7, --0x1.fe7ea85482d6p-1, --0x1.34b085c1828f7p-56, --0x1p-4, --0x1.6a9049670cfaep-7, --0x1.fe9cdad01883ap-1, --0x1.521ecd0c67e35p-57, --0x1p-4, --0x1.064b3a76a2264p-7, --0x1.feb9d2530410fp-1, --0x1.9d429eeda9bb9p-58, --0x1p-4, --0x1.440134d709b28p-8, --0x1.fed58ecb673c4p-1, -0x1.e6e462a7ae686p-56, --0x1p-4, --0x1.ed853918c18ecp-10, --0x1.fef0102826191p-1, --0x1.3c3ea4f30addap-56, --0x1p-4, -0x1.35230c0fbe402p-10, --0x1.ff095658e71adp-1, --0x1.01a8ce18a4b9ep-55, --0x1p-4, -0x1.15fc833fb89b8p-8, --0x1.ff21614e131edp-1, -0x1.de692a167353p-55, --0x1p-4, -0x1.deb9769f940eap-8, --0x1.ff3830f8d575cp-1, -0x1.95e1e79d335f7p-56, --0x1p-4, -0x1.53bf90a81f3a5p-7, --0x1.ff4dc54b1bed3p-1, -0x1.c1169ccd1e92ep-55, --0x1p-4, -0x1.b82683bc89fbp-7, --0x1.ff621e3796d7ep-1, -0x1.c57bc2e24aa15p-57, --0x1p-4, -0x1.0e48ab4f172f4p-6, --0x1.ff753bb1b9164p-1, -0x1.7c330129f56efp-56, --0x1p-4, --0x1.7f0034a43350ep-7, --0x1.ff871dadb81dfp-1, --0x1.8b1c676208aa4p-56, --0x1p-5, --0x1.1a8e5bfe185e4p-7, --0x1.ff97c4208c014p-1, --0x1.52ab2b947e843p-57, --0x1p-5, --0x1.6c32baca2ae69p-8, --0x1.ffa72effef75dp-1, -0x1.8b4cdcdb25956p-55, --0x1p-5, --0x1.4685db42c17ebp-9, --0x1.ffb55e425fdaep-1, --0x1.6da7ec781c225p-55, --0x1p-5, -0x1.2d919c5c61fep-11, --0x1.ffc251df1d3f8p-1, --0x1.7a7d209f32d43p-56, --0x1p-5, -0x1.dd58598d6271cp-9, --0x1.ffce09ce2a679p-1, -0x1.7bd62ab5ee228p-55, --0x1p-5, -0x1.b7aa821726608p-8, --0x1.ffd886084cd0dp-1, -0x1.1354d4556e4cbp-55, --0x1p-5, --0x1.7f53487eac897p-8, --0x1.ffe1c6870cb77p-1, --0x1.89aa14768323ep-55, --0x1p-6, --0x1.6c9b5df1877eap-9, --0x1.ffe9cb44b51a1p-1, --0x1.5b43366df667p-56, --0x1p-6, -0x1.2bad2a8cd06bp-12, --0x1.fff0943c53bd1p-1, -0x1.47399f361d158p-55, --0x1p-6, -0x1.b78b80c84e1eep-9, --0x1.fff62169b92dbp-1, --0x1.5dda3c81fbd0dp-55, --0x1p-6, --0x1.6cb587284b817p-10, --0x1.fffa72c978c4fp-1, -0x1.22cb000328f91p-55, --0x1p-7, -0x1.b783c0663fe3cp-10, --0x1.fffd8858e8a92p-1, --0x1.359c71883bcf7p-55, --0x1p-7, -0x1.b781d04cd6d17p-11, --0x1.ffff621621d02p-1, -0x1.6acfcebc82813p-56, --0x1p-8, -0, --0x1p0, -0, -0, --0x1.b781d04cd6d17p-11, --0x1.ffff621621d02p-1, -0x1.6acfcebc82813p-56, -0x1p-8, --0x1.b783c0663fe3cp-10, --0x1.fffd8858e8a92p-1, --0x1.359c71883bcf7p-55, -0x1p-7, -0x1.6cb587284b817p-10, --0x1.fffa72c978c4fp-1, -0x1.22cb000328f91p-55, -0x1p-7, --0x1.b78b80c84e1eep-9, --0x1.fff62169b92dbp-1, --0x1.5dda3c81fbd0dp-55, -0x1p-6, --0x1.2bad2a8cd06bp-12, --0x1.fff0943c53bd1p-1, -0x1.47399f361d158p-55, -0x1p-6, -0x1.6c9b5df1877eap-9, --0x1.ffe9cb44b51a1p-1, --0x1.5b43366df667p-56, -0x1p-6, -0x1.7f53487eac897p-8, --0x1.ffe1c6870cb77p-1, --0x1.89aa14768323ep-55, -0x1p-6, --0x1.b7aa821726608p-8, --0x1.ffd886084cd0dp-1, -0x1.1354d4556e4cbp-55, -0x1p-5, --0x1.dd58598d6271cp-9, --0x1.ffce09ce2a679p-1, -0x1.7bd62ab5ee228p-55, -0x1p-5, --0x1.2d919c5c61fep-11, --0x1.ffc251df1d3f8p-1, --0x1.7a7d209f32d43p-56, -0x1p-5, -0x1.4685db42c17ebp-9, --0x1.ffb55e425fdaep-1, --0x1.6da7ec781c225p-55, -0x1p-5, -0x1.6c32baca2ae69p-8, --0x1.ffa72effef75dp-1, -0x1.8b4cdcdb25956p-55, -0x1p-5, -0x1.1a8e5bfe185e4p-7, --0x1.ff97c4208c014p-1, --0x1.52ab2b947e843p-57, -0x1p-5, -0x1.7f0034a43350ep-7, --0x1.ff871dadb81dfp-1, --0x1.8b1c676208aa4p-56, -0x1p-5, --0x1.0e48ab4f172f4p-6, --0x1.ff753bb1b9164p-1, -0x1.7c330129f56efp-56, -0x1p-4, --0x1.b82683bc89fbp-7, --0x1.ff621e3796d7ep-1, -0x1.c57bc2e24aa15p-57, -0x1p-4, --0x1.53bf90a81f3a5p-7, --0x1.ff4dc54b1bed3p-1, -0x1.c1169ccd1e92ep-55, -0x1p-4, --0x1.deb9769f940eap-8, --0x1.ff3830f8d575cp-1, -0x1.95e1e79d335f7p-56, -0x1p-4, --0x1.15fc833fb89b8p-8, --0x1.ff21614e131edp-1, -0x1.de692a167353p-55, -0x1p-4, --0x1.35230c0fbe402p-10, --0x1.ff095658e71adp-1, --0x1.01a8ce18a4b9ep-55, -0x1p-4, -0x1.ed853918c18ecp-10, --0x1.fef0102826191p-1, --0x1.3c3ea4f30addap-56, -0x1p-4, -0x1.440134d709b28p-8, --0x1.fed58ecb673c4p-1, -0x1.e6e462a7ae686p-56, -0x1p-4, -0x1.064b3a76a2264p-7, --0x1.feb9d2530410fp-1, --0x1.9d429eeda9bb9p-58, -0x1p-4, -0x1.6a9049670cfaep-7, --0x1.fe9cdad01883ap-1, --0x1.521ecd0c67e35p-57, -0x1p-4, -0x1.cecf8962d14c8p-7, --0x1.fe7ea85482d6p-1, --0x1.34b085c1828f7p-56, -0x1p-4, -0x1.19845e49c8257p-6, --0x1.fe5f3af2e394p-1, --0x1.b213f18c9cf17p-55, -0x1p-4, -0x1.4b9dd29353428p-6, --0x1.fe3e92be9d886p-1, --0x1.afeb2e264d46bp-57, -0x1p-4, -0x1.7db402a6a9063p-6, --0x1.fe1cafcbd5b09p-1, --0x1.a23e3202a884ep-57, -0x1p-4, --0x1.281c9830c9dafp-5, --0x1.fdf9922f73307p-1, --0x1.a5e0abd3a9b65p-56, -0x1p-3, --0x1.0f14f2b4549bdp-5, --0x1.fdd539ff1f456p-1, -0x1.ab13cbbec1781p-56, -0x1p-3, --0x1.ec1e3b4fb3d7ep-6, --0x1.fdafa7514538cp-1, --0x1.d97c45ca4d398p-59, -0x1p-3, --0x1.ba1650f592f5p-6, --0x1.fd88da3d12526p-1, -0x1.87df6378811c7p-55, -0x1p-3, --0x1.88124536d5e8fp-6, --0x1.fd60d2da75c9ep-1, --0x1.36dedb314f0ebp-58, -0x1p-3, --0x1.561236eda8ff2p-6, --0x1.fd37914220b84p-1, --0x1.52e9d7b772791p-55, -0x1p-3, --0x1.241644f1c26cep-6, --0x1.fd0d158d86087p-1, --0x1.9705a7b864883p-55, -0x1p-3, --0x1.e43d1c309e958p-7, --0x1.fce15fd6da67bp-1, -0x1.5dd6f830d4c09p-56, -0x1p-3, --0x1.80566267c11f6p-7, --0x1.fcb4703914354p-1, --0x1.126aa7d51b25cp-55, -0x1p-3, --0x1.1c789a28b01b7p-7, --0x1.fc8646cfeb721p-1, --0x1.3143dc43a9b9dp-55, -0x1p-3, --0x1.7148021b55c15p-8, --0x1.fc56e3b7d9af6p-1, -0x1.03ff7a673d3bdp-56, -0x1p-3, --0x1.536352ad19e39p-9, --0x1.fc26470e19fd3p-1, --0x1.1ec8668ecaceep-55, -0x1p-3, -0x1.dd15adf70b65ap-12, --0x1.fbf470f0a8d88p-1, -0x1.6bb200d1d70b7p-55, -0x1p-3, -0x1.ca811eea0c749p-9, --0x1.fbc1617e44186p-1, -0x1.58ec496dc4ecbp-59, -0x1p-3, -0x1.ac9b7964cf0bap-8, --0x1.fb8d18d66adb7p-1, -0x1.d0b66224cce2ep-56, -0x1p-3, -0x1.39f0cedaf576bp-7, --0x1.fb5797195d741p-1, --0x1.1bfac7397cc08p-56, -0x1p-3, -0x1.9d8940be24e74p-7, --0x1.fb20dc681d54dp-1, -0x1.ff148ec7c5fafp-55, -0x1p-3, -0x1.008b6a763de76p-6, --0x1.fae8e8e46cfbbp-1, -0x1.3a9e414732d97p-56, -0x1p-3, -0x1.324ca6fe9a04bp-6, --0x1.faafbcb0cfddcp-1, -0x1.e349cb4d3e866p-55, -0x1p-3, -0x1.64083747309d1p-6, --0x1.fa7557f08a517p-1, -0x1.7a0a8ca13571fp-55, -0x1p-3, -0x1.95bdfca28b53ap-6, --0x1.fa39bac7a1791p-1, -0x1.94f388f1b4e1ep-57, -0x1p-3, -0x1.c76dd866c689ep-6, --0x1.f9fce55adb2c8p-1, --0x1.f2a06fab9f9d1p-56, -0x1p-3, -0x1.f917abeda4499p-6, --0x1.f9bed7cfbde29p-1, -0x1.b35b1f9bcf70bp-56, -0x1p-3, -0x1.155dac4a4f967p-5, --0x1.f97f924c9099bp-1, -0x1.e2ae0eea5963bp-55, -0x1p-3, -0x1.2e2c5fde7ea22p-5, --0x1.f93f14f85ac08p-1, -0x1.cfd153e9a9c1ap-55, -0x1p-3, -0x1.46f7e165f17c8p-5, --0x1.f8fd5ffae41dbp-1, -0x1.8cfd77fd970d2p-56, -0x1p-3, -0x1.5fc0219532f79p-5, --0x1.f8ba737cb4b78p-1, -0x1.da71f96d5a49cp-55, -0x1p-3, -0x1.78851122cff19p-5, --0x1.f8764fa714ba9p-1, --0x1.ab256778ffcb6p-56, -0x1p-3, -0x1.9146a0c760c35p-5, --0x1.f830f4a40c60cp-1, --0x1.8528676925128p-57, -0x1p-3, --0x1.2afd9f6136a9cp-4, --0x1.f7ea629e63d6ep-1, --0x1.ba92d57ebfeddp-55, -0x1p-2, --0x1.1ea04e5ee7601p-4, --0x1.f7a299c1a322ap-1, --0x1.6e7190c94899ep-56, -0x1p-2, --0x1.1244c435e819dp-4, --0x1.f7599a3a12077p-1, --0x1.84f31d743195cp-55, -0x1p-2, --0x1.05eb0885a69c9p-4, --0x1.f70f6434b7eb7p-1, --0x1.1775df66f0ec4p-56, -0x1p-2, --0x1.f32645d8e6ce9p-5, --0x1.f6c3f7df5bbb7p-1, --0x1.8561ce9d5ef5bp-56, -0x1p-2, --0x1.da7a360ef9fefp-5, --0x1.f677556883ceep-1, --0x1.ef696a8d070f4p-57, -0x1p-2, --0x1.c1d1f0e5967d5p-5, --0x1.f6297cff75cbp-1, --0x1.562172a361fd3p-56, -0x1p-2, --0x1.a92d859275418p-5, --0x1.f5da6ed43685dp-1, -0x1.536fc33bf9dd8p-55, -0x1p-2, --0x1.908d0348ef266p-5, --0x1.f58a2b1789e84p-1, --0x1.1f4a188aa368p-56, -0x1p-2, --0x1.77f07939f3897p-5, --0x1.f538b1faf2d07p-1, -0x1.5f7cd5099519cp-59, -0x1p-2, --0x1.5f57f693feebep-5, --0x1.f4e603b0b2f2dp-1, -0x1.8ee01e695ac05p-56, -0x1p-2, --0x1.46c38a8311952p-5, --0x1.f492206bcabb4p-1, --0x1.d1e921bbe3bd3p-55, -0x1p-2, --0x1.2e334430a6376p-5, --0x1.f43d085ff92ddp-1, -0x1.8fde71e361c05p-55, -0x1p-2, --0x1.15a732c3a894dp-5, --0x1.f3e6bbc1bbc65p-1, --0x1.5774bb7e8a21ep-57, -0x1p-2, --0x1.fa3ecac0d84e8p-6, --0x1.f38f3ac64e589p-1, -0x1.d7bafb51f72e6p-56, -0x1p-2, --0x1.c937d65145919p-6, --0x1.f33685a3aaefp-1, --0x1.eb78685d850f8p-56, -0x1p-2, --0x1.9839a676a6bcfp-6, --0x1.f2dc9c9089a9dp-1, --0x1.5407460bdfc07p-59, -0x1p-2, --0x1.67445969a108ep-6, --0x1.f2817fc4609cep-1, -0x1.dd1f8eaf65689p-55, -0x1p-2, --0x1.36580d5d5e775p-6, --0x1.f2252f7763adap-1, -0x1.20cb81c8d94abp-55, -0x1p-2, --0x1.0574e07f7b332p-6, --0x1.f1c7abe284708p-1, --0x1.504b80c8a63fcp-55, -0x1p-2, --0x1.a935e1efe5e4bp-7, --0x1.f168f53f7205dp-1, -0x1.26a6c1f015601p-57, -0x1p-2, --0x1.4794b9d21cb87p-7, --0x1.f1090bc898f5fp-1, -0x1.baa64ab102a93p-55, -0x1p-2, --0x1.cc0d09bd41caap-8, --0x1.f0a7efb9230d7p-1, --0x1.52c7adc6b4989p-56, -0x1p-2, --0x1.0916fe858ffcdp-8, --0x1.f045a14cf738cp-1, -0x1.a52c44f45216cp-55, -0x1p-2, --0x1.191f2900903a6p-10, --0x1.efe220c0b95ecp-1, --0x1.c853b7bf7e0cdp-55, -0x1p-2, -0x1.f1806b9fdd1afp-10, --0x1.ef7d6e51ca3cp-1, -0x1.a3c67c3d3f604p-55, -0x1p-2, -0x1.3ee038dff6b8p-8, --0x1.ef178a3e473c2p-1, --0x1.6310a67fe774fp-55, -0x1p-2, -0x1.009c0bd6cc3cbp-7, --0x1.eeb074c50a544p-1, --0x1.d925f656c43b4p-55, -0x1p-2, -0x1.61b39fb7b7202p-7, --0x1.ee482e25a9dbcp-1, -0x1.b6066ef81af2ap-56, -0x1p-2, -0x1.c2b69c2e939b5p-7, --0x1.eddeb6a078651p-1, -0x1.3b579af740a74p-55, -0x1p-2, -0x1.11d262b1f6776p-6, --0x1.ed740e7684963p-1, --0x1.e82c791f59cc2p-56, -0x1p-2, -0x1.423eefc693785p-6, --0x1.ed0835e999009p-1, --0x1.499d188aa32fap-57, -0x1p-2, -0x1.72a0d77651772p-6, --0x1.ec9b2d3c3bf84p-1, --0x1.19119d358de05p-56, -0x1p-2, -0x1.a2f7fbe8f2436p-6, --0x1.ec2cf4b1af6b2p-1, --0x1.34ee3f2caa62dp-59, -0x1p-2, -0x1.d3443f4cdb3ddp-6, --0x1.ebbd8c8df0b74p-1, --0x1.c6c8c615e7277p-56, -0x1p-2, -0x1.01c2c1eb93deep-5, --0x1.eb4cf515b8811p-1, --0x1.95da1ba97ec5ep-57, -0x1p-2, -0x1.19ddd5e1ddb8bp-5, --0x1.eadb2e8e7a88ep-1, -0x1.92ec52ea226a3p-55, -0x1p-2, -0x1.31f34caaaa5d2p-5, --0x1.ea68393e658p-1, -0x1.467259bb7b556p-56, -0x1p-2, -0x1.4a03176acf82dp-5, --0x1.e9f4156c62ddap-1, --0x1.760b1e2e3f81ep-55, -0x1p-2, -0x1.620d274aa2903p-5, --0x1.e97ec36016b3p-1, --0x1.5bc48562557d3p-55, -0x1p-2, -0x1.7a116d7601c35p-5, --0x1.e9084361df7f2p-1, --0x1.cdfc7ce9dc3e9p-55, -0x1p-2, -0x1.920fdb1c5d578p-5, --0x1.e89095bad6025p-1, -0x1.5a4cc0fcbccap-55, -0x1p-2, -0x1.aa086170c0a8ep-5, --0x1.e817bab4cd10dp-1, -0x1.d0afe686b5e0ap-56, -0x1p-2, -0x1.c1faf1a9db555p-5, --0x1.e79db29a5165ap-1, -0x1.75e710aca58p-56, -0x1p-2, -0x1.d9e77d020a5bcp-5, --0x1.e7227db6a9744p-1, --0x1.2128794da5a5p-55, -0x1p-2, -0x1.f1cdf4b76138bp-5, --0x1.e6a61c55d53a7p-1, --0x1.660d981acdcf7p-56, -0x1p-2, -0x1.04d72505d9805p-4, --0x1.e6288ec48e112p-1, -0x1.16b56f2847754p-57, -0x1p-2, -0x1.10c437224dbc2p-4, --0x1.e5a9d550467d3p-1, --0x1.7d431be53f92fp-56, -0x1p-2, -0x1.1cae2955c414fp-4, --0x1.e529f04729ffcp-1, --0x1.9075d6e6dfc8bp-55, -0x1p-2, -0x1.2894f446e0bccp-4, --0x1.e4a8dff81ce5ep-1, --0x1.43578776c0f46p-55, -0x1p-2, -0x1.3478909e39da9p-4, --0x1.e426a4b2bc17ep-1, --0x1.a873889744882p-55, -0x1p-2, -0x1.4058f7065c11ep-4, --0x1.e3a33ec75ce85p-1, --0x1.45089cd46bbb8p-57, -0x1p-2, -0x1.4c36202bcf08ep-4, --0x1.e31eae870ce25p-1, -0x1.bc7094538d678p-56, -0x1p-2, -0x1.581004bd19ed2p-4, --0x1.e298f4439197ap-1, --0x1.e84e601038eb2p-57, -0x1p-2, -0x1.63e69d6ac7f74p-4, --0x1.e212104f686e5p-1, -0x1.014c76c126527p-55, -0x1p-2, -0x1.6fb9e2e76ced8p-4, --0x1.e18a02fdc66d9p-1, --0x1.07e272abd88cfp-55, -0x1p-2, -0x1.7b89cde7a9a4dp-4, --0x1.e100cca2980acp-1, -0x1.02d182acdf825p-57, -0x1p-2, -0x1.875657223080ap-4, --0x1.e0766d9280f54p-1, --0x1.f44c969cf62e3p-55, -0x1p-2, -0x1.931f774fc9f18p-4, --0x1.dfeae622dbe2bp-1, -0x1.514ea88425567p-55, -0x1p-2, -0x1.9ee5272b58f2ap-4, --0x1.df5e36a9ba59cp-1, -0x1.e01f8bceb43d3p-57, -0x1p-2, --0x1.2aac5047103d3p-3, --0x1.ded05f7de47dap-1, -0x1.2cc4c1f8ba966p-55, -0x1p-1, --0x1.24ccf38ebe694p-3, --0x1.de4160f6d8d81p-1, --0x1.9bf11cc5f8776p-55, -0x1p-1, --0x1.1eef59e0b74c3p-3, --0x1.ddb13b6ccc23cp-1, --0x1.83c37c6107db3p-55, -0x1p-1, --0x1.191386db3dedcp-3, --0x1.dd1fef38a915ap-1, -0x1.782f169e17f3bp-55, -0x1p-1, --0x1.13397e1b7ce13p-3, --0x1.dc8d7cb41026p-1, --0x1.6b7872773830dp-56, -0x1p-1, --0x1.0d61433d840a4p-3, --0x1.dbf9e4395759ap-1, --0x1.d8ff7350f75fdp-55, -0x1p-1, --0x1.078ad9dc46632p-3, --0x1.db6526238a09bp-1, -0x1.adee7eae6946p-56, -0x1p-1, --0x1.01b6459197c38p-3, --0x1.dacf42ce68ab9p-1, -0x1.fe8d76efdf896p-56, -0x1p-1, --0x1.f7c713ec554fp-4, --0x1.da383a9668988p-1, -0x1.5811000b39d84p-55, -0x1p-1, --0x1.ec2555431bf03p-4, --0x1.d9a00dd8b3d46p-1, --0x1.bea0e4bac8e16p-58, -0x1p-1, --0x1.e087565455a75p-4, --0x1.d906bcf328d46p-1, --0x1.457e610231ac2p-56, -0x1p-1, --0x1.d4ed1e4a84aefp-4, --0x1.d86c48445a44fp-1, --0x1.e8813c023d71fp-55, -0x1p-1, --0x1.c956b44dd6d41p-4, --0x1.d7d0b02b8ecf9p-1, --0x1.800f4ce65cd6ep-55, -0x1p-1, --0x1.bdc41f84210bbp-4, --0x1.d733f508c0dffp-1, -0x1.007928e770cd5p-55, -0x1p-1, --0x1.b2356710db0a3p-4, --0x1.d696173c9e68bp-1, -0x1.e8c61c6393d55p-56, -0x1p-1, --0x1.a6aa92151adc3p-4, --0x1.d5f7172888a7fp-1, -0x1.68663e2225755p-55, -0x1p-1, --0x1.9b23a7af90805p-4, --0x1.d556f52e93eb1p-1, -0x1.80ed9233a963p-55, -0x1p-1, --0x1.8fa0aefc81837p-4, --0x1.d4b5b1b187524p-1, -0x1.f56be6b42b76dp-57, -0x1p-1, --0x1.8421af15c49d7p-4, --0x1.d4134d14dc93ap-1, -0x1.4ef5295d25af2p-55, -0x1p-1, --0x1.78a6af12bd501p-4, --0x1.d36fc7bcbfbdcp-1, -0x1.ba196d95a177dp-55, -0x1p-1, --0x1.6d2fb6085786ep-4, --0x1.d2cb220e0ef9fp-1, -0x1.f07656d4e6652p-56, -0x1p-1, --0x1.61bccb0903395p-4, --0x1.d2255c6e5a4e1p-1, -0x1.d129a71ecafc9p-55, -0x1p-1, --0x1.564df524b00dap-4, --0x1.d17e7743e35dcp-1, -0x1.101da3540130ap-58, -0x1p-1, --0x1.4ae33b68c8fdcp-4, --0x1.d0d672f59d2b9p-1, -0x1.c83009f0c39dep-55, -0x1p-1, --0x1.3f7ca4e02ffdcp-4, --0x1.d02d4feb2bd92p-1, --0x1.195ff41bc55fep-55, -0x1p-1, --0x1.341a389339a36p-4, --0x1.cf830e8ce467bp-1, -0x1.7b9202780d49dp-55, -0x1p-1, --0x1.28bbfd87a8cffp-4, --0x1.ced7af43cc773p-1, -0x1.e7b6bb5ab58aep-58, -0x1p-1, --0x1.1d61fac0aa5b2p-4, --0x1.ce2b32799a06p-1, -0x1.631d457e46317p-56, -0x1p-1, --0x1.120c373ed0bfbp-4, --0x1.cd7d9898b32f6p-1, -0x1.f2fa062496738p-57, -0x1p-1, --0x1.06baba000fc9bp-4, --0x1.cccee20c2deap-1, -0x1.d3116ae0e69e4p-55, -0x1p-1, --0x1.f6db13ff708cbp-5, --0x1.cc1f0f3fcfc5cp-1, --0x1.e57613b68f6abp-56, -0x1p-1, --0x1.e0495c6ce76b5p-5, --0x1.cb6e20a00da99p-1, -0x1.4fb24b5194c1bp-55, -0x1p-1, --0x1.c9c05b347ffabp-5, --0x1.cabc169a0b9p-1, --0x1.c42d3e10851d1p-55, -0x1p-1, --0x1.b3401e3cd63bbp-5, --0x1.ca08f19b9c449p-1, -0x1.431e0a5a737fdp-56, -0x1p-1, --0x1.9cc8b3671dd0fp-5, --0x1.c954b213411f5p-1, -0x1.2fb761e946603p-58, -0x1p-1, --0x1.865a288f196fap-5, --0x1.c89f587029c13p-1, --0x1.588358ed6e78fp-58, -0x1p-1, --0x1.6ff48b8b1252ap-5, --0x1.c7e8e52233cf3p-1, --0x1.b2ad324aa35c1p-57, -0x1p-1, --0x1.5997ea2bcfb19p-5, --0x1.c7315899eaad7p-1, -0x1.9be5dcd047da7p-57, -0x1p-1, --0x1.4344523c8e3b5p-5, --0x1.c678b3488739bp-1, --0x1.d86cac7c5ff5bp-57, -0x1p-1, --0x1.2cf9d182f7939p-5, --0x1.c5bef59fef85ap-1, -0x1.f0a406c8b7468p-58, -0x1p-1, --0x1.16b875bf19d4p-5, --0x1.c5042012b6907p-1, -0x1.5c058dd8eaba5p-57, -0x1p-1, --0x1.00804cab5f113p-5, --0x1.c44833141c004p-1, --0x1.23e0521df01a2p-56, -0x1p-1, --0x1.d4a2c7f909c4ep-6, --0x1.c38b2f180bdb1p-1, -0x1.6e0b1757c8d07p-56, -0x1p-1, --0x1.a85792c327db2p-6, --0x1.c2cd14931e3f1p-1, --0x1.2ce2f9d4600f5p-56, -0x1p-1, --0x1.7c1f1507aeec3p-6, --0x1.c20de3fa971bp-1, -0x1.b4ca2bab1322cp-55, -0x1p-1, --0x1.4ff96a0da9dfbp-6, --0x1.c14d9dc465e57p-1, --0x1.ce36b64c7f3ccp-55, -0x1p-1, --0x1.23e6ad10872a7p-6, --0x1.c08c426725549p-1, --0x1.b157fd80e2946p-58, -0x1p-1, --0x1.efcdf2801004ap-7, --0x1.bfc9d25a1b147p-1, -0x1.51bf4ee01357p-61, -0x1p-1, --0x1.97f4d3805f318p-7, --0x1.bf064e15377ddp-1, --0x1.2156026a1e028p-57, -0x1p-1, --0x1.4042335264ba3p-7, --0x1.be41b611154c1p-1, -0x1.fdcdad3a6877ep-55, -0x1p-1, --0x1.d16c901d95181p-8, --0x1.bd7c0ac6f952ap-1, -0x1.825a732ac700ap-55, -0x1p-1, --0x1.22a28f6cb488bp-8, --0x1.bcb54cb0d2327p-1, --0x1.410923c55523ep-62, -0x1p-1, --0x1.d09b418edf04ap-10, --0x1.bbed7c49380eap-1, --0x1.beacbd88500b4p-59, -0x1p-1, -0x1.d0320ae0b8293p-11, --0x1.bb249a0b6c40dp-1, -0x1.d6318ee919f7ap-58, -0x1p-1, -0x1.cfc874c3eb6d9p-9, --0x1.ba5aa673590d2p-1, --0x1.7ea4e370753b6p-55, -0x1p-1, -0x1.9572af6decac8p-8, --0x1.b98fa1fd9155ep-1, --0x1.5559034fe85a4p-55, -0x1p-1, -0x1.21589ab88869cp-7, --0x1.b8c38d27504e9p-1, -0x1.1529abff40e45p-55, -0x1p-1, -0x1.77cfb0c6e2db8p-7, --0x1.b7f6686e792e9p-1, --0x1.87665bfea06aap-55, -0x1p-1, -0x1.ce1e648bffb66p-7, --0x1.b728345196e3ep-1, -0x1.bc69f324e6d61p-55, -0x1p-1, -0x1.1222406561182p-6, --0x1.b658f14fdbc47p-1, --0x1.52b5308f397dep-57, -0x1p-1, -0x1.3d20e82f8bc1p-6, --0x1.b5889fe921405p-1, -0x1.df49b307c8602p-57, -0x1p-1, -0x1.680b0f1f0bd73p-6, --0x1.b4b7409de7925p-1, --0x1.f4e257bde73d8p-56, -0x1p-1, -0x1.92e09abb131d4p-6, --0x1.b3e4d3ef55712p-1, -0x1.eb6b8bf11a493p-55, -0x1p-1, -0x1.bda17097896b4p-6, --0x1.b3115a5f37bf3p-1, --0x1.dde2726e34fe1p-55, -0x1p-1, -0x1.e84d76551cfb2p-6, --0x1.b23cd470013b4p-1, --0x1.5a1bb35ad6d2ep-56, -0x1p-1, -0x1.097248d0a956ap-5, --0x1.b16742a4ca2f5p-1, -0x1.ba70972b80438p-55, -0x1p-1, -0x1.1eb3541b4b228p-5, --0x1.b090a581502p-1, -0x1.926da300ffccep-55, -0x1p-1, -0x1.33e9cfee254edp-5, --0x1.afb8fd89f57b6p-1, --0x1.1ced12d2899b8p-60, -0x1p-1, -0x1.4915af336ceb4p-5, --0x1.aee04b43c1474p-1, -0x1.3a79a438bf8ccp-55, -0x1p-1, -0x1.5e36e4dbe2bc2p-5, --0x1.ae068f345ecefp-1, -0x1.33934c4029a4cp-56, -0x1p-1, -0x1.734d63dedb48ap-5, --0x1.ad2bc9e21d511p-1, -0x1.47fbe07bea548p-55, -0x1p-1, -0x1.88591f3a46e4dp-5, --0x1.ac4ffbd3efac8p-1, -0x1.818504103fa16p-56, -0x1p-1, -0x1.9d5a09f2b9b7fp-5, --0x1.ab7325916c0d4p-1, --0x1.a8b8c85baaa9bp-55, -0x1p-1, -0x1.b250171373be9p-5, --0x1.aa9547a2cb98ep-1, --0x1.87d00ae97abaap-60, -0x1p-1, -0x1.c73b39ae68c87p-5, --0x1.a9b66290ea1a3p-1, --0x1.9f630e8b6dac8p-60, -0x1p-1, -0x1.dc1b64dc48722p-5, --0x1.a8d676e545ad2p-1, -0x1.b11dcce2e74bdp-59, -0x1p-1, -0x1.f0f08bbc861afp-5, --0x1.a7f58529fe69dp-1, -0x1.97a441584a179p-55, -0x1p-1, -0x1.02dd50bab06b2p-4, --0x1.a7138de9d60f5p-1, -0x1.f1ab82a9c5f2dp-55, -0x1p-1, -0x1.0d3ccc99f5ac6p-4, --0x1.a63091b02fae2p-1, -0x1.e911152248d1p-56, -0x1p-1, -0x1.1796b31609f0cp-4, --0x1.a54c91090f523p-1, --0x1.184300fd1c1cep-56, -0x1p-1, -0x1.21eafdcc560fap-4, --0x1.a4678c8119ac8p-1, --0x1.1b4c0dd3f212ap-55, -0x1p-1, -0x1.2c39a65db8881p-4, --0x1.a38184a593bc6p-1, -0x1.bc92c5bd2d288p-55, -0x1p-1, -0x1.3682a66e896f5p-4, --0x1.a29a7a0462782p-1, -0x1.128bb015df175p-56, -0x1p-1, -0x1.40c5f7a69e5cep-4, --0x1.a1b26d2c0a75ep-1, --0x1.30ef431d627a6p-57, -0x1p-1, -0x1.4b0393b14e541p-4, --0x1.a0c95eabaf937p-1, -0x1.e0ca3acbd049ap-55, -0x1p-1, -0x1.553b743d75acp-4, --0x1.9fdf4f13149dep-1, --0x1.1e6d79006ec09p-55, -0x1p-1, -0x1.5f6d92fd79f5p-4, --0x1.9ef43ef29af94p-1, --0x1.b1dfcb60445c2p-56, -0x1p-1, -0x1.6999e9a74ddbep-4, --0x1.9e082edb42472p-1, --0x1.5809a4e121e22p-57, -0x1p-1, -0x1.73c071f4750b5p-4, --0x1.9d1b1f5ea80d5p-1, --0x1.c5fadd5ffb36fp-55, -0x1p-1, -0x1.7de125a2080a9p-4, --0x1.9c2d110f075c2p-1, --0x1.d9c9f1c8c30dp-55, -0x1p-1, -0x1.87fbfe70b81a7p-4, --0x1.9b3e047f38741p-1, -0x1.30ee286712474p-55, -0x1p-1, -0x1.9210f624d30fbp-4, --0x1.9a4dfa42b06b2p-1, -0x1.829b6b8b1c947p-56, -0x1p-1, -0x1.9c200686472b5p-4, --0x1.995cf2ed80d22p-1, --0x1.7783e907fbd7bp-56, -0x1p-1, -0x1.a6292960a6f0bp-4, --0x1.986aef1457594p-1, -0x1.af03e318f38fcp-55, -0x1p-1, -0x1.b02c58832cf96p-4, --0x1.9777ef4c7d742p-1, -0x1.15479a240665ep-55, -0x1p-1, -0x1.ba298dc0bfc6bp-4, --0x1.9683f42bd7fe1p-1, -0x1.11bad933c835ep-57, -0x1p-1, -0x1.c420c2eff590ep-4, --0x1.958efe48e6dd7p-1, -0x1.561335da0f4e7p-55, -0x1p-1, -0x1.ce11f1eb18148p-4, --0x1.94990e3ac4a6cp-1, --0x1.a95328edeb3e6p-56, -0x1p-1, -0x1.d7fd1490285cap-4, --0x1.93a22499263fbp-1, --0x1.3d419a920df0bp-55, -0x1p-1, -0x1.e1e224c0e28bdp-4, --0x1.92aa41fc5a815p-1, -0x1.68f89e2d23db7p-57, -0x1p-1, -0x1.ebc11c62c1a1ep-4, --0x1.91b166fd49da2p-1, -0x1.3be953a7fe996p-57, -0x1p-1, -0x1.f599f55f034p-4, --0x1.90b7943575efep-1, --0x1.4ecb0c5273706p-57, -0x1p-1, -0x1.ff6ca9a2ab6a2p-4, --0x1.8fbcca3ef940dp-1, -0x1.6dfa99c86f2f1p-57, -0x1p-1, -0x1.049c998f44231p-3, --0x1.8ec109b486c49p-1, -0x1.cb2a3eb6af617p-56, -0x1p-1, -0x1.097fc5e39aec5p-3, --0x1.8dc45331698ccp-1, --0x1.1d9fcd83634d7p-57, -0x1p-1, -0x1.0e5fd6ca90dffp-3, --0x1.8cc6a75184655p-1, -0x1.e18b3657e2285p-55, -0x1p-1, -0x1.133cc94247758p-3, --0x1.8bc806b151741p-1, -0x1.2c5e12ed1336dp-55, -0x1p-1, -0x1.18169a4acca89p-3, --0x1.8ac871ede1d88p-1, -0x1.9afaa5b7cfc55p-55, -0x1p-1, -0x1.1ced46e61cd1cp-3, --0x1.89c7e9a4dd4aap-1, --0x1.db6ea04a8678fp-55, -0x1p-1, -0x1.21c0cc18247fcp-3, --0x1.88c66e7481ba1p-1, -0x1.5c6228970cf35p-56, -0x1p-1, -0x1.269126e6c24e3p-3, --0x1.87c400fba2ebfp-1, -0x1.2dabc0c3f64cdp-55, -0x1p-1, -0x1.2b5e5459c8bc3p-3, --0x1.86c0a1d9aa195p-1, --0x1.84564f09c3726p-59, -0x1p-1, -0x1.3028517b0001p-3, --0x1.85bc51ae958ccp-1, --0x1.45ba6478086ccp-55, -0x1p-1, -0x1.34ef1b5627dfdp-3, --0x1.84b7111af83fap-1, -0x1.63a47df0b21bap-55, -0x1p-1, -0x1.39b2aef8f97a4p-3, --0x1.83b0e0bff976ep-1, -0x1.6f420f8ea3475p-56, -0x1p-1, -0x1.3e73097329219p-3, --0x1.82a9c13f545ffp-1, -0x1.65e87a7a8cde9p-56, -0x1p-1, -0x1.433027d66826dp-3, --0x1.81a1b33b57accp-1, -0x1.5dea12d66bb66p-55, -0x1p-1, -0x1.47ea073666a98p-3, --0x1.8098b756e52fap-1, --0x1.9136e834b4707p-55, -0x1p-1, -0x1.4ca0a4a8d5657p-3, --0x1.7f8ece3571771p-1, -0x1.9c8d8ce93c917p-55, -0x1p-1, -0x1.5153fd45677efp-3, --0x1.7e83f87b03686p-1, --0x1.b61a8ccabad6p-57, -0x1p-1, -0x1.56040e25d44ddp-3, --0x1.7d7836cc33db2p-1, --0x1.162715ef03f85p-56, -0x1p-1, -0x1.5ab0d465d927ap-3, --0x1.7c6b89ce2d333p-1, -0x1.cfd628084982cp-56, -0x1p-1, -0x1.5f5a4d233b27fp-3, --0x1.7b5df226aafafp-1, -0x1.0f537acdf0ad7p-56, -0x1p-1, -0x1.6400757dc8f7dp-3, --0x1.7a4f707bf97d2p-1, --0x1.3c9751b491eafp-55, -0x1p-1, -0x1.68a34a975c941p-3, --0x1.79400574f55e5p-1, -0x1.0adadbdb4c65ap-55, -0x1p-1, -0x1.6d42c993dd121p-3, --0x1.782fb1b90b35bp-1, -0x1.3e46c1dfd001cp-55, -0x1p-1, -0x1.71deef9940631p-3, --0x1.771e75f037261p-1, --0x1.5cfce8d84068fp-56, -0x1p-1, -0x1.7677b9cf8d17p-3, --0x1.760c52c304764p-1, -0x1.11d76f8e50f1fp-55, -0x1p-1, -0x1.7b0d2560dc1d1p-3, --0x1.74f948da8d28dp-1, --0x1.19900a3b9a3a2p-63, -0x1p-1, -0x1.7f9f2f795a83ep-3, --0x1.73e558e079942p-1, -0x1.2663126697f5ep-55, -0x1p-1, -0x1.842dd5474b37bp-3, --0x1.72d0837efff96p-1, --0x1.0d4ef0f1d915cp-55, -0x1p-1, -0x1.88b913fb08bfdp-3, --0x1.71bac960e41bfp-1, -0x1.b858d90b0f7d8p-56, -0x1p-1, -0x1.8d40e8c706fa4p-3, --0x1.70a42b3176d7ap-1, -0x1.d9e3fbe2e15ap-56, -0x1p-1, -0x1.91c550dfd4d6bp-3, --0x1.6f8ca99c95b75p-1, --0x1.f22e7a35723f4p-56, -0x1p-1, -0x1.9646497c1e0f6p-3, --0x1.6e74454eaa8afp-1, -0x1.dbc03c84e226ep-55, -0x1p-1, -0x1.9ac3cfd4ace19p-3, --0x1.6d5afef4aafcdp-1, -0x1.868a696b8835ep-55, -0x1p-1, -0x1.9f3de1246bc4p-3, --0x1.6c40d73c18275p-1, --0x1.25d4f802be257p-57, -0x1p-1, -0x1.a3b47aa8671c5p-3, --0x1.6b25ced2fe29cp-1, -0x1.5ac64116beda5p-55, -0x1p-1, -0, --0x1.6a09e667f3bcdp-1, -0x1.bdd3413b26456p-55, -0, --0x1.29b4625a03ac9p-2, --0x1.68ed1eaa19c71p-1, --0x1.fd4a85350f69p-56, -0x1p0, --0x1.277e5187cfb16p-2, --0x1.67cf78491af1p-1, --0x1.750ab23477b61p-59, -0x1p0, --0x1.254a0216aa067p-2, --0x1.66b0f3f52b386p-1, --0x1.1e2eb31a8848bp-55, -0x1p0, --0x1.23177562aaea3p-2, --0x1.6591925f0783dp-1, --0x1.c3d64fbf5de23p-55, -0x1p0, --0x1.20e6acc6d4916p-2, --0x1.64715437f535bp-1, -0x1.7c399c15a17dp-55, -0x1p0, --0x1.1eb7a99d1250cp-2, --0x1.63503a31c1be9p-1, --0x1.1248f09e6587cp-57, -0x1p0, --0x1.1c8a6d3e37c82p-2, --0x1.622e44fec22ffp-1, --0x1.f98d8be132d57p-56, -0x1p0, --0x1.1a5ef902000d3p-2, --0x1.610b7551d2cdfp-1, -0x1.251b352ff2a37p-56, -0x1p0, --0x1.18354e3f0cd7dp-2, --0x1.5fe7cbde56a1p-1, -0x1.fcb9cc30cc01ep-55, -0x1p0, --0x1.160d6e4ae5ae6p-2, --0x1.5ec3495837074p-1, --0x1.dea89a9b8f727p-56, -0x1p0, --0x1.13e75a79f7139p-2, --0x1.5d9dee73e345cp-1, -0x1.de1165ecdf7a3p-57, -0x1p0, --0x1.11c3141f91b3ep-2, --0x1.5c77bbe65018cp-1, --0x1.069ea9c0bc32ap-55, -0x1p0, --0x1.0fa09c8de994bp-2, --0x1.5b50b264f7448p-1, --0x1.519d30d4cfebp-56, -0x1p0, --0x1.0d7ff51615437p-2, --0x1.5a28d2a5d725p-1, --0x1.57a25f8b1343p-55, -0x1p0, --0x1.0b611f080d05bp-2, --0x1.59001d5f723dfp-1, --0x1.a9f86ba0dde98p-56, -0x1p0, --0x1.09441bb2aa0a2p-2, --0x1.57d69348cecap-1, -0x1.75720992bfbb2p-55, -0x1p0, --0x1.0728ec63a599ap-2, --0x1.56ac35197649fp-1, -0x1.f7874188cb279p-55, -0x1p0, --0x1.050f92679849cp-2, --0x1.5581038975137p-1, --0x1.4570d9efe26dfp-55, -0x1p0, --0x1.02f80f09f92f4p-2, --0x1.5454ff5159dfcp-1, -0x1.4e247588bf256p-55, -0x1p0, --0x1.00e263951d11fp-2, --0x1.5328292a35596p-1, -0x1.a12eb89da0257p-56, -0x1p0, --0x1.fd9d22a46b416p-3, --0x1.51fa81cd99aa6p-1, -0x1.499f59d8560e9p-63, -0x1p0, --0x1.f9793312a14d1p-3, --0x1.50cc09f59a09bp-1, --0x1.693463a2c2e6fp-56, -0x1p0, --0x1.f558fb02ae805p-3, --0x1.4f9cc25cca486p-1, --0x1.48b5951cfc2b5p-55, -0x1p0, --0x1.f13c7d001a249p-3, --0x1.4e6cabbe3e5e9p-1, --0x1.3c293edceb327p-57, -0x1p0, --0x1.ed23bb941f019p-3, --0x1.4d3bc6d589f7fp-1, --0x1.6e4d9d6b72011p-55, -0x1p0, --0x1.e90eb945a9ccfp-3, --0x1.4c0a145ec0004p-1, --0x1.2630cfafceaa1p-58, -0x1p0, --0x1.e4fd7899579acp-3, --0x1.4ad79516722f1p-1, -0x1.1273b163000f7p-55, -0x1p0, --0x1.e0effc1174505p-3, --0x1.49a449b9b0939p-1, -0x1.27ee16d719b94p-55, -0x1p0, --0x1.dce6462df917dp-3, --0x1.48703306091ffp-1, -0x1.70813b86159fdp-57, -0x1p0, --0x1.d8e0596c8ad56p-3, --0x1.473b51b987347p-1, --0x1.ca1953514e41bp-57, -0x1p0, --0x1.d4de3848789e2p-3, --0x1.4605a692b32a2p-1, --0x1.21ca219b97107p-55, -0x1p0, --0x1.d0dfe53aba2fdp-3, --0x1.44cf325091dd6p-1, --0x1.8076a2cfdc6b3p-57, -0x1p0, --0x1.cce562b9ee6aep-3, --0x1.4397f5b2a438p-1, -0x1.7274c9e48c226p-55, -0x1p0, --0x1.c8eeb33a59cdp-3, --0x1.425ff178e6bb1p-1, --0x1.7b38d675140cap-55, -0x1p0, --0x1.c4fbd92de4eddp-3, --0x1.41272663d108cp-1, --0x1.1bbe7636fadf5p-55, -0x1p0, --0x1.c10cd7041afccp-3, --0x1.3fed9534556d4p-1, --0x1.36916608c5061p-55, -0x1p0, --0x1.bd21af2a28408p-3, --0x1.3eb33eabe068p-1, --0x1.86a2357d1a0d3p-58, -0x1p0, --0x1.b93a640ad8978p-3, --0x1.3d78238c58344p-1, -0x1.0219f5f0f79cep-55, -0x1p0, --0x1.b556f80e95facp-3, --0x1.3c3c44981c518p-1, -0x1.b5e9a9644151bp-55, -0x1p0, --0x1.b1776d9b67013p-3, --0x1.3affa292050b9p-1, --0x1.e3e25e3954964p-56, -0x1p0, --0x1.ad9bc714ed64fp-3, --0x1.39c23e3d63029p-1, -0x1.3b05b276085c1p-58, -0x1p0, --0x1.a9c406dc648a5p-3, --0x1.3884185dfeb22p-1, -0x1.a038026abe6b2p-56, -0x1p0, --0x1.a5f02f50a007cp-3, --0x1.374531b817f8dp-1, --0x1.444d2b0a747fep-55, -0x1p0, --0x1.a22042ce0a2f9p-3, --0x1.36058b10659f3p-1, -0x1.1fcb3a35857e7p-55, -0x1p0, --0x1.9e5443aea29b2p-3, --0x1.34c5252c14de1p-1, --0x1.583f49632ab2bp-55, -0x1p0, --0x1.9a8c3449fcb77p-3, --0x1.338400d0c8e57p-1, -0x1.abf2a5e95e6e5p-55, -0x1p0, --0x1.96c816f53e539p-3, --0x1.32421ec49a61fp-1, --0x1.65e25cc951bfep-55, -0x1p0, --0x1.9307ee031e2fdp-3, --0x1.30ff7fce17035p-1, -0x1.efcc626f74a6fp-57, -0x1p0, --0x1.8f4bbbc3e28f6p-3, --0x1.2fbc24b441015p-1, --0x1.dba4875410874p-57, -0x1p0, --0x1.8b9382855fcaap-3, --0x1.2e780e3e8ea17p-1, -0x1.b19fafe36587ap-55, -0x1p0, --0x1.87df4492f6e38p-3, --0x1.2d333d34e9bb8p-1, -0x1.0e2c2c5549e26p-55, -0x1p0, --0x1.842f0435941afp-3, --0x1.2bedb25faf3eap-1, -0x1.14981c796ee46p-58, -0x1p0, --0x1.8082c3b3ad887p-3, --0x1.2aa76e87aeb58p-1, --0x1.fd600833287a7p-59, -0x1p0, --0x1.7cda855141b26p-3, --0x1.2960727629ca8p-1, --0x1.56d6c7af02d5cp-56, -0x1p0, --0x1.79364b4fd6288p-3, --0x1.2818bef4d3cbap-1, -0x1.e3fffeb76568ap-56, -0x1p0, --0x1.759617ee761f9p-3, --0x1.26d054cdd12dfp-1, -0x1.5da743ef3770cp-55, -0x1p0, --0x1.71f9ed69b10eap-3, --0x1.258734cbb711p-1, --0x1.3a3f0903ce09dp-57, -0x1p0, --0x1.6e61cdfb994dfp-3, --0x1.243d5fb98ac1fp-1, --0x1.c533d0a284a8dp-56, -0x1p0, --0x1.6acdbbdbc2b73p-3, --0x1.22f2d662c13e2p-1, -0x1.d5cc7580cb6d2p-55, -0x1p0, --0x1.673db93f41479p-3, --0x1.21a799933eb59p-1, -0x1.3a7b177c68fb2p-55, -0x1p0, --0x1.63b1c858a7c2ep-3, --0x1.205baa17560d6p-1, --0x1.b7b144016c7a3p-56, -0x1p0, --0x1.6029eb580658ep-3, --0x1.1f0f08bbc861bp-1, -0x1.10d9dcafb74cbp-57, -0x1p0, --0x1.5ca6246ae94b8p-3, --0x1.1dc1b64dc4872p-1, --0x1.f15e1c468be78p-57, -0x1p0, --0x1.592675bc57974p-3, --0x1.1c73b39ae68c8p-1, --0x1.b25dd267f66p-55, -0x1p0, --0x1.55aae174d19c8p-3, --0x1.1b250171373bfp-1, -0x1.b210e95e1ca4cp-55, -0x1p0, --0x1.523369ba4fcaep-3, --0x1.19d5a09f2b9b8p-1, -0x1.33656c68a1d4ap-57, -0x1p0, --0x1.4ec010b0414e1p-3, --0x1.188591f3a46e5p-1, -0x1.bbefe5a524346p-56, -0x1p0, --0x1.4b50d8778abbdp-3, --0x1.1734d63dedb49p-1, -0x1.7eef2ccc50575p-55, -0x1p0, --0x1.47e5c32e84c45p-3, --0x1.15e36e4dbe2bcp-1, --0x1.3c545f7d79eaep-56, -0x1p0, --0x1.447ed2f0fae31p-3, --0x1.14915af336cebp-1, --0x1.f3660558a0213p-56, -0x1p0, --0x1.411c09d82a128p-3, --0x1.133e9cfee254fp-1, -0x1.a1377cfd5ce5p-56, -0x1p0, --0x1.3dbd69fabf802p-3, --0x1.11eb3541b4b23p-1, -0x1.ef23b69abe4f1p-55, -0x1p0, --0x1.3a62f56cd742ep-3, --0x1.1097248d0a957p-1, -0x1.7a58759ba80ddp-55, -0x1p0, --0x1.370cae3ffb12fp-3, --0x1.0f426bb2a8e7ep-1, -0x1.bb58fb774f8eep-55, -0x1p0, --0x1.33ba968321032p-3, --0x1.0ded0b84bc4b6p-1, -0x1.8540fa327c55cp-55, -0x1p0, --0x1.306cb042aa3bap-3, --0x1.0c9704d5d898fp-1, -0x1.8d3d7de6ee9b2p-55, -0x1p0, --0x1.2d22fd8861b6bp-3, --0x1.0b405878f85ecp-1, -0x1.ad66c3bb80da5p-55, -0x1p0, --0x1.29dd805b7afecp-3, --0x1.09e907417c5e1p-1, -0x1.fe573741a9bd4p-55, -0x1p0, --0x1.269c3ac090ee4p-3, --0x1.089112032b08cp-1, --0x1.3248ddf9fe619p-57, -0x1p0, --0x1.235f2eb9a470ap-3, --0x1.073879922ffeep-1, -0x1.a5a014347406cp-55, -0x1p0, --0x1.20265e461b45ap-3, --0x1.05df3ec31b8b7p-1, -0x1.e2dcad34d9c1dp-57, -0x1p0, --0x1.1cf1cb62bec5dp-3, --0x1.0485626ae221ap-1, --0x1.b937d9091ff7p-55, -0x1p0, --0x1.19c17809baa87p-3, --0x1.032ae55edbd96p-1, -0x1.bdb022b40107ap-55, -0x1p0, --0x1.169566329bcb7p-3, --0x1.01cfc874c3eb7p-1, -0x1.34a35e7c2368cp-56, -0x1p0, --0x1.136d97d24efccp-3, --0x1.00740c82b82e1p-1, -0x1.6d48563c60e87p-55, -0x1p0, --0x1.104a0edb1fc58p-3, --0x1.fe2f64be7121p-2, -0x1.297ab1ca2d7dbp-56, -0x1p0, --0x1.0d2acd3cb7364p-3, --0x1.fb7575c24d2dep-2, -0x1.5bfdc883c8664p-57, -0x1p0, --0x1.0a0fd4e41ab5ap-3, --0x1.f8ba4dbf89abap-2, -0x1.2ec1fc1b776b8p-60, -0x1p0, --0x1.06f927bbaacfep-3, --0x1.f5fdee656cda3p-2, -0x1.7bf9780816b05p-58, -0x1p0, --0x1.03e6c7ab2208cp-3, --0x1.f3405963fd067p-2, --0x1.06846d44a238fp-56, -0x1p0, --0x1.00d8b69793ae4p-3, --0x1.f081906bff7fep-2, -0x1.4cab2d4ff6fccp-56, -0x1p0, --0x1.fb9decc6d55b8p-4, --0x1.edc1952ef78d6p-2, -0x1.dd0f7c33edee6p-56, -0x1p0, --0x1.f59311dcd0d44p-4, --0x1.eb00695f2562p-2, --0x1.53c9fd3083e22p-56, -0x1p0, --0x1.ef90e02b47283p-4, --0x1.e83e0eaf85114p-2, -0x1.7bc380ef24ba7p-57, -0x1p0, --0x1.e9975b670e077p-4, --0x1.e57a86d3cd825p-2, -0x1.2c80dcd511e87p-57, -0x1p0, --0x1.e3a6873fa1279p-4, --0x1.e2b5d3806f63bp-2, --0x1.e0d891d3c6841p-58, -0x1p0, --0x1.ddbe675f1ffdfp-4, --0x1.dfeff66a941dep-2, -0x1.a756c6e625f96p-56, -0x1p0, --0x1.d7deff6a4b7c9p-4, --0x1.dd28f1481cc58p-2, -0x1.e7576fa6c944ep-59, -0x1p0, --0x1.d208530083d3p-4, --0x1.da60c5cfa10d9p-2, -0x1.0f38e2143c8d5p-57, -0x1p0, --0x1.cc3a65bbc6327p-4, --0x1.d79775b86e389p-2, --0x1.550ec87bc0575p-56, -0x1p0, --0x1.c6753b30aa949p-4, --0x1.d4cd02ba8609dp-2, -0x1.37f33c63033d6p-57, -0x1p0, --0x1.c0b8d6ee61867p-4, --0x1.d2016e8e9db5bp-2, -0x1.c8bce9d93efb8p-57, -0x1p0, --0x1.bb053c7eb1f68p-4, --0x1.cf34baee1cd21p-2, -0x1.118724d19d014p-56, -0x1p0, --0x1.b55a6f65f7058p-4, --0x1.cc66e9931c45ep-2, --0x1.6850e59c37f8fp-58, -0x1p0, --0x1.afb873231ddb9p-4, --0x1.c997fc3865389p-2, -0x1.6295f8b0ca33bp-56, -0x1p0, --0x1.aa1f4b2fa37fcp-4, --0x1.c6c7f4997000bp-2, -0x1.bec2669c68e74p-56, -0x1p0, --0x1.a48efaff92b3bp-4, --0x1.c3f6d47263129p-2, --0x1.9c7bd0fcdecddp-56, -0x1p0, --0x1.9f07860181d1ep-4, --0x1.c1249d8011ee7p-2, -0x1.813aabb515206p-56, -0x1p0, --0x1.9988ef9e90b04p-4, --0x1.be51517ffc0d9p-2, --0x1.2b667131a5f16p-56, -0x1p0, --0x1.94133b3a66851p-4, --0x1.bb7cf2304bd01p-2, --0x1.9e1a5bd9269d4p-57, -0x1p0, --0x1.8ea66c332fd01p-4, --0x1.b8a7814fd5693p-2, --0x1.9a9e6651cc119p-56, -0x1p0, --0x1.894285e19c468p-4, --0x1.b5d1009e15ccp-2, --0x1.5b362cb974183p-57, -0x1p0, --0x1.83e78b98dcc2bp-4, --0x1.b2f971db31972p-2, --0x1.fa971a4a41f2p-56, -0x1p0, --0x1.7e9580a6a136ep-4, --0x1.b020d6c7f4009p-2, --0x1.414ae7e555208p-58, -0x1p0, --0x1.794c685316a3cp-4, --0x1.ad473125cdc09p-2, -0x1.379ede57649dap-58, -0x1p0, --0x1.740c45e0e512p-4, --0x1.aa6c82b6d3fcap-2, -0x1.d5f106ee5ccf7p-56, -0x1p0, --0x1.6ed51c8d2d8fcp-4, --0x1.a790cd3dbf31bp-2, -0x1.7f786986d9023p-57, -0x1p0, --0x1.69a6ef8f8830ap-4, --0x1.a4b4127dea1e5p-2, -0x1.bec6f01bc22f1p-56, -0x1p0, --0x1.6481c21a02123p-4, --0x1.a1d6543b50acp-2, -0x1.0246cfd8779fbp-57, -0x1p0, --0x1.5f6597591b633p-4, --0x1.9ef7943a8ed8ap-2, --0x1.6da81290bdbabp-57, -0x1p0, --0x1.5a527273c56e1p-4, --0x1.9c17d440df9f2p-2, --0x1.923c540a9eec4p-57, -0x1p0, --0x1.5548568b60a7bp-4, --0x1.993716141bdffp-2, -0x1.15e8cce261c55p-56, -0x1p0, --0x1.504746bbbac0bp-4, --0x1.96555b7ab948fp-2, --0x1.7afd51eff33adp-56, -0x1p0, --0x1.4b4f461b0cbaap-4, --0x1.9372a63bc93d7p-2, --0x1.684319e5ad5b1p-57, -0x1p0, --0x1.466057b9f900ap-4, --0x1.908ef81ef7bd1p-2, --0x1.4c00267012357p-56, -0x1p0, --0x1.417a7ea389835p-4, --0x1.8daa52ec8a4bp-2, -0x1.72eb2db8c621ep-57, -0x1p0, --0x1.3c9dbddd2dd84p-4, --0x1.8ac4b86d5ed44p-2, --0x1.17fa7f944ad5bp-56, -0x1p0, --0x1.37ca1866b95cfp-4, --0x1.87de2a6aea963p-2, -0x1.72cedd3d5a61p-57, -0x1p0, --0x1.32ff913a615dp-4, --0x1.84f6aaaf3903fp-2, --0x1.6dcdc2bd47067p-57, -0x1p0, --0x1.2e3e2b4cbb3c3p-4, --0x1.820e3b04eaac4p-2, -0x1.92379eb01c6b6p-59, -0x1p0, --0x1.2985e98cbaa3ap-4, --0x1.7f24dd37341e4p-2, --0x1.2791a1b5eb796p-57, -0x1p0, --0x1.24d6cee3afb2ap-4, --0x1.7c3a9311dcce7p-2, --0x1.9a3f21ef3e8d9p-62, -0x1p0, --0x1.2030de354532cp-4, --0x1.794f5e613dfaep-2, --0x1.820a4b0d21fc5p-57, -0x1p0, --0x1.1b941a5f7ecffp-4, --0x1.766340f2418f6p-2, --0x1.2b2adc9041b2cp-56, -0x1p0, --0x1.1700863ab7533p-4, --0x1.73763c9261092p-2, -0x1.52324face3b1ap-57, -0x1p0, --0x1.127624999ee1dp-4, --0x1.7088530fa459fp-2, -0x1.44b19e0864c5dp-56, -0x1p0, --0x1.0df4f849393f5p-4, --0x1.6d998638a0cb6p-2, -0x1.1ca14532860dfp-61, -0x1p0, --0x1.097d0410dc132p-4, --0x1.6aa9d7dc77e17p-2, -0x1.38b470592c7b3p-56, -0x1p0, --0x1.050e4ab22d321p-4, --0x1.67b949cad63cbp-2, -0x1.a23369348d7efp-56, -0x1p0, --0x1.00a8cee920eabp-4, --0x1.64c7ddd3f27c6p-2, --0x1.10d2b4a664121p-58, -0x1p0, --0x1.f89926d7f0ab8p-5, --0x1.61d595c88c202p-2, --0x1.f6b1e333415d7p-56, -0x1p0, --0x1.eff335d67f541p-5, --0x1.5ee27379ea693p-2, --0x1.634ff2fa75245p-56, -0x1p0, --0x1.e75fd0239926cp-5, --0x1.5bee78b9db3b6p-2, --0x1.e734a63158dfdp-58, -0x1p0, --0x1.dedefb09791b4p-5, --0x1.58f9a75ab1fddp-2, -0x1.efdc0d58cf62p-62, -0x1p0, --0x1.d670bbc6e685ep-5, --0x1.5604012f467b4p-2, --0x1.a0e0b2a5b25p-56, -0x1p0, --0x1.ce15178f31db3p-5, --0x1.530d880af3c24p-2, -0x1.fab8e2103fbd6p-56, -0x1p0, --0x1.c5cc138a317afp-5, --0x1.50163dc197048p-2, -0x1.ec66cb05c7ea4p-56, -0x1p0, --0x1.bd95b4d43e819p-5, --0x1.4d1e24278e76ap-2, --0x1.2417218792858p-57, -0x1p0, --0x1.b572007e31a1bp-5, --0x1.4a253d11b82f3p-2, -0x1.2afa4d6d42a55p-58, -0x1p0, --0x1.ad60fb8d6003ap-5, --0x1.472b8a5571054p-2, -0x1.01ea0fe4dff23p-56, -0x1p0, --0x1.a562aafb982cdp-5, --0x1.44310dc8936fp-2, --0x1.8b694e91d3125p-56, -0x1p0, --0x1.9d7713b71eee1p-5, --0x1.4135c94176601p-2, --0x1.0c97c4afa2518p-56, -0x1p0, --0x1.959e3aa2ac58dp-5, --0x1.3e39be96ec271p-2, --0x1.814c6de9aaaf6p-56, -0x1p0, --0x1.8dd8249568bbbp-5, --0x1.3b3cefa0414b7p-2, --0x1.f36dc4a9c2294p-56, -0x1p0, --0x1.8624d65ae9a63p-5, --0x1.383f5e353b6abp-2, -0x1.a812a4a5c3d44p-56, -0x1p0, --0x1.7e8454b32ef34p-5, --0x1.35410c2e18152p-2, -0x1.3cb002f96e062p-56, -0x1p0, --0x1.76f6a4529fdb5p-5, --0x1.3241fb638baafp-2, --0x1.ecee8f76f8c51p-60, -0x1p0, --0x1.6f7bc9e2080d9p-5, --0x1.2f422daec0387p-2, -0x1.7501ba473da6fp-56, -0x1p0, --0x1.6813c9fe94cfbp-5, --0x1.2c41a4e95452p-2, --0x1.9cf0354aad2dcp-56, -0x1p0, --0x1.60bea939d225ap-5, --0x1.294062ed59f06p-2, -0x1.5d28da2c4612dp-56, -0x1p0, --0x1.597c6c19a8003p-5, --0x1.263e6995554bap-2, --0x1.1d350ffc5ff32p-56, -0x1p0, --0x1.524d171857726p-5, --0x1.233bbabc3bb71p-2, --0x1.99b04e23259efp-56, -0x1p0, --0x1.4b30aea477eeep-5, --0x1.2038583d727bep-2, -0x1.c69cd46300a3p-57, -0x1p0, --0x1.44273720f48bcp-5, --0x1.1d3443f4cdb3ep-2, -0x1.720d41c13519ep-57, -0x1p0, --0x1.3d30b4e5094ep-5, --0x1.1a2f7fbe8f243p-2, --0x1.6465ac86ba7b2p-56, -0x1p0, --0x1.364d2c3c407bep-5, --0x1.172a0d7765177p-2, --0x1.22575f33366bep-57, -0x1p0, --0x1.2f7ca1666ff6fp-5, --0x1.1423eefc69378p-2, --0x1.22d3368ec9b62p-56, -0x1p0, --0x1.28bf1897b69ccp-5, --0x1.111d262b1f677p-2, --0x1.824c20ab7aa9ap-56, -0x1p0, --0x1.221495f879af5p-5, --0x1.0e15b4e1749cep-2, -0x1.5b7fb156c550ap-56, -0x1p0, --0x1.1b7d1da562443p-5, --0x1.0b0d9cfdbdb9p-2, --0x1.3b3a7b8d1200dp-58, -0x1p0, --0x1.14f8b3af5abb9p-5, --0x1.0804e05eb661ep-2, --0x1.54e583d92d3d8p-56, -0x1p0, --0x1.0e875c1b8c3dap-5, --0x1.04fb80e37fdaep-2, -0x1.412cdb72583ccp-63, -0x1p0, --0x1.08291ae35c407p-5, --0x1.01f1806b9fdd2p-2, -0x1.448135394b8bap-56, -0x1p0, --0x1.01ddf3f46a139p-5, --0x1.fdcdc1adfedf9p-3, -0x1.2dba4580ed7bbp-57, -0x1p0, --0x1.f74bd66118e8dp-6, --0x1.f7b7480bd3802p-3, -0x1.9a96d967ee12ep-57, -0x1p0, --0x1.eb0208db9e51bp-6, --0x1.f19f97b215f1bp-3, -0x1.42deef11da2c4p-57, -0x1p0, --0x1.dede86ece142ep-6, --0x1.eb86b462de348p-3, -0x1.bfcde46f90b62p-57, -0x1p0, --0x1.d2e15811bf462p-6, --0x1.e56ca1e101a1bp-3, --0x1.46ac3f9fd0227p-57, -0x1p0, --0x1.c70a83af71ef5p-6, --0x1.df5163f01099ap-3, -0x1.01f7d79906e86p-57, -0x1p0, --0x1.bb5a11138a4c9p-6, --0x1.d934fe5454311p-3, --0x1.75b92277107adp-57, -0x1p0, --0x1.afd00773ec64fp-6, --0x1.d31774d2cbdeep-3, --0x1.2fdc8e5791a0bp-57, -0x1p0, --0x1.a46c6deecac5fp-6, --0x1.ccf8cb312b286p-3, --0x1.2382b0aecadf8p-58, -0x1p0, --0x1.992f4b8aa21f8p-6, --0x1.c6d90535d74ddp-3, -0x1.bfb2be2264962p-59, -0x1p0, --0x1.8e18a73634ee7p-6, --0x1.c0b826a7e4f63p-3, -0x1.af1439e521935p-62, -0x1p0, --0x1.832887c88735dp-6, --0x1.ba96334f15dadp-3, -0x1.75098c05dd18ap-57, -0x1p0, --0x1.785ef400da46cp-6, --0x1.b4732ef3d6722p-3, --0x1.bbe5d5d75cbd8p-57, -0x1p0, --0x1.6dbbf286a8971p-6, --0x1.ae4f1d5f3b9abp-3, --0x1.aa8bbcef9b68ep-57, -0x1p0, --0x1.633f89e9a1a66p-6, --0x1.a82a025b00451p-3, -0x1.87905ffd084adp-57, -0x1p0, --0x1.58e9c0a1a5f21p-6, --0x1.a203e1b1831dap-3, --0x1.c1aadb580a1ecp-58, -0x1p0, --0x1.4eba9d0ec2f7cp-6, --0x1.9bdcbf2dc4366p-3, --0x1.9632d189956fep-57, -0x1p0, --0x1.44b225792f46bp-6, --0x1.95b49e9b62afap-3, -0x1.100b3d1dbfeaap-59, -0x1p0, --0x1.3ad06011469fbp-6, --0x1.8f8b83c69a60bp-3, -0x1.26d19b9ff8d82p-57, -0x1p0, --0x1.311552ef8623cp-6, --0x1.8961727c41804p-3, --0x1.3fdab4e42640ap-58, -0x1p0, --0x1.278104148891ap-6, --0x1.83366e89c64c6p-3, -0x1.192952df10db8p-57, -0x1p0, --0x1.1e1379690291cp-6, --0x1.7d0a7bbd2cb1cp-3, -0x1.cf900f27c58efp-57, -0x1p0, --0x1.14ccb8bdbf114p-6, --0x1.76dd9de50bf31p-3, --0x1.1d5eeec501b2fp-57, -0x1p0, --0x1.0bacc7cb9babap-6, --0x1.70afd8d08c4ffp-3, --0x1.260c3f1369484p-57, -0x1p0, --0x1.02b3ac3385232p-6, --0x1.6a81304f64ab2p-3, --0x1.f0cd73fb5d8d4p-58, -0x1p0, --0x1.f3c2d6fce7cfap-7, --0x1.6451a831d830dp-3, --0x1.ad16031a34d5p-58, -0x1p0, --0x1.e26c163ad15b3p-7, --0x1.5e214448b3fc6p-3, --0x1.531ff779ddac6p-57, -0x1p0, --0x1.d16320d2d221ep-7, --0x1.57f008654cbdep-3, --0x1.908c95c4c9118p-58, -0x1p0, --0x1.c0a80146f894cp-7, --0x1.51bdf8597c5f2p-3, -0x1.9f9976af04aa5p-61, -0x1p0, --0x1.b03ac1e94fe1dp-7, --0x1.4b8b17f79fa88p-3, --0x1.b534fe588f0dp-57, -0x1p0, --0x1.a01b6cdbd995ep-7, --0x1.45576b1293e5ap-3, -0x1.285a24119f7b1p-58, -0x1p0, --0x1.904a0c10875cep-7, --0x1.3f22f57db4893p-3, --0x1.bfe7ff2274956p-59, -0x1p0, --0x1.80c6a94934dfp-7, --0x1.38edbb0cd8d14p-3, -0x1.198c21fbf7718p-57, -0x1p0, --0x1.71914e17a1bc6p-7, --0x1.32b7bf94516a7p-3, --0x1.2a24e2431ef29p-57, -0x1p0, --0x1.62aa03dd6ba58p-7, --0x1.2c8106e8e613ap-3, --0x1.13000a89a11ep-58, -0x1p0, --0x1.5410d3cc0891ep-7, --0x1.264994dfd3409p-3, --0x1.a744ce26f39cp-57, -0x1p0, --0x1.45c5c6e4c114ap-7, --0x1.20116d4ec7bcfp-3, -0x1.242c8e1053452p-57, -0x1p0, --0x1.37c8e5f8aacep-7, --0x1.19d8940be24e7p-3, --0x1.e8dcdca90cc74p-58, -0x1p0, --0x1.2a1a39a8a2fb7p-7, --0x1.139f0cedaf577p-3, -0x1.523434d1b3cfap-57, -0x1p0, --0x1.1cb9ca654924fp-7, --0x1.0d64dbcb26786p-3, -0x1.713a562132055p-58, -0x1p0, --0x1.0fa7a06ef9e81p-7, --0x1.072a047ba831dp-3, --0x1.19db1f70118cap-58, -0x1p0, --0x1.02e3c3d5c9e17p-7, --0x1.00ee8ad6fb85bp-3, --0x1.673eac8308f11p-58, -0x1p0, --0x1.ecdc78f30165cp-8, --0x1.f564e56a9730ep-4, --0x1.a2704729ae56dp-59, -0x1p0, --0x1.d48e24132851p-8, --0x1.e8eb7fde4aa3fp-4, -0x1.23758f2d5bb8bp-58, -0x1p0, --0x1.bcdc980a46f5ap-8, --0x1.dc70ecbae9fc9p-4, --0x1.2fda2d73295eep-60, -0x1p0, --0x1.a5c7e375e55dep-8, --0x1.cff533b307dc1p-4, --0x1.8feeb8f9c3334p-59, -0x1p0, --0x1.8f501492cc296p-8, --0x1.c3785c79ec2d5p-4, -0x1.4f39df133fb21p-61, -0x1p0, --0x1.7975393cfbc4dp-8, --0x1.b6fa6ec38f64cp-4, --0x1.db5d943691f09p-58, -0x1p0, --0x1.64375eefa3dd6p-8, --0x1.aa7b724495c03p-4, --0x1.e5399ba0967b8p-58, -0x1p0, --0x1.4f9692c51b0fbp-8, --0x1.9dfb6eb24a85cp-4, --0x1.e96b47b8c44e6p-59, -0x1p0, --0x1.3b92e176d6d31p-8, --0x1.917a6bc29b42cp-4, -0x1.e2718d26ed688p-60, -0x1p0, --0x1.282c575d639fcp-8, --0x1.84f8712c130a1p-4, -0x1.e626ebafe374ep-58, -0x1p0, --0x1.156300705d51bp-8, --0x1.787586a5d5b21p-4, --0x1.5f7589f083399p-58, -0x1p0, --0x1.0336e84667c66p-8, --0x1.6bf1b3e79b129p-4, -0x1.14b6da08765p-58, -0x1p0, --0x1.e350342a4f6e6p-9, --0x1.5f6d00a9aa419p-4, -0x1.f4022d03f6c9ap-59, -0x1p0, --0x1.c16d4162779e5p-9, --0x1.52e774a4d4d0ap-4, --0x1.b2edf18c730cbp-60, -0x1p0, --0x1.a0c50d1c6bf93p-9, --0x1.4661179272096p-4, -0x1.4b109f2406c4cp-58, -0x1p0, --0x1.8157ab7d29fd9p-9, --0x1.39d9f12c5a299p-4, --0x1.1287ff27ae554p-62, -0x1p0, --0x1.63252fe77c5ebp-9, --0x1.2d52092ce19f6p-4, -0x1.9a088a8bf6b2cp-59, -0x1p0, --0x1.462dacfbef0f3p-9, --0x1.20c9674ed444dp-4, -0x1.f9d48faba7974p-58, -0x1p0, --0x1.2a713498c3c3dp-9, --0x1.1440134d709b3p-4, -0x1.fec446daea6adp-58, -0x1p0, --0x1.0fefd7d9e6ed8p-9, --0x1.07b614e463064p-4, -0x1.384f8c3ee7605p-58, -0x1p0, --0x1.ed534e31ca57fp-10, --0x1.f656e79f820ep-5, -0x1.2e1ebe392bffep-61, -0x1p0, --0x1.bd3d63d9c26efp-10, --0x1.dd406f9808ec9p-5, --0x1.1313a4b4068bdp-62, -0x1p0, --0x1.8f9e0e5514865p-10, --0x1.c428d12c0d7e3p-5, -0x1.89bc74b58c513p-60, -0x1p0, --0x1.647569c825ae1p-10, --0x1.ab101bd5f8317p-5, -0x1.65c6175c6dc68p-59, -0x1p0, --0x1.3bc390d250439p-10, --0x1.91f65f10dd814p-5, -0x1.912bd0d569a9p-61, -0x1p0, --0x1.15889c8dd385fp-10, --0x1.78dbaa5874686p-5, -0x1.4a0ef4035c29cp-60, -0x1p0, --0x1.e389491f8833ap-11, --0x1.5fc00d290cd43p-5, --0x1.a2669a693a8e1p-59, -0x1p0, --0x1.a0ef7dcffafabp-11, --0x1.46a396ff86179p-5, --0x1.136ac00fa2da9p-61, -0x1p0, --0x1.6344004228d8bp-11, --0x1.2d865759455cdp-5, --0x1.686f65ba93acp-61, -0x1p0, --0x1.2a86f68094692p-11, --0x1.14685db42c17fp-5, -0x1.2890d277cb974p-59, -0x1p0, --0x1.ed71071603e86p-12, --0x1.f693731d1cf01p-6, -0x1.3fe9bc66286c7p-66, -0x1p0, --0x1.8fb18eacc3af8p-12, --0x1.c454f4ce53b1dp-6, -0x1.d63d7fef0e36cp-60, -0x1p0, --0x1.3bcfbd9979a27p-12, --0x1.92155f7a3667ep-6, -0x1.b1d63091a013p-64, -0x1p0, --0x1.e3978f34889d9p-13, --0x1.5fd4d21fab226p-6, -0x1.0c0a91c37851cp-61, -0x1p0, --0x1.634bb4ae5ed49p-13, --0x1.2d936bbe30efdp-6, --0x1.b5f91ee371d64p-61, -0x1p0, --0x1.ed7875885ea3ap-14, --0x1.f6a296ab997cbp-7, -0x1.f2943d8fe7033p-61, -0x1p0, --0x1.3bd2c8da49511p-14, --0x1.921d1fcdec784p-7, --0x1.9878ebe836d9dp-61, -0x1p0, --0x1.634da1cec522dp-15, --0x1.2d96b0e509703p-7, -0x1.1e9131ff52dc9p-63, -0x1p0, --0x1.3bd38bab6d94cp-16, --0x1.921f0fe670071p-8, --0x1.ab967fe6b7a9bp-64, -0x1p0, --0x1.3bd3bc5fc5ab4p-18, --0x1.921f8becca4bap-9, --0x1.2ba407bcab5b2p-63, -0x1p0, -0, -0, -0, -0x1p0, --0x1.3bd3bc5fc5ab4p-18, -0x1.921f8becca4bap-9, -0x1.2ba407bcab5b2p-63, -0x1p0, --0x1.3bd38bab6d94cp-16, -0x1.921f0fe670071p-8, -0x1.ab967fe6b7a9bp-64, -0x1p0, --0x1.634da1cec522dp-15, -0x1.2d96b0e509703p-7, --0x1.1e9131ff52dc9p-63, -0x1p0, --0x1.3bd2c8da49511p-14, -0x1.921d1fcdec784p-7, -0x1.9878ebe836d9dp-61, -0x1p0, --0x1.ed7875885ea3ap-14, -0x1.f6a296ab997cbp-7, --0x1.f2943d8fe7033p-61, -0x1p0, --0x1.634bb4ae5ed49p-13, -0x1.2d936bbe30efdp-6, -0x1.b5f91ee371d64p-61, -0x1p0, --0x1.e3978f34889d9p-13, -0x1.5fd4d21fab226p-6, --0x1.0c0a91c37851cp-61, -0x1p0, --0x1.3bcfbd9979a27p-12, -0x1.92155f7a3667ep-6, --0x1.b1d63091a013p-64, -0x1p0, --0x1.8fb18eacc3af8p-12, -0x1.c454f4ce53b1dp-6, --0x1.d63d7fef0e36cp-60, -0x1p0, --0x1.ed71071603e86p-12, -0x1.f693731d1cf01p-6, --0x1.3fe9bc66286c7p-66, -0x1p0, --0x1.2a86f68094692p-11, -0x1.14685db42c17fp-5, --0x1.2890d277cb974p-59, -0x1p0, --0x1.6344004228d8bp-11, -0x1.2d865759455cdp-5, -0x1.686f65ba93acp-61, -0x1p0, --0x1.a0ef7dcffafabp-11, -0x1.46a396ff86179p-5, -0x1.136ac00fa2da9p-61, -0x1p0, --0x1.e389491f8833ap-11, -0x1.5fc00d290cd43p-5, -0x1.a2669a693a8e1p-59, -0x1p0, --0x1.15889c8dd385fp-10, -0x1.78dbaa5874686p-5, --0x1.4a0ef4035c29cp-60, -0x1p0, --0x1.3bc390d250439p-10, -0x1.91f65f10dd814p-5, --0x1.912bd0d569a9p-61, -0x1p0, --0x1.647569c825ae1p-10, -0x1.ab101bd5f8317p-5, --0x1.65c6175c6dc68p-59, -0x1p0, --0x1.8f9e0e5514865p-10, -0x1.c428d12c0d7e3p-5, --0x1.89bc74b58c513p-60, -0x1p0, --0x1.bd3d63d9c26efp-10, -0x1.dd406f9808ec9p-5, -0x1.1313a4b4068bdp-62, -0x1p0, --0x1.ed534e31ca57fp-10, -0x1.f656e79f820ep-5, --0x1.2e1ebe392bffep-61, -0x1p0, --0x1.0fefd7d9e6ed8p-9, -0x1.07b614e463064p-4, --0x1.384f8c3ee7605p-58, -0x1p0, --0x1.2a713498c3c3dp-9, -0x1.1440134d709b3p-4, --0x1.fec446daea6adp-58, -0x1p0, --0x1.462dacfbef0f3p-9, -0x1.20c9674ed444dp-4, --0x1.f9d48faba7974p-58, -0x1p0, --0x1.63252fe77c5ebp-9, -0x1.2d52092ce19f6p-4, --0x1.9a088a8bf6b2cp-59, -0x1p0, --0x1.8157ab7d29fd9p-9, -0x1.39d9f12c5a299p-4, -0x1.1287ff27ae554p-62, -0x1p0, --0x1.a0c50d1c6bf93p-9, -0x1.4661179272096p-4, --0x1.4b109f2406c4cp-58, -0x1p0, --0x1.c16d4162779e5p-9, -0x1.52e774a4d4d0ap-4, -0x1.b2edf18c730cbp-60, -0x1p0, --0x1.e350342a4f6e6p-9, -0x1.5f6d00a9aa419p-4, --0x1.f4022d03f6c9ap-59, -0x1p0, --0x1.0336e84667c66p-8, -0x1.6bf1b3e79b129p-4, --0x1.14b6da08765p-58, -0x1p0, --0x1.156300705d51bp-8, -0x1.787586a5d5b21p-4, -0x1.5f7589f083399p-58, -0x1p0, --0x1.282c575d639fcp-8, -0x1.84f8712c130a1p-4, --0x1.e626ebafe374ep-58, -0x1p0, --0x1.3b92e176d6d31p-8, -0x1.917a6bc29b42cp-4, --0x1.e2718d26ed688p-60, -0x1p0, --0x1.4f9692c51b0fbp-8, -0x1.9dfb6eb24a85cp-4, -0x1.e96b47b8c44e6p-59, -0x1p0, --0x1.64375eefa3dd6p-8, -0x1.aa7b724495c03p-4, -0x1.e5399ba0967b8p-58, -0x1p0, --0x1.7975393cfbc4dp-8, -0x1.b6fa6ec38f64cp-4, -0x1.db5d943691f09p-58, -0x1p0, --0x1.8f501492cc296p-8, -0x1.c3785c79ec2d5p-4, --0x1.4f39df133fb21p-61, -0x1p0, --0x1.a5c7e375e55dep-8, -0x1.cff533b307dc1p-4, -0x1.8feeb8f9c3334p-59, -0x1p0, --0x1.bcdc980a46f5ap-8, -0x1.dc70ecbae9fc9p-4, -0x1.2fda2d73295eep-60, -0x1p0, --0x1.d48e24132851p-8, -0x1.e8eb7fde4aa3fp-4, --0x1.23758f2d5bb8bp-58, -0x1p0, --0x1.ecdc78f30165cp-8, -0x1.f564e56a9730ep-4, -0x1.a2704729ae56dp-59, -0x1p0, --0x1.02e3c3d5c9e17p-7, -0x1.00ee8ad6fb85bp-3, -0x1.673eac8308f11p-58, -0x1p0, --0x1.0fa7a06ef9e81p-7, -0x1.072a047ba831dp-3, -0x1.19db1f70118cap-58, -0x1p0, --0x1.1cb9ca654924fp-7, -0x1.0d64dbcb26786p-3, --0x1.713a562132055p-58, -0x1p0, --0x1.2a1a39a8a2fb7p-7, -0x1.139f0cedaf577p-3, --0x1.523434d1b3cfap-57, -0x1p0, --0x1.37c8e5f8aacep-7, -0x1.19d8940be24e7p-3, -0x1.e8dcdca90cc74p-58, -0x1p0, --0x1.45c5c6e4c114ap-7, -0x1.20116d4ec7bcfp-3, --0x1.242c8e1053452p-57, -0x1p0, --0x1.5410d3cc0891ep-7, -0x1.264994dfd3409p-3, -0x1.a744ce26f39cp-57, -0x1p0, --0x1.62aa03dd6ba58p-7, -0x1.2c8106e8e613ap-3, -0x1.13000a89a11ep-58, -0x1p0, --0x1.71914e17a1bc6p-7, -0x1.32b7bf94516a7p-3, -0x1.2a24e2431ef29p-57, -0x1p0, --0x1.80c6a94934dfp-7, -0x1.38edbb0cd8d14p-3, --0x1.198c21fbf7718p-57, -0x1p0, --0x1.904a0c10875cep-7, -0x1.3f22f57db4893p-3, -0x1.bfe7ff2274956p-59, -0x1p0, --0x1.a01b6cdbd995ep-7, -0x1.45576b1293e5ap-3, --0x1.285a24119f7b1p-58, -0x1p0, --0x1.b03ac1e94fe1dp-7, -0x1.4b8b17f79fa88p-3, -0x1.b534fe588f0dp-57, -0x1p0, --0x1.c0a80146f894cp-7, -0x1.51bdf8597c5f2p-3, --0x1.9f9976af04aa5p-61, -0x1p0, --0x1.d16320d2d221ep-7, -0x1.57f008654cbdep-3, -0x1.908c95c4c9118p-58, -0x1p0, --0x1.e26c163ad15b3p-7, -0x1.5e214448b3fc6p-3, -0x1.531ff779ddac6p-57, -0x1p0, --0x1.f3c2d6fce7cfap-7, -0x1.6451a831d830dp-3, -0x1.ad16031a34d5p-58, -0x1p0, --0x1.02b3ac3385232p-6, -0x1.6a81304f64ab2p-3, -0x1.f0cd73fb5d8d4p-58, -0x1p0, --0x1.0bacc7cb9babap-6, -0x1.70afd8d08c4ffp-3, -0x1.260c3f1369484p-57, -0x1p0, --0x1.14ccb8bdbf114p-6, -0x1.76dd9de50bf31p-3, -0x1.1d5eeec501b2fp-57, -0x1p0, --0x1.1e1379690291cp-6, -0x1.7d0a7bbd2cb1cp-3, --0x1.cf900f27c58efp-57, -0x1p0, --0x1.278104148891ap-6, -0x1.83366e89c64c6p-3, --0x1.192952df10db8p-57, -0x1p0, --0x1.311552ef8623cp-6, -0x1.8961727c41804p-3, -0x1.3fdab4e42640ap-58, -0x1p0, --0x1.3ad06011469fbp-6, -0x1.8f8b83c69a60bp-3, --0x1.26d19b9ff8d82p-57, -0x1p0, --0x1.44b225792f46bp-6, -0x1.95b49e9b62afap-3, --0x1.100b3d1dbfeaap-59, -0x1p0, --0x1.4eba9d0ec2f7cp-6, -0x1.9bdcbf2dc4366p-3, -0x1.9632d189956fep-57, -0x1p0, --0x1.58e9c0a1a5f21p-6, -0x1.a203e1b1831dap-3, -0x1.c1aadb580a1ecp-58, -0x1p0, --0x1.633f89e9a1a66p-6, -0x1.a82a025b00451p-3, --0x1.87905ffd084adp-57, -0x1p0, --0x1.6dbbf286a8971p-6, -0x1.ae4f1d5f3b9abp-3, -0x1.aa8bbcef9b68ep-57, -0x1p0, --0x1.785ef400da46cp-6, -0x1.b4732ef3d6722p-3, -0x1.bbe5d5d75cbd8p-57, -0x1p0, --0x1.832887c88735dp-6, -0x1.ba96334f15dadp-3, --0x1.75098c05dd18ap-57, -0x1p0, --0x1.8e18a73634ee7p-6, -0x1.c0b826a7e4f63p-3, --0x1.af1439e521935p-62, -0x1p0, --0x1.992f4b8aa21f8p-6, -0x1.c6d90535d74ddp-3, --0x1.bfb2be2264962p-59, -0x1p0, --0x1.a46c6deecac5fp-6, -0x1.ccf8cb312b286p-3, -0x1.2382b0aecadf8p-58, -0x1p0, --0x1.afd00773ec64fp-6, -0x1.d31774d2cbdeep-3, -0x1.2fdc8e5791a0bp-57, -0x1p0, --0x1.bb5a11138a4c9p-6, -0x1.d934fe5454311p-3, -0x1.75b92277107adp-57, -0x1p0, --0x1.c70a83af71ef5p-6, -0x1.df5163f01099ap-3, --0x1.01f7d79906e86p-57, -0x1p0, --0x1.d2e15811bf462p-6, -0x1.e56ca1e101a1bp-3, -0x1.46ac3f9fd0227p-57, -0x1p0, --0x1.dede86ece142ep-6, -0x1.eb86b462de348p-3, --0x1.bfcde46f90b62p-57, -0x1p0, --0x1.eb0208db9e51bp-6, -0x1.f19f97b215f1bp-3, --0x1.42deef11da2c4p-57, -0x1p0, --0x1.f74bd66118e8dp-6, -0x1.f7b7480bd3802p-3, --0x1.9a96d967ee12ep-57, -0x1p0, --0x1.01ddf3f46a139p-5, -0x1.fdcdc1adfedf9p-3, --0x1.2dba4580ed7bbp-57, -0x1p0, --0x1.08291ae35c407p-5, -0x1.01f1806b9fdd2p-2, --0x1.448135394b8bap-56, -0x1p0, --0x1.0e875c1b8c3dap-5, -0x1.04fb80e37fdaep-2, --0x1.412cdb72583ccp-63, -0x1p0, --0x1.14f8b3af5abb9p-5, -0x1.0804e05eb661ep-2, -0x1.54e583d92d3d8p-56, -0x1p0, --0x1.1b7d1da562443p-5, -0x1.0b0d9cfdbdb9p-2, -0x1.3b3a7b8d1200dp-58, -0x1p0, --0x1.221495f879af5p-5, -0x1.0e15b4e1749cep-2, --0x1.5b7fb156c550ap-56, -0x1p0, --0x1.28bf1897b69ccp-5, -0x1.111d262b1f677p-2, -0x1.824c20ab7aa9ap-56, -0x1p0, --0x1.2f7ca1666ff6fp-5, -0x1.1423eefc69378p-2, -0x1.22d3368ec9b62p-56, -0x1p0, --0x1.364d2c3c407bep-5, -0x1.172a0d7765177p-2, -0x1.22575f33366bep-57, -0x1p0, --0x1.3d30b4e5094ep-5, -0x1.1a2f7fbe8f243p-2, -0x1.6465ac86ba7b2p-56, -0x1p0, --0x1.44273720f48bcp-5, -0x1.1d3443f4cdb3ep-2, --0x1.720d41c13519ep-57, -0x1p0, --0x1.4b30aea477eeep-5, -0x1.2038583d727bep-2, --0x1.c69cd46300a3p-57, -0x1p0, --0x1.524d171857726p-5, -0x1.233bbabc3bb71p-2, -0x1.99b04e23259efp-56, -0x1p0, --0x1.597c6c19a8003p-5, -0x1.263e6995554bap-2, -0x1.1d350ffc5ff32p-56, -0x1p0, --0x1.60bea939d225ap-5, -0x1.294062ed59f06p-2, --0x1.5d28da2c4612dp-56, -0x1p0, --0x1.6813c9fe94cfbp-5, -0x1.2c41a4e95452p-2, -0x1.9cf0354aad2dcp-56, -0x1p0, --0x1.6f7bc9e2080d9p-5, -0x1.2f422daec0387p-2, --0x1.7501ba473da6fp-56, -0x1p0, --0x1.76f6a4529fdb5p-5, -0x1.3241fb638baafp-2, -0x1.ecee8f76f8c51p-60, -0x1p0, --0x1.7e8454b32ef34p-5, -0x1.35410c2e18152p-2, --0x1.3cb002f96e062p-56, -0x1p0, --0x1.8624d65ae9a63p-5, -0x1.383f5e353b6abp-2, --0x1.a812a4a5c3d44p-56, -0x1p0, --0x1.8dd8249568bbbp-5, -0x1.3b3cefa0414b7p-2, -0x1.f36dc4a9c2294p-56, -0x1p0, --0x1.959e3aa2ac58dp-5, -0x1.3e39be96ec271p-2, -0x1.814c6de9aaaf6p-56, -0x1p0, --0x1.9d7713b71eee1p-5, -0x1.4135c94176601p-2, -0x1.0c97c4afa2518p-56, -0x1p0, --0x1.a562aafb982cdp-5, -0x1.44310dc8936fp-2, -0x1.8b694e91d3125p-56, -0x1p0, --0x1.ad60fb8d6003ap-5, -0x1.472b8a5571054p-2, --0x1.01ea0fe4dff23p-56, -0x1p0, --0x1.b572007e31a1bp-5, -0x1.4a253d11b82f3p-2, --0x1.2afa4d6d42a55p-58, -0x1p0, --0x1.bd95b4d43e819p-5, -0x1.4d1e24278e76ap-2, -0x1.2417218792858p-57, -0x1p0, --0x1.c5cc138a317afp-5, -0x1.50163dc197048p-2, --0x1.ec66cb05c7ea4p-56, -0x1p0, --0x1.ce15178f31db3p-5, -0x1.530d880af3c24p-2, --0x1.fab8e2103fbd6p-56, -0x1p0, --0x1.d670bbc6e685ep-5, -0x1.5604012f467b4p-2, -0x1.a0e0b2a5b25p-56, -0x1p0, --0x1.dedefb09791b4p-5, -0x1.58f9a75ab1fddp-2, --0x1.efdc0d58cf62p-62, -0x1p0, --0x1.e75fd0239926cp-5, -0x1.5bee78b9db3b6p-2, -0x1.e734a63158dfdp-58, -0x1p0, --0x1.eff335d67f541p-5, -0x1.5ee27379ea693p-2, -0x1.634ff2fa75245p-56, -0x1p0, --0x1.f89926d7f0ab8p-5, -0x1.61d595c88c202p-2, -0x1.f6b1e333415d7p-56, -0x1p0, --0x1.00a8cee920eabp-4, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4a664121p-58, -0x1p0, --0x1.050e4ab22d321p-4, -0x1.67b949cad63cbp-2, --0x1.a23369348d7efp-56, -0x1p0, --0x1.097d0410dc132p-4, -0x1.6aa9d7dc77e17p-2, --0x1.38b470592c7b3p-56, -0x1p0, --0x1.0df4f849393f5p-4, -0x1.6d998638a0cb6p-2, --0x1.1ca14532860dfp-61, -0x1p0, --0x1.127624999ee1dp-4, -0x1.7088530fa459fp-2, --0x1.44b19e0864c5dp-56, -0x1p0, --0x1.1700863ab7533p-4, -0x1.73763c9261092p-2, --0x1.52324face3b1ap-57, -0x1p0, --0x1.1b941a5f7ecffp-4, -0x1.766340f2418f6p-2, -0x1.2b2adc9041b2cp-56, -0x1p0, --0x1.2030de354532cp-4, -0x1.794f5e613dfaep-2, -0x1.820a4b0d21fc5p-57, -0x1p0, --0x1.24d6cee3afb2ap-4, -0x1.7c3a9311dcce7p-2, -0x1.9a3f21ef3e8d9p-62, -0x1p0, --0x1.2985e98cbaa3ap-4, -0x1.7f24dd37341e4p-2, -0x1.2791a1b5eb796p-57, -0x1p0, --0x1.2e3e2b4cbb3c3p-4, -0x1.820e3b04eaac4p-2, --0x1.92379eb01c6b6p-59, -0x1p0, --0x1.32ff913a615dp-4, -0x1.84f6aaaf3903fp-2, -0x1.6dcdc2bd47067p-57, -0x1p0, --0x1.37ca1866b95cfp-4, -0x1.87de2a6aea963p-2, --0x1.72cedd3d5a61p-57, -0x1p0, --0x1.3c9dbddd2dd84p-4, -0x1.8ac4b86d5ed44p-2, -0x1.17fa7f944ad5bp-56, -0x1p0, --0x1.417a7ea389835p-4, -0x1.8daa52ec8a4bp-2, --0x1.72eb2db8c621ep-57, -0x1p0, --0x1.466057b9f900ap-4, -0x1.908ef81ef7bd1p-2, -0x1.4c00267012357p-56, -0x1p0, --0x1.4b4f461b0cbaap-4, -0x1.9372a63bc93d7p-2, -0x1.684319e5ad5b1p-57, -0x1p0, --0x1.504746bbbac0bp-4, -0x1.96555b7ab948fp-2, -0x1.7afd51eff33adp-56, -0x1p0, --0x1.5548568b60a7bp-4, -0x1.993716141bdffp-2, --0x1.15e8cce261c55p-56, -0x1p0, --0x1.5a527273c56e1p-4, -0x1.9c17d440df9f2p-2, -0x1.923c540a9eec4p-57, -0x1p0, --0x1.5f6597591b633p-4, -0x1.9ef7943a8ed8ap-2, -0x1.6da81290bdbabp-57, -0x1p0, --0x1.6481c21a02123p-4, -0x1.a1d6543b50acp-2, --0x1.0246cfd8779fbp-57, -0x1p0, --0x1.69a6ef8f8830ap-4, -0x1.a4b4127dea1e5p-2, --0x1.bec6f01bc22f1p-56, -0x1p0, --0x1.6ed51c8d2d8fcp-4, -0x1.a790cd3dbf31bp-2, --0x1.7f786986d9023p-57, -0x1p0, --0x1.740c45e0e512p-4, -0x1.aa6c82b6d3fcap-2, --0x1.d5f106ee5ccf7p-56, -0x1p0, --0x1.794c685316a3cp-4, -0x1.ad473125cdc09p-2, --0x1.379ede57649dap-58, -0x1p0, --0x1.7e9580a6a136ep-4, -0x1.b020d6c7f4009p-2, -0x1.414ae7e555208p-58, -0x1p0, --0x1.83e78b98dcc2bp-4, -0x1.b2f971db31972p-2, -0x1.fa971a4a41f2p-56, -0x1p0, --0x1.894285e19c468p-4, -0x1.b5d1009e15ccp-2, -0x1.5b362cb974183p-57, -0x1p0, --0x1.8ea66c332fd01p-4, -0x1.b8a7814fd5693p-2, -0x1.9a9e6651cc119p-56, -0x1p0, --0x1.94133b3a66851p-4, -0x1.bb7cf2304bd01p-2, -0x1.9e1a5bd9269d4p-57, -0x1p0, --0x1.9988ef9e90b04p-4, -0x1.be51517ffc0d9p-2, -0x1.2b667131a5f16p-56, -0x1p0, --0x1.9f07860181d1ep-4, -0x1.c1249d8011ee7p-2, --0x1.813aabb515206p-56, -0x1p0, --0x1.a48efaff92b3bp-4, -0x1.c3f6d47263129p-2, -0x1.9c7bd0fcdecddp-56, -0x1p0, --0x1.aa1f4b2fa37fcp-4, -0x1.c6c7f4997000bp-2, --0x1.bec2669c68e74p-56, -0x1p0, --0x1.afb873231ddb9p-4, -0x1.c997fc3865389p-2, --0x1.6295f8b0ca33bp-56, -0x1p0, --0x1.b55a6f65f7058p-4, -0x1.cc66e9931c45ep-2, -0x1.6850e59c37f8fp-58, -0x1p0, --0x1.bb053c7eb1f68p-4, -0x1.cf34baee1cd21p-2, --0x1.118724d19d014p-56, -0x1p0, --0x1.c0b8d6ee61867p-4, -0x1.d2016e8e9db5bp-2, --0x1.c8bce9d93efb8p-57, -0x1p0, --0x1.c6753b30aa949p-4, -0x1.d4cd02ba8609dp-2, --0x1.37f33c63033d6p-57, -0x1p0, --0x1.cc3a65bbc6327p-4, -0x1.d79775b86e389p-2, -0x1.550ec87bc0575p-56, -0x1p0, --0x1.d208530083d3p-4, -0x1.da60c5cfa10d9p-2, --0x1.0f38e2143c8d5p-57, -0x1p0, --0x1.d7deff6a4b7c9p-4, -0x1.dd28f1481cc58p-2, --0x1.e7576fa6c944ep-59, -0x1p0, --0x1.ddbe675f1ffdfp-4, -0x1.dfeff66a941dep-2, --0x1.a756c6e625f96p-56, -0x1p0, --0x1.e3a6873fa1279p-4, -0x1.e2b5d3806f63bp-2, -0x1.e0d891d3c6841p-58, -0x1p0, --0x1.e9975b670e077p-4, -0x1.e57a86d3cd825p-2, --0x1.2c80dcd511e87p-57, -0x1p0, --0x1.ef90e02b47283p-4, -0x1.e83e0eaf85114p-2, --0x1.7bc380ef24ba7p-57, -0x1p0, --0x1.f59311dcd0d44p-4, -0x1.eb00695f2562p-2, -0x1.53c9fd3083e22p-56, -0x1p0, --0x1.fb9decc6d55b8p-4, -0x1.edc1952ef78d6p-2, --0x1.dd0f7c33edee6p-56, -0x1p0, --0x1.00d8b69793ae4p-3, -0x1.f081906bff7fep-2, --0x1.4cab2d4ff6fccp-56, -0x1p0, --0x1.03e6c7ab2208cp-3, -0x1.f3405963fd067p-2, -0x1.06846d44a238fp-56, -0x1p0, --0x1.06f927bbaacfep-3, -0x1.f5fdee656cda3p-2, --0x1.7bf9780816b05p-58, -0x1p0, --0x1.0a0fd4e41ab5ap-3, -0x1.f8ba4dbf89abap-2, --0x1.2ec1fc1b776b8p-60, -0x1p0, --0x1.0d2acd3cb7364p-3, -0x1.fb7575c24d2dep-2, --0x1.5bfdc883c8664p-57, -0x1p0, --0x1.104a0edb1fc58p-3, -0x1.fe2f64be7121p-2, --0x1.297ab1ca2d7dbp-56, -0x1p0, --0x1.136d97d24efccp-3, -0x1.00740c82b82e1p-1, --0x1.6d48563c60e87p-55, -0x1p0, --0x1.169566329bcb7p-3, -0x1.01cfc874c3eb7p-1, --0x1.34a35e7c2368cp-56, -0x1p0, --0x1.19c17809baa87p-3, -0x1.032ae55edbd96p-1, --0x1.bdb022b40107ap-55, -0x1p0, --0x1.1cf1cb62bec5dp-3, -0x1.0485626ae221ap-1, -0x1.b937d9091ff7p-55, -0x1p0, --0x1.20265e461b45ap-3, -0x1.05df3ec31b8b7p-1, --0x1.e2dcad34d9c1dp-57, -0x1p0, --0x1.235f2eb9a470ap-3, -0x1.073879922ffeep-1, --0x1.a5a014347406cp-55, -0x1p0, --0x1.269c3ac090ee4p-3, -0x1.089112032b08cp-1, -0x1.3248ddf9fe619p-57, -0x1p0, --0x1.29dd805b7afecp-3, -0x1.09e907417c5e1p-1, --0x1.fe573741a9bd4p-55, -0x1p0, --0x1.2d22fd8861b6bp-3, -0x1.0b405878f85ecp-1, --0x1.ad66c3bb80da5p-55, -0x1p0, --0x1.306cb042aa3bap-3, -0x1.0c9704d5d898fp-1, --0x1.8d3d7de6ee9b2p-55, -0x1p0, --0x1.33ba968321032p-3, -0x1.0ded0b84bc4b6p-1, --0x1.8540fa327c55cp-55, -0x1p0, --0x1.370cae3ffb12fp-3, -0x1.0f426bb2a8e7ep-1, --0x1.bb58fb774f8eep-55, -0x1p0, --0x1.3a62f56cd742ep-3, -0x1.1097248d0a957p-1, --0x1.7a58759ba80ddp-55, -0x1p0, --0x1.3dbd69fabf802p-3, -0x1.11eb3541b4b23p-1, --0x1.ef23b69abe4f1p-55, -0x1p0, --0x1.411c09d82a128p-3, -0x1.133e9cfee254fp-1, --0x1.a1377cfd5ce5p-56, -0x1p0, --0x1.447ed2f0fae31p-3, -0x1.14915af336cebp-1, -0x1.f3660558a0213p-56, -0x1p0, --0x1.47e5c32e84c45p-3, -0x1.15e36e4dbe2bcp-1, -0x1.3c545f7d79eaep-56, -0x1p0, --0x1.4b50d8778abbdp-3, -0x1.1734d63dedb49p-1, --0x1.7eef2ccc50575p-55, -0x1p0, --0x1.4ec010b0414e1p-3, -0x1.188591f3a46e5p-1, --0x1.bbefe5a524346p-56, -0x1p0, --0x1.523369ba4fcaep-3, -0x1.19d5a09f2b9b8p-1, --0x1.33656c68a1d4ap-57, -0x1p0, --0x1.55aae174d19c8p-3, -0x1.1b250171373bfp-1, --0x1.b210e95e1ca4cp-55, -0x1p0, --0x1.592675bc57974p-3, -0x1.1c73b39ae68c8p-1, -0x1.b25dd267f66p-55, -0x1p0, --0x1.5ca6246ae94b8p-3, -0x1.1dc1b64dc4872p-1, -0x1.f15e1c468be78p-57, -0x1p0, --0x1.6029eb580658ep-3, -0x1.1f0f08bbc861bp-1, --0x1.10d9dcafb74cbp-57, -0x1p0, --0x1.63b1c858a7c2ep-3, -0x1.205baa17560d6p-1, -0x1.b7b144016c7a3p-56, -0x1p0, --0x1.673db93f41479p-3, -0x1.21a799933eb59p-1, --0x1.3a7b177c68fb2p-55, -0x1p0, --0x1.6acdbbdbc2b73p-3, -0x1.22f2d662c13e2p-1, --0x1.d5cc7580cb6d2p-55, -0x1p0, --0x1.6e61cdfb994dfp-3, -0x1.243d5fb98ac1fp-1, -0x1.c533d0a284a8dp-56, -0x1p0, --0x1.71f9ed69b10eap-3, -0x1.258734cbb711p-1, -0x1.3a3f0903ce09dp-57, -0x1p0, --0x1.759617ee761f9p-3, -0x1.26d054cdd12dfp-1, --0x1.5da743ef3770cp-55, -0x1p0, --0x1.79364b4fd6288p-3, -0x1.2818bef4d3cbap-1, --0x1.e3fffeb76568ap-56, -0x1p0, --0x1.7cda855141b26p-3, -0x1.2960727629ca8p-1, -0x1.56d6c7af02d5cp-56, -0x1p0, --0x1.8082c3b3ad887p-3, -0x1.2aa76e87aeb58p-1, -0x1.fd600833287a7p-59, -0x1p0, --0x1.842f0435941afp-3, -0x1.2bedb25faf3eap-1, --0x1.14981c796ee46p-58, -0x1p0, --0x1.87df4492f6e38p-3, -0x1.2d333d34e9bb8p-1, --0x1.0e2c2c5549e26p-55, -0x1p0, --0x1.8b9382855fcaap-3, -0x1.2e780e3e8ea17p-1, --0x1.b19fafe36587ap-55, -0x1p0, --0x1.8f4bbbc3e28f6p-3, -0x1.2fbc24b441015p-1, -0x1.dba4875410874p-57, -0x1p0, --0x1.9307ee031e2fdp-3, -0x1.30ff7fce17035p-1, --0x1.efcc626f74a6fp-57, -0x1p0, --0x1.96c816f53e539p-3, -0x1.32421ec49a61fp-1, -0x1.65e25cc951bfep-55, -0x1p0, --0x1.9a8c3449fcb77p-3, -0x1.338400d0c8e57p-1, --0x1.abf2a5e95e6e5p-55, -0x1p0, --0x1.9e5443aea29b2p-3, -0x1.34c5252c14de1p-1, -0x1.583f49632ab2bp-55, -0x1p0, --0x1.a22042ce0a2f9p-3, -0x1.36058b10659f3p-1, --0x1.1fcb3a35857e7p-55, -0x1p0, --0x1.a5f02f50a007cp-3, -0x1.374531b817f8dp-1, -0x1.444d2b0a747fep-55, -0x1p0, --0x1.a9c406dc648a5p-3, -0x1.3884185dfeb22p-1, --0x1.a038026abe6b2p-56, -0x1p0, --0x1.ad9bc714ed64fp-3, -0x1.39c23e3d63029p-1, --0x1.3b05b276085c1p-58, -0x1p0, --0x1.b1776d9b67013p-3, -0x1.3affa292050b9p-1, -0x1.e3e25e3954964p-56, -0x1p0, --0x1.b556f80e95facp-3, -0x1.3c3c44981c518p-1, --0x1.b5e9a9644151bp-55, -0x1p0, --0x1.b93a640ad8978p-3, -0x1.3d78238c58344p-1, --0x1.0219f5f0f79cep-55, -0x1p0, --0x1.bd21af2a28408p-3, -0x1.3eb33eabe068p-1, -0x1.86a2357d1a0d3p-58, -0x1p0, --0x1.c10cd7041afccp-3, -0x1.3fed9534556d4p-1, -0x1.36916608c5061p-55, -0x1p0, --0x1.c4fbd92de4eddp-3, -0x1.41272663d108cp-1, -0x1.1bbe7636fadf5p-55, -0x1p0, --0x1.c8eeb33a59cdp-3, -0x1.425ff178e6bb1p-1, -0x1.7b38d675140cap-55, -0x1p0, --0x1.cce562b9ee6aep-3, -0x1.4397f5b2a438p-1, --0x1.7274c9e48c226p-55, -0x1p0, --0x1.d0dfe53aba2fdp-3, -0x1.44cf325091dd6p-1, -0x1.8076a2cfdc6b3p-57, -0x1p0, --0x1.d4de3848789e2p-3, -0x1.4605a692b32a2p-1, -0x1.21ca219b97107p-55, -0x1p0, --0x1.d8e0596c8ad56p-3, -0x1.473b51b987347p-1, -0x1.ca1953514e41bp-57, -0x1p0, --0x1.dce6462df917dp-3, -0x1.48703306091ffp-1, --0x1.70813b86159fdp-57, -0x1p0, --0x1.e0effc1174505p-3, -0x1.49a449b9b0939p-1, --0x1.27ee16d719b94p-55, -0x1p0, --0x1.e4fd7899579acp-3, -0x1.4ad79516722f1p-1, --0x1.1273b163000f7p-55, -0x1p0, --0x1.e90eb945a9ccfp-3, -0x1.4c0a145ec0004p-1, -0x1.2630cfafceaa1p-58, -0x1p0, --0x1.ed23bb941f019p-3, -0x1.4d3bc6d589f7fp-1, -0x1.6e4d9d6b72011p-55, -0x1p0, --0x1.f13c7d001a249p-3, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293edceb327p-57, -0x1p0, --0x1.f558fb02ae805p-3, -0x1.4f9cc25cca486p-1, -0x1.48b5951cfc2b5p-55, -0x1p0, --0x1.f9793312a14d1p-3, -0x1.50cc09f59a09bp-1, -0x1.693463a2c2e6fp-56, -0x1p0, --0x1.fd9d22a46b416p-3, -0x1.51fa81cd99aa6p-1, --0x1.499f59d8560e9p-63, -0x1p0, --0x1.00e263951d11fp-2, -0x1.5328292a35596p-1, --0x1.a12eb89da0257p-56, -0x1p0, --0x1.02f80f09f92f4p-2, -0x1.5454ff5159dfcp-1, --0x1.4e247588bf256p-55, -0x1p0, --0x1.050f92679849cp-2, -0x1.5581038975137p-1, -0x1.4570d9efe26dfp-55, -0x1p0, --0x1.0728ec63a599ap-2, -0x1.56ac35197649fp-1, --0x1.f7874188cb279p-55, -0x1p0, --0x1.09441bb2aa0a2p-2, -0x1.57d69348cecap-1, --0x1.75720992bfbb2p-55, -0x1p0, --0x1.0b611f080d05bp-2, -0x1.59001d5f723dfp-1, -0x1.a9f86ba0dde98p-56, -0x1p0, --0x1.0d7ff51615437p-2, -0x1.5a28d2a5d725p-1, -0x1.57a25f8b1343p-55, -0x1p0, --0x1.0fa09c8de994bp-2, -0x1.5b50b264f7448p-1, -0x1.519d30d4cfebp-56, -0x1p0, --0x1.11c3141f91b3ep-2, -0x1.5c77bbe65018cp-1, -0x1.069ea9c0bc32ap-55, -0x1p0, --0x1.13e75a79f7139p-2, -0x1.5d9dee73e345cp-1, --0x1.de1165ecdf7a3p-57, -0x1p0, --0x1.160d6e4ae5ae6p-2, -0x1.5ec3495837074p-1, -0x1.dea89a9b8f727p-56, -0x1p0, --0x1.18354e3f0cd7dp-2, -0x1.5fe7cbde56a1p-1, --0x1.fcb9cc30cc01ep-55, -0x1p0, --0x1.1a5ef902000d3p-2, -0x1.610b7551d2cdfp-1, --0x1.251b352ff2a37p-56, -0x1p0, --0x1.1c8a6d3e37c82p-2, -0x1.622e44fec22ffp-1, -0x1.f98d8be132d57p-56, -0x1p0, --0x1.1eb7a99d1250cp-2, -0x1.63503a31c1be9p-1, -0x1.1248f09e6587cp-57, -0x1p0, --0x1.20e6acc6d4916p-2, -0x1.64715437f535bp-1, --0x1.7c399c15a17dp-55, -0x1p0, --0x1.23177562aaea3p-2, -0x1.6591925f0783dp-1, -0x1.c3d64fbf5de23p-55, -0x1p0, --0x1.254a0216aa067p-2, -0x1.66b0f3f52b386p-1, -0x1.1e2eb31a8848bp-55, -0x1p0, --0x1.277e5187cfb16p-2, -0x1.67cf78491af1p-1, -0x1.750ab23477b61p-59, -0x1p0, --0x1.29b4625a03ac9p-2, -0x1.68ed1eaa19c71p-1, -0x1.fd4a85350f69p-56, -0x1p0, -0, -0x1.6a09e667f3bcdp-1, --0x1.bdd3413b26456p-55, -0, -0x1.a3b47aa8671c5p-3, -0x1.6b25ced2fe29cp-1, --0x1.5ac64116beda5p-55, -0x1p-1, -0x1.9f3de1246bc4p-3, -0x1.6c40d73c18275p-1, -0x1.25d4f802be257p-57, -0x1p-1, -0x1.9ac3cfd4ace19p-3, -0x1.6d5afef4aafcdp-1, --0x1.868a696b8835ep-55, -0x1p-1, -0x1.9646497c1e0f6p-3, -0x1.6e74454eaa8afp-1, --0x1.dbc03c84e226ep-55, -0x1p-1, -0x1.91c550dfd4d6bp-3, -0x1.6f8ca99c95b75p-1, -0x1.f22e7a35723f4p-56, -0x1p-1, -0x1.8d40e8c706fa4p-3, -0x1.70a42b3176d7ap-1, --0x1.d9e3fbe2e15ap-56, -0x1p-1, -0x1.88b913fb08bfdp-3, -0x1.71bac960e41bfp-1, --0x1.b858d90b0f7d8p-56, -0x1p-1, -0x1.842dd5474b37bp-3, -0x1.72d0837efff96p-1, -0x1.0d4ef0f1d915cp-55, -0x1p-1, -0x1.7f9f2f795a83ep-3, -0x1.73e558e079942p-1, --0x1.2663126697f5ep-55, -0x1p-1, -0x1.7b0d2560dc1d1p-3, -0x1.74f948da8d28dp-1, -0x1.19900a3b9a3a2p-63, -0x1p-1, -0x1.7677b9cf8d17p-3, -0x1.760c52c304764p-1, --0x1.11d76f8e50f1fp-55, -0x1p-1, -0x1.71deef9940631p-3, -0x1.771e75f037261p-1, -0x1.5cfce8d84068fp-56, -0x1p-1, -0x1.6d42c993dd121p-3, -0x1.782fb1b90b35bp-1, --0x1.3e46c1dfd001cp-55, -0x1p-1, -0x1.68a34a975c941p-3, -0x1.79400574f55e5p-1, --0x1.0adadbdb4c65ap-55, -0x1p-1, -0x1.6400757dc8f7dp-3, -0x1.7a4f707bf97d2p-1, -0x1.3c9751b491eafp-55, -0x1p-1, -0x1.5f5a4d233b27fp-3, -0x1.7b5df226aafafp-1, --0x1.0f537acdf0ad7p-56, -0x1p-1, -0x1.5ab0d465d927ap-3, -0x1.7c6b89ce2d333p-1, --0x1.cfd628084982cp-56, -0x1p-1, -0x1.56040e25d44ddp-3, -0x1.7d7836cc33db2p-1, -0x1.162715ef03f85p-56, -0x1p-1, -0x1.5153fd45677efp-3, -0x1.7e83f87b03686p-1, -0x1.b61a8ccabad6p-57, -0x1p-1, -0x1.4ca0a4a8d5657p-3, -0x1.7f8ece3571771p-1, --0x1.9c8d8ce93c917p-55, -0x1p-1, -0x1.47ea073666a98p-3, -0x1.8098b756e52fap-1, -0x1.9136e834b4707p-55, -0x1p-1, -0x1.433027d66826dp-3, -0x1.81a1b33b57accp-1, --0x1.5dea12d66bb66p-55, -0x1p-1, -0x1.3e73097329219p-3, -0x1.82a9c13f545ffp-1, --0x1.65e87a7a8cde9p-56, -0x1p-1, -0x1.39b2aef8f97a4p-3, -0x1.83b0e0bff976ep-1, --0x1.6f420f8ea3475p-56, -0x1p-1, -0x1.34ef1b5627dfdp-3, -0x1.84b7111af83fap-1, --0x1.63a47df0b21bap-55, -0x1p-1, -0x1.3028517b0001p-3, -0x1.85bc51ae958ccp-1, -0x1.45ba6478086ccp-55, -0x1p-1, -0x1.2b5e5459c8bc3p-3, -0x1.86c0a1d9aa195p-1, -0x1.84564f09c3726p-59, -0x1p-1, -0x1.269126e6c24e3p-3, -0x1.87c400fba2ebfp-1, --0x1.2dabc0c3f64cdp-55, -0x1p-1, -0x1.21c0cc18247fcp-3, -0x1.88c66e7481ba1p-1, --0x1.5c6228970cf35p-56, -0x1p-1, -0x1.1ced46e61cd1cp-3, -0x1.89c7e9a4dd4aap-1, -0x1.db6ea04a8678fp-55, -0x1p-1, -0x1.18169a4acca89p-3, -0x1.8ac871ede1d88p-1, --0x1.9afaa5b7cfc55p-55, -0x1p-1, -0x1.133cc94247758p-3, -0x1.8bc806b151741p-1, --0x1.2c5e12ed1336dp-55, -0x1p-1, -0x1.0e5fd6ca90dffp-3, -0x1.8cc6a75184655p-1, --0x1.e18b3657e2285p-55, -0x1p-1, -0x1.097fc5e39aec5p-3, -0x1.8dc45331698ccp-1, -0x1.1d9fcd83634d7p-57, -0x1p-1, -0x1.049c998f44231p-3, -0x1.8ec109b486c49p-1, --0x1.cb2a3eb6af617p-56, -0x1p-1, -0x1.ff6ca9a2ab6a2p-4, -0x1.8fbcca3ef940dp-1, --0x1.6dfa99c86f2f1p-57, -0x1p-1, -0x1.f599f55f034p-4, -0x1.90b7943575efep-1, -0x1.4ecb0c5273706p-57, -0x1p-1, -0x1.ebc11c62c1a1ep-4, -0x1.91b166fd49da2p-1, --0x1.3be953a7fe996p-57, -0x1p-1, -0x1.e1e224c0e28bdp-4, -0x1.92aa41fc5a815p-1, --0x1.68f89e2d23db7p-57, -0x1p-1, -0x1.d7fd1490285cap-4, -0x1.93a22499263fbp-1, -0x1.3d419a920df0bp-55, -0x1p-1, -0x1.ce11f1eb18148p-4, -0x1.94990e3ac4a6cp-1, -0x1.a95328edeb3e6p-56, -0x1p-1, -0x1.c420c2eff590ep-4, -0x1.958efe48e6dd7p-1, --0x1.561335da0f4e7p-55, -0x1p-1, -0x1.ba298dc0bfc6bp-4, -0x1.9683f42bd7fe1p-1, --0x1.11bad933c835ep-57, -0x1p-1, -0x1.b02c58832cf96p-4, -0x1.9777ef4c7d742p-1, --0x1.15479a240665ep-55, -0x1p-1, -0x1.a6292960a6f0bp-4, -0x1.986aef1457594p-1, --0x1.af03e318f38fcp-55, -0x1p-1, -0x1.9c200686472b5p-4, -0x1.995cf2ed80d22p-1, -0x1.7783e907fbd7bp-56, -0x1p-1, -0x1.9210f624d30fbp-4, -0x1.9a4dfa42b06b2p-1, --0x1.829b6b8b1c947p-56, -0x1p-1, -0x1.87fbfe70b81a7p-4, -0x1.9b3e047f38741p-1, --0x1.30ee286712474p-55, -0x1p-1, -0x1.7de125a2080a9p-4, -0x1.9c2d110f075c2p-1, -0x1.d9c9f1c8c30dp-55, -0x1p-1, -0x1.73c071f4750b5p-4, -0x1.9d1b1f5ea80d5p-1, -0x1.c5fadd5ffb36fp-55, -0x1p-1, -0x1.6999e9a74ddbep-4, -0x1.9e082edb42472p-1, -0x1.5809a4e121e22p-57, -0x1p-1, -0x1.5f6d92fd79f5p-4, -0x1.9ef43ef29af94p-1, -0x1.b1dfcb60445c2p-56, -0x1p-1, -0x1.553b743d75acp-4, -0x1.9fdf4f13149dep-1, -0x1.1e6d79006ec09p-55, -0x1p-1, -0x1.4b0393b14e541p-4, -0x1.a0c95eabaf937p-1, --0x1.e0ca3acbd049ap-55, -0x1p-1, -0x1.40c5f7a69e5cep-4, -0x1.a1b26d2c0a75ep-1, -0x1.30ef431d627a6p-57, -0x1p-1, -0x1.3682a66e896f5p-4, -0x1.a29a7a0462782p-1, --0x1.128bb015df175p-56, -0x1p-1, -0x1.2c39a65db8881p-4, -0x1.a38184a593bc6p-1, --0x1.bc92c5bd2d288p-55, -0x1p-1, -0x1.21eafdcc560fap-4, -0x1.a4678c8119ac8p-1, -0x1.1b4c0dd3f212ap-55, -0x1p-1, -0x1.1796b31609f0cp-4, -0x1.a54c91090f523p-1, -0x1.184300fd1c1cep-56, -0x1p-1, -0x1.0d3ccc99f5ac6p-4, -0x1.a63091b02fae2p-1, --0x1.e911152248d1p-56, -0x1p-1, -0x1.02dd50bab06b2p-4, -0x1.a7138de9d60f5p-1, --0x1.f1ab82a9c5f2dp-55, -0x1p-1, -0x1.f0f08bbc861afp-5, -0x1.a7f58529fe69dp-1, --0x1.97a441584a179p-55, -0x1p-1, -0x1.dc1b64dc48722p-5, -0x1.a8d676e545ad2p-1, --0x1.b11dcce2e74bdp-59, -0x1p-1, -0x1.c73b39ae68c87p-5, -0x1.a9b66290ea1a3p-1, -0x1.9f630e8b6dac8p-60, -0x1p-1, -0x1.b250171373be9p-5, -0x1.aa9547a2cb98ep-1, -0x1.87d00ae97abaap-60, -0x1p-1, -0x1.9d5a09f2b9b7fp-5, -0x1.ab7325916c0d4p-1, -0x1.a8b8c85baaa9bp-55, -0x1p-1, -0x1.88591f3a46e4dp-5, -0x1.ac4ffbd3efac8p-1, --0x1.818504103fa16p-56, -0x1p-1, -0x1.734d63dedb48ap-5, -0x1.ad2bc9e21d511p-1, --0x1.47fbe07bea548p-55, -0x1p-1, -0x1.5e36e4dbe2bc2p-5, -0x1.ae068f345ecefp-1, --0x1.33934c4029a4cp-56, -0x1p-1, -0x1.4915af336ceb4p-5, -0x1.aee04b43c1474p-1, --0x1.3a79a438bf8ccp-55, -0x1p-1, -0x1.33e9cfee254edp-5, -0x1.afb8fd89f57b6p-1, -0x1.1ced12d2899b8p-60, -0x1p-1, -0x1.1eb3541b4b228p-5, -0x1.b090a581502p-1, --0x1.926da300ffccep-55, -0x1p-1, -0x1.097248d0a956ap-5, -0x1.b16742a4ca2f5p-1, --0x1.ba70972b80438p-55, -0x1p-1, -0x1.e84d76551cfb2p-6, -0x1.b23cd470013b4p-1, -0x1.5a1bb35ad6d2ep-56, -0x1p-1, -0x1.bda17097896b4p-6, -0x1.b3115a5f37bf3p-1, -0x1.dde2726e34fe1p-55, -0x1p-1, -0x1.92e09abb131d4p-6, -0x1.b3e4d3ef55712p-1, --0x1.eb6b8bf11a493p-55, -0x1p-1, -0x1.680b0f1f0bd73p-6, -0x1.b4b7409de7925p-1, -0x1.f4e257bde73d8p-56, -0x1p-1, -0x1.3d20e82f8bc1p-6, -0x1.b5889fe921405p-1, --0x1.df49b307c8602p-57, -0x1p-1, -0x1.1222406561182p-6, -0x1.b658f14fdbc47p-1, -0x1.52b5308f397dep-57, -0x1p-1, -0x1.ce1e648bffb66p-7, -0x1.b728345196e3ep-1, --0x1.bc69f324e6d61p-55, -0x1p-1, -0x1.77cfb0c6e2db8p-7, -0x1.b7f6686e792e9p-1, -0x1.87665bfea06aap-55, -0x1p-1, -0x1.21589ab88869cp-7, -0x1.b8c38d27504e9p-1, --0x1.1529abff40e45p-55, -0x1p-1, -0x1.9572af6decac8p-8, -0x1.b98fa1fd9155ep-1, -0x1.5559034fe85a4p-55, -0x1p-1, -0x1.cfc874c3eb6d9p-9, -0x1.ba5aa673590d2p-1, -0x1.7ea4e370753b6p-55, -0x1p-1, -0x1.d0320ae0b8293p-11, -0x1.bb249a0b6c40dp-1, --0x1.d6318ee919f7ap-58, -0x1p-1, --0x1.d09b418edf04ap-10, -0x1.bbed7c49380eap-1, -0x1.beacbd88500b4p-59, -0x1p-1, --0x1.22a28f6cb488bp-8, -0x1.bcb54cb0d2327p-1, -0x1.410923c55523ep-62, -0x1p-1, --0x1.d16c901d95181p-8, -0x1.bd7c0ac6f952ap-1, --0x1.825a732ac700ap-55, -0x1p-1, --0x1.4042335264ba3p-7, -0x1.be41b611154c1p-1, --0x1.fdcdad3a6877ep-55, -0x1p-1, --0x1.97f4d3805f318p-7, -0x1.bf064e15377ddp-1, -0x1.2156026a1e028p-57, -0x1p-1, --0x1.efcdf2801004ap-7, -0x1.bfc9d25a1b147p-1, --0x1.51bf4ee01357p-61, -0x1p-1, --0x1.23e6ad10872a7p-6, -0x1.c08c426725549p-1, -0x1.b157fd80e2946p-58, -0x1p-1, --0x1.4ff96a0da9dfbp-6, -0x1.c14d9dc465e57p-1, -0x1.ce36b64c7f3ccp-55, -0x1p-1, --0x1.7c1f1507aeec3p-6, -0x1.c20de3fa971bp-1, --0x1.b4ca2bab1322cp-55, -0x1p-1, --0x1.a85792c327db2p-6, -0x1.c2cd14931e3f1p-1, -0x1.2ce2f9d4600f5p-56, -0x1p-1, --0x1.d4a2c7f909c4ep-6, -0x1.c38b2f180bdb1p-1, --0x1.6e0b1757c8d07p-56, -0x1p-1, --0x1.00804cab5f113p-5, -0x1.c44833141c004p-1, -0x1.23e0521df01a2p-56, -0x1p-1, --0x1.16b875bf19d4p-5, -0x1.c5042012b6907p-1, --0x1.5c058dd8eaba5p-57, -0x1p-1, --0x1.2cf9d182f7939p-5, -0x1.c5bef59fef85ap-1, --0x1.f0a406c8b7468p-58, -0x1p-1, --0x1.4344523c8e3b5p-5, -0x1.c678b3488739bp-1, -0x1.d86cac7c5ff5bp-57, -0x1p-1, --0x1.5997ea2bcfb19p-5, -0x1.c7315899eaad7p-1, --0x1.9be5dcd047da7p-57, -0x1p-1, --0x1.6ff48b8b1252ap-5, -0x1.c7e8e52233cf3p-1, -0x1.b2ad324aa35c1p-57, -0x1p-1, --0x1.865a288f196fap-5, -0x1.c89f587029c13p-1, -0x1.588358ed6e78fp-58, -0x1p-1, --0x1.9cc8b3671dd0fp-5, -0x1.c954b213411f5p-1, --0x1.2fb761e946603p-58, -0x1p-1, --0x1.b3401e3cd63bbp-5, -0x1.ca08f19b9c449p-1, --0x1.431e0a5a737fdp-56, -0x1p-1, --0x1.c9c05b347ffabp-5, -0x1.cabc169a0b9p-1, -0x1.c42d3e10851d1p-55, -0x1p-1, --0x1.e0495c6ce76b5p-5, -0x1.cb6e20a00da99p-1, --0x1.4fb24b5194c1bp-55, -0x1p-1, --0x1.f6db13ff708cbp-5, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57613b68f6abp-56, -0x1p-1, --0x1.06baba000fc9bp-4, -0x1.cccee20c2deap-1, --0x1.d3116ae0e69e4p-55, -0x1p-1, --0x1.120c373ed0bfbp-4, -0x1.cd7d9898b32f6p-1, --0x1.f2fa062496738p-57, -0x1p-1, --0x1.1d61fac0aa5b2p-4, -0x1.ce2b32799a06p-1, --0x1.631d457e46317p-56, -0x1p-1, --0x1.28bbfd87a8cffp-4, -0x1.ced7af43cc773p-1, --0x1.e7b6bb5ab58aep-58, -0x1p-1, --0x1.341a389339a36p-4, -0x1.cf830e8ce467bp-1, --0x1.7b9202780d49dp-55, -0x1p-1, --0x1.3f7ca4e02ffdcp-4, -0x1.d02d4feb2bd92p-1, -0x1.195ff41bc55fep-55, -0x1p-1, --0x1.4ae33b68c8fdcp-4, -0x1.d0d672f59d2b9p-1, --0x1.c83009f0c39dep-55, -0x1p-1, --0x1.564df524b00dap-4, -0x1.d17e7743e35dcp-1, --0x1.101da3540130ap-58, -0x1p-1, --0x1.61bccb0903395p-4, -0x1.d2255c6e5a4e1p-1, --0x1.d129a71ecafc9p-55, -0x1p-1, --0x1.6d2fb6085786ep-4, -0x1.d2cb220e0ef9fp-1, --0x1.f07656d4e6652p-56, -0x1p-1, --0x1.78a6af12bd501p-4, -0x1.d36fc7bcbfbdcp-1, --0x1.ba196d95a177dp-55, -0x1p-1, --0x1.8421af15c49d7p-4, -0x1.d4134d14dc93ap-1, --0x1.4ef5295d25af2p-55, -0x1p-1, --0x1.8fa0aefc81837p-4, -0x1.d4b5b1b187524p-1, --0x1.f56be6b42b76dp-57, -0x1p-1, --0x1.9b23a7af90805p-4, -0x1.d556f52e93eb1p-1, --0x1.80ed9233a963p-55, -0x1p-1, --0x1.a6aa92151adc3p-4, -0x1.d5f7172888a7fp-1, --0x1.68663e2225755p-55, -0x1p-1, --0x1.b2356710db0a3p-4, -0x1.d696173c9e68bp-1, --0x1.e8c61c6393d55p-56, -0x1p-1, --0x1.bdc41f84210bbp-4, -0x1.d733f508c0dffp-1, --0x1.007928e770cd5p-55, -0x1p-1, --0x1.c956b44dd6d41p-4, -0x1.d7d0b02b8ecf9p-1, -0x1.800f4ce65cd6ep-55, -0x1p-1, --0x1.d4ed1e4a84aefp-4, -0x1.d86c48445a44fp-1, -0x1.e8813c023d71fp-55, -0x1p-1, --0x1.e087565455a75p-4, -0x1.d906bcf328d46p-1, -0x1.457e610231ac2p-56, -0x1p-1, --0x1.ec2555431bf03p-4, -0x1.d9a00dd8b3d46p-1, -0x1.bea0e4bac8e16p-58, -0x1p-1, --0x1.f7c713ec554fp-4, -0x1.da383a9668988p-1, --0x1.5811000b39d84p-55, -0x1p-1, --0x1.01b6459197c38p-3, -0x1.dacf42ce68ab9p-1, --0x1.fe8d76efdf896p-56, -0x1p-1, --0x1.078ad9dc46632p-3, -0x1.db6526238a09bp-1, --0x1.adee7eae6946p-56, -0x1p-1, --0x1.0d61433d840a4p-3, -0x1.dbf9e4395759ap-1, -0x1.d8ff7350f75fdp-55, -0x1p-1, --0x1.13397e1b7ce13p-3, -0x1.dc8d7cb41026p-1, -0x1.6b7872773830dp-56, -0x1p-1, --0x1.191386db3dedcp-3, -0x1.dd1fef38a915ap-1, --0x1.782f169e17f3bp-55, -0x1p-1, --0x1.1eef59e0b74c3p-3, -0x1.ddb13b6ccc23cp-1, -0x1.83c37c6107db3p-55, -0x1p-1, --0x1.24ccf38ebe694p-3, -0x1.de4160f6d8d81p-1, -0x1.9bf11cc5f8776p-55, -0x1p-1, --0x1.2aac5047103d3p-3, -0x1.ded05f7de47dap-1, --0x1.2cc4c1f8ba966p-55, -0x1p-1, -0x1.9ee5272b58f2ap-4, -0x1.df5e36a9ba59cp-1, --0x1.e01f8bceb43d3p-57, -0x1p-2, -0x1.931f774fc9f18p-4, -0x1.dfeae622dbe2bp-1, --0x1.514ea88425567p-55, -0x1p-2, -0x1.875657223080ap-4, -0x1.e0766d9280f54p-1, -0x1.f44c969cf62e3p-55, -0x1p-2, -0x1.7b89cde7a9a4dp-4, -0x1.e100cca2980acp-1, --0x1.02d182acdf825p-57, -0x1p-2, -0x1.6fb9e2e76ced8p-4, -0x1.e18a02fdc66d9p-1, -0x1.07e272abd88cfp-55, -0x1p-2, -0x1.63e69d6ac7f74p-4, -0x1.e212104f686e5p-1, --0x1.014c76c126527p-55, -0x1p-2, -0x1.581004bd19ed2p-4, -0x1.e298f4439197ap-1, -0x1.e84e601038eb2p-57, -0x1p-2, -0x1.4c36202bcf08ep-4, -0x1.e31eae870ce25p-1, --0x1.bc7094538d678p-56, -0x1p-2, -0x1.4058f7065c11ep-4, -0x1.e3a33ec75ce85p-1, -0x1.45089cd46bbb8p-57, -0x1p-2, -0x1.3478909e39da9p-4, -0x1.e426a4b2bc17ep-1, -0x1.a873889744882p-55, -0x1p-2, -0x1.2894f446e0bccp-4, -0x1.e4a8dff81ce5ep-1, -0x1.43578776c0f46p-55, -0x1p-2, -0x1.1cae2955c414fp-4, -0x1.e529f04729ffcp-1, -0x1.9075d6e6dfc8bp-55, -0x1p-2, -0x1.10c437224dbc2p-4, -0x1.e5a9d550467d3p-1, -0x1.7d431be53f92fp-56, -0x1p-2, -0x1.04d72505d9805p-4, -0x1.e6288ec48e112p-1, --0x1.16b56f2847754p-57, -0x1p-2, -0x1.f1cdf4b76138bp-5, -0x1.e6a61c55d53a7p-1, -0x1.660d981acdcf7p-56, -0x1p-2, -0x1.d9e77d020a5bcp-5, -0x1.e7227db6a9744p-1, -0x1.2128794da5a5p-55, -0x1p-2, -0x1.c1faf1a9db555p-5, -0x1.e79db29a5165ap-1, --0x1.75e710aca58p-56, -0x1p-2, -0x1.aa086170c0a8ep-5, -0x1.e817bab4cd10dp-1, --0x1.d0afe686b5e0ap-56, -0x1p-2, -0x1.920fdb1c5d578p-5, -0x1.e89095bad6025p-1, --0x1.5a4cc0fcbccap-55, -0x1p-2, -0x1.7a116d7601c35p-5, -0x1.e9084361df7f2p-1, -0x1.cdfc7ce9dc3e9p-55, -0x1p-2, -0x1.620d274aa2903p-5, -0x1.e97ec36016b3p-1, -0x1.5bc48562557d3p-55, -0x1p-2, -0x1.4a03176acf82dp-5, -0x1.e9f4156c62ddap-1, -0x1.760b1e2e3f81ep-55, -0x1p-2, -0x1.31f34caaaa5d2p-5, -0x1.ea68393e658p-1, --0x1.467259bb7b556p-56, -0x1p-2, -0x1.19ddd5e1ddb8bp-5, -0x1.eadb2e8e7a88ep-1, --0x1.92ec52ea226a3p-55, -0x1p-2, -0x1.01c2c1eb93deep-5, -0x1.eb4cf515b8811p-1, -0x1.95da1ba97ec5ep-57, -0x1p-2, -0x1.d3443f4cdb3ddp-6, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c615e7277p-56, -0x1p-2, -0x1.a2f7fbe8f2436p-6, -0x1.ec2cf4b1af6b2p-1, -0x1.34ee3f2caa62dp-59, -0x1p-2, -0x1.72a0d77651772p-6, -0x1.ec9b2d3c3bf84p-1, -0x1.19119d358de05p-56, -0x1p-2, -0x1.423eefc693785p-6, -0x1.ed0835e999009p-1, -0x1.499d188aa32fap-57, -0x1p-2, -0x1.11d262b1f6776p-6, -0x1.ed740e7684963p-1, -0x1.e82c791f59cc2p-56, -0x1p-2, -0x1.c2b69c2e939b5p-7, -0x1.eddeb6a078651p-1, --0x1.3b579af740a74p-55, -0x1p-2, -0x1.61b39fb7b7202p-7, -0x1.ee482e25a9dbcp-1, --0x1.b6066ef81af2ap-56, -0x1p-2, -0x1.009c0bd6cc3cbp-7, -0x1.eeb074c50a544p-1, -0x1.d925f656c43b4p-55, -0x1p-2, -0x1.3ee038dff6b8p-8, -0x1.ef178a3e473c2p-1, -0x1.6310a67fe774fp-55, -0x1p-2, -0x1.f1806b9fdd1afp-10, -0x1.ef7d6e51ca3cp-1, --0x1.a3c67c3d3f604p-55, -0x1p-2, --0x1.191f2900903a6p-10, -0x1.efe220c0b95ecp-1, -0x1.c853b7bf7e0cdp-55, -0x1p-2, --0x1.0916fe858ffcdp-8, -0x1.f045a14cf738cp-1, --0x1.a52c44f45216cp-55, -0x1p-2, --0x1.cc0d09bd41caap-8, -0x1.f0a7efb9230d7p-1, -0x1.52c7adc6b4989p-56, -0x1p-2, --0x1.4794b9d21cb87p-7, -0x1.f1090bc898f5fp-1, --0x1.baa64ab102a93p-55, -0x1p-2, --0x1.a935e1efe5e4bp-7, -0x1.f168f53f7205dp-1, --0x1.26a6c1f015601p-57, -0x1p-2, --0x1.0574e07f7b332p-6, -0x1.f1c7abe284708p-1, -0x1.504b80c8a63fcp-55, -0x1p-2, --0x1.36580d5d5e775p-6, -0x1.f2252f7763adap-1, --0x1.20cb81c8d94abp-55, -0x1p-2, --0x1.67445969a108ep-6, -0x1.f2817fc4609cep-1, --0x1.dd1f8eaf65689p-55, -0x1p-2, --0x1.9839a676a6bcfp-6, -0x1.f2dc9c9089a9dp-1, -0x1.5407460bdfc07p-59, -0x1p-2, --0x1.c937d65145919p-6, -0x1.f33685a3aaefp-1, -0x1.eb78685d850f8p-56, -0x1p-2, --0x1.fa3ecac0d84e8p-6, -0x1.f38f3ac64e589p-1, --0x1.d7bafb51f72e6p-56, -0x1p-2, --0x1.15a732c3a894dp-5, -0x1.f3e6bbc1bbc65p-1, -0x1.5774bb7e8a21ep-57, -0x1p-2, --0x1.2e334430a6376p-5, -0x1.f43d085ff92ddp-1, --0x1.8fde71e361c05p-55, -0x1p-2, --0x1.46c38a8311952p-5, -0x1.f492206bcabb4p-1, -0x1.d1e921bbe3bd3p-55, -0x1p-2, --0x1.5f57f693feebep-5, -0x1.f4e603b0b2f2dp-1, --0x1.8ee01e695ac05p-56, -0x1p-2, --0x1.77f07939f3897p-5, -0x1.f538b1faf2d07p-1, --0x1.5f7cd5099519cp-59, -0x1p-2, --0x1.908d0348ef266p-5, -0x1.f58a2b1789e84p-1, -0x1.1f4a188aa368p-56, -0x1p-2, --0x1.a92d859275418p-5, -0x1.f5da6ed43685dp-1, --0x1.536fc33bf9dd8p-55, -0x1p-2, --0x1.c1d1f0e5967d5p-5, -0x1.f6297cff75cbp-1, -0x1.562172a361fd3p-56, -0x1p-2, --0x1.da7a360ef9fefp-5, -0x1.f677556883ceep-1, -0x1.ef696a8d070f4p-57, -0x1p-2, --0x1.f32645d8e6ce9p-5, -0x1.f6c3f7df5bbb7p-1, -0x1.8561ce9d5ef5bp-56, -0x1p-2, --0x1.05eb0885a69c9p-4, -0x1.f70f6434b7eb7p-1, -0x1.1775df66f0ec4p-56, -0x1p-2, --0x1.1244c435e819dp-4, -0x1.f7599a3a12077p-1, -0x1.84f31d743195cp-55, -0x1p-2, --0x1.1ea04e5ee7601p-4, -0x1.f7a299c1a322ap-1, -0x1.6e7190c94899ep-56, -0x1p-2, --0x1.2afd9f6136a9cp-4, -0x1.f7ea629e63d6ep-1, -0x1.ba92d57ebfeddp-55, -0x1p-2, -0x1.9146a0c760c35p-5, -0x1.f830f4a40c60cp-1, -0x1.8528676925128p-57, -0x1p-3, -0x1.78851122cff19p-5, -0x1.f8764fa714ba9p-1, -0x1.ab256778ffcb6p-56, -0x1p-3, -0x1.5fc0219532f79p-5, -0x1.f8ba737cb4b78p-1, --0x1.da71f96d5a49cp-55, -0x1p-3, -0x1.46f7e165f17c8p-5, -0x1.f8fd5ffae41dbp-1, --0x1.8cfd77fd970d2p-56, -0x1p-3, -0x1.2e2c5fde7ea22p-5, -0x1.f93f14f85ac08p-1, --0x1.cfd153e9a9c1ap-55, -0x1p-3, -0x1.155dac4a4f967p-5, -0x1.f97f924c9099bp-1, --0x1.e2ae0eea5963bp-55, -0x1p-3, -0x1.f917abeda4499p-6, -0x1.f9bed7cfbde29p-1, --0x1.b35b1f9bcf70bp-56, -0x1p-3, -0x1.c76dd866c689ep-6, -0x1.f9fce55adb2c8p-1, -0x1.f2a06fab9f9d1p-56, -0x1p-3, -0x1.95bdfca28b53ap-6, -0x1.fa39bac7a1791p-1, --0x1.94f388f1b4e1ep-57, -0x1p-3, -0x1.64083747309d1p-6, -0x1.fa7557f08a517p-1, --0x1.7a0a8ca13571fp-55, -0x1p-3, -0x1.324ca6fe9a04bp-6, -0x1.faafbcb0cfddcp-1, --0x1.e349cb4d3e866p-55, -0x1p-3, -0x1.008b6a763de76p-6, -0x1.fae8e8e46cfbbp-1, --0x1.3a9e414732d97p-56, -0x1p-3, -0x1.9d8940be24e74p-7, -0x1.fb20dc681d54dp-1, --0x1.ff148ec7c5fafp-55, -0x1p-3, -0x1.39f0cedaf576bp-7, -0x1.fb5797195d741p-1, -0x1.1bfac7397cc08p-56, -0x1p-3, -0x1.ac9b7964cf0bap-8, -0x1.fb8d18d66adb7p-1, --0x1.d0b66224cce2ep-56, -0x1p-3, -0x1.ca811eea0c749p-9, -0x1.fbc1617e44186p-1, --0x1.58ec496dc4ecbp-59, -0x1p-3, -0x1.dd15adf70b65ap-12, -0x1.fbf470f0a8d88p-1, --0x1.6bb200d1d70b7p-55, -0x1p-3, --0x1.536352ad19e39p-9, -0x1.fc26470e19fd3p-1, -0x1.1ec8668ecaceep-55, -0x1p-3, --0x1.7148021b55c15p-8, -0x1.fc56e3b7d9af6p-1, --0x1.03ff7a673d3bdp-56, -0x1p-3, --0x1.1c789a28b01b7p-7, -0x1.fc8646cfeb721p-1, -0x1.3143dc43a9b9dp-55, -0x1p-3, --0x1.80566267c11f6p-7, -0x1.fcb4703914354p-1, -0x1.126aa7d51b25cp-55, -0x1p-3, --0x1.e43d1c309e958p-7, -0x1.fce15fd6da67bp-1, --0x1.5dd6f830d4c09p-56, -0x1p-3, --0x1.241644f1c26cep-6, -0x1.fd0d158d86087p-1, -0x1.9705a7b864883p-55, -0x1p-3, --0x1.561236eda8ff2p-6, -0x1.fd37914220b84p-1, -0x1.52e9d7b772791p-55, -0x1p-3, --0x1.88124536d5e8fp-6, -0x1.fd60d2da75c9ep-1, -0x1.36dedb314f0ebp-58, -0x1p-3, --0x1.ba1650f592f5p-6, -0x1.fd88da3d12526p-1, --0x1.87df6378811c7p-55, -0x1p-3, --0x1.ec1e3b4fb3d7ep-6, -0x1.fdafa7514538cp-1, -0x1.d97c45ca4d398p-59, -0x1p-3, --0x1.0f14f2b4549bdp-5, -0x1.fdd539ff1f456p-1, --0x1.ab13cbbec1781p-56, -0x1p-3, --0x1.281c9830c9dafp-5, -0x1.fdf9922f73307p-1, -0x1.a5e0abd3a9b65p-56, -0x1p-3, -0x1.7db402a6a9063p-6, -0x1.fe1cafcbd5b09p-1, -0x1.a23e3202a884ep-57, -0x1p-4, -0x1.4b9dd29353428p-6, -0x1.fe3e92be9d886p-1, -0x1.afeb2e264d46bp-57, -0x1p-4, -0x1.19845e49c8257p-6, -0x1.fe5f3af2e394p-1, -0x1.b213f18c9cf17p-55, -0x1p-4, -0x1.cecf8962d14c8p-7, -0x1.fe7ea85482d6p-1, -0x1.34b085c1828f7p-56, -0x1p-4, -0x1.6a9049670cfaep-7, -0x1.fe9cdad01883ap-1, -0x1.521ecd0c67e35p-57, -0x1p-4, -0x1.064b3a76a2264p-7, -0x1.feb9d2530410fp-1, -0x1.9d429eeda9bb9p-58, -0x1p-4, -0x1.440134d709b28p-8, -0x1.fed58ecb673c4p-1, --0x1.e6e462a7ae686p-56, -0x1p-4, -0x1.ed853918c18ecp-10, -0x1.fef0102826191p-1, -0x1.3c3ea4f30addap-56, -0x1p-4, --0x1.35230c0fbe402p-10, -0x1.ff095658e71adp-1, -0x1.01a8ce18a4b9ep-55, -0x1p-4, --0x1.15fc833fb89b8p-8, -0x1.ff21614e131edp-1, --0x1.de692a167353p-55, -0x1p-4, --0x1.deb9769f940eap-8, -0x1.ff3830f8d575cp-1, --0x1.95e1e79d335f7p-56, -0x1p-4, --0x1.53bf90a81f3a5p-7, -0x1.ff4dc54b1bed3p-1, --0x1.c1169ccd1e92ep-55, -0x1p-4, --0x1.b82683bc89fbp-7, -0x1.ff621e3796d7ep-1, --0x1.c57bc2e24aa15p-57, -0x1p-4, --0x1.0e48ab4f172f4p-6, -0x1.ff753bb1b9164p-1, --0x1.7c330129f56efp-56, -0x1p-4, -0x1.7f0034a43350ep-7, -0x1.ff871dadb81dfp-1, -0x1.8b1c676208aa4p-56, -0x1p-5, -0x1.1a8e5bfe185e4p-7, -0x1.ff97c4208c014p-1, -0x1.52ab2b947e843p-57, -0x1p-5, -0x1.6c32baca2ae69p-8, -0x1.ffa72effef75dp-1, --0x1.8b4cdcdb25956p-55, -0x1p-5, -0x1.4685db42c17ebp-9, -0x1.ffb55e425fdaep-1, -0x1.6da7ec781c225p-55, -0x1p-5, --0x1.2d919c5c61fep-11, -0x1.ffc251df1d3f8p-1, -0x1.7a7d209f32d43p-56, -0x1p-5, --0x1.dd58598d6271cp-9, -0x1.ffce09ce2a679p-1, --0x1.7bd62ab5ee228p-55, -0x1p-5, --0x1.b7aa821726608p-8, -0x1.ffd886084cd0dp-1, --0x1.1354d4556e4cbp-55, -0x1p-5, -0x1.7f53487eac897p-8, -0x1.ffe1c6870cb77p-1, -0x1.89aa14768323ep-55, -0x1p-6, -0x1.6c9b5df1877eap-9, -0x1.ffe9cb44b51a1p-1, -0x1.5b43366df667p-56, -0x1p-6, --0x1.2bad2a8cd06bp-12, -0x1.fff0943c53bd1p-1, --0x1.47399f361d158p-55, -0x1p-6, --0x1.b78b80c84e1eep-9, -0x1.fff62169b92dbp-1, -0x1.5dda3c81fbd0dp-55, -0x1p-6, -0x1.6cb587284b817p-10, -0x1.fffa72c978c4fp-1, --0x1.22cb000328f91p-55, -0x1p-7, --0x1.b783c0663fe3cp-10, -0x1.fffd8858e8a92p-1, -0x1.359c71883bcf7p-55, -0x1p-7, --0x1.b781d04cd6d17p-11, -0x1.ffff621621d02p-1, --0x1.6acfcebc82813p-56, -0x1p-8 -}; - -} // namespace npsr::HWY_NAMESPACE::sincos -HWY_AFTER_NAMESPACE(); -#endif // NPSR_TRIG_LUT_INL_H_ - diff --git a/npsr/trig/lut-inl.h.py b/npsr/trig/lut-inl.h.py deleted file mode 100644 index 3f1e524..0000000 --- a/npsr/trig/lut-inl.h.py +++ /dev/null @@ -1,224 +0,0 @@ -import subprocess -import textwrap -import tempfile -import os -import re - - -def sollya(expr, as_int=None): - """Sollya wrapper with comprehensive message filtering using temp file""" - expr = textwrap.dedent(expr).strip() - # Create temporary file - with tempfile.NamedTemporaryFile(mode="w", suffix=".sollya", delete=False) as f: - f.write(expr + "\nquit;\n") - temp_file = f.name - - try: - # Execute Sollya with temp file - result = subprocess.run(["sollya", temp_file], capture_output=True, text=True) - - # Define patterns to filter out - ignore_patterns = [ - r"^Warning", # Warnings - r"^The precision has been set", # Precision messages - r"^Display mode is ", # Default precision messages - r"^\s*$", # Empty lines - ] - - lines = result.stdout.strip().split("\n") - filtered = [] - - for line in lines: - line = line.strip() - if line: - # Check if line matches any ignore pattern - should_ignore = any( - re.match(pattern, line) for pattern in ignore_patterns - ) - if not should_ignore: - filtered.append(line) - if as_int: - return [int(l, base=as_int) for l in filtered] - return filtered - - finally: - # Clean up temp file - os.unlink(temp_file) - - -def gen_reduction(float_size=64): - """ - Precompute int(2^exp × 4/π) with ~96-bit precision (f32) or ~192-bit precision (f64) - and split them into three chunks: 32-bit chunks for single precision, 64-bit chunks for double precision. - - This generates a lookup table for large range reduction in trigonometric functions. - The table is used to compute mantissa × (2^exp × 4/π) using wider integer multiplications for precision: - - f32: 16×16 → 32-bit multiplications - - f64: 32×32 → 64-bit multiplications - - For input x = mantissa × 2^exp, the algorithm becomes: - x × 4/π = mantissa × table_lookup[exp], providing high precision without floating-point errors. - - Args: - float_size: 32 for f32 or 64 for f64 - """ - exp = (1 << (8 if float_size == 32 else 11)) - 1 - offset, usfx = (70, "U") if float_size == 32 else (137, "ULL") - bias = exp >> 1 - ints = sollya( - f""" - prec = {float_size * 3 * 3}; - four_over_pi = 4 / pi; - for e from 0 to {exp} do {{ - e_shift = e - {bias} + {offset}; - floor(four_over_pi * (2^e_shift)); - }}; - """, - as_int=10, - ) - chunk_mask = (1 << float_size) - 1 - chunks = [ - hex((i >> shift) & chunk_mask) + usfx - for i in ints - for shift in [float_size * 2, float_size, 0] - ] - return chunks - - -def gen_approx(float_size=64, func="sin", func_driv="cos"): - n = 1 << (8 if float_size == 32 else 11) - cast = "single" if float_size == 32 else "double" - return sollya( - f""" - prec = {float_size*3}; - display = hexadecimal; - cast = {cast}(x); - func = {func}(x); - scale = 2.0 * pi / {n}; - for e from 0 to {n - 1} do {{ - theta = e * scale; - p1 = cast(func(theta)); - p2 = cast(func(theta) - p1); - deriv = {func_driv}(theta); - k = nearestint(log2(abs(deriv))); - if (deriv < 0) then sign = -1 else sign = 1; - p3 = sign * 2.0^k; - p0 = cast(deriv - p3); - p0;p1;p2;p3; - }}; - """ - ) - - -def gen_kpi16(float_size=64, func="sin"): - cast = "single" if float_size == 32 else "double" - return sollya( - f""" - prec = {float_size*3}; - display = hexadecimal; - cast = {cast}(x); - func = {func}(x); - pi16 = pi / 16; - for k from 0 to 15 do {{ - cast(func(k * pi16)); - }}; - """ - ) - - -def gen_pack_func(clo, slo): - combined = (clo & 0xFFFFFFFF00000000) | ((slo >> 32) & 0xFFFFFFFF) - return f"0x{combined:016x}" - - -def gen_kpi16_low_pack(): - ints = sollya( - f""" - prec = {64*3}; - display = hexadecimal; - pi16 = pi / 16; - for k from 0 to 15 do {{ - shi = double(sin(k * pi16)); - chi = double(cos(k * pi16)); - slo = double(sin(k * pi16) - shi); - clo = double(cos(k * pi16) - chi); - printdouble(clo); - printdouble(slo); - }}; - """, - as_int=0x10, - ) - packed = [gen_pack_func(clo, slo) for clo, slo in zip(ints[::2], ints[1::2])] - ints = sollya( - f""" - prec = {64*3}; - display = hexadecimal; - packed = [|{','.join(packed)}|]; - for k from 0 to 15 do {{ - double(packed[k]); - }}; - """ - ) - return ints - - -nl = ",\n" -print( - """\ -// auto generated by npsr/sincos/lut-inl.h.py -#include -#if defined(NPSR_TRIG_LUT_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT -#ifdef NPSR_TRIG_LUT_INL_H_ -#undef NPSR_TRIG_LUT_INL_H_ -#else -#define NPSR_TRIG_LUT_INL_H_ -#endif - -HWY_BEFORE_NAMESPACE(); - -namespace npsr::HWY_NAMESPACE::sincos { -HWY_API void DummySupressUnusedTargetWarn(); - - -template constexpr T kLargeReductionTable[] = {}; -template constexpr T kSinApproxTable[] = {}; -template constexpr T kCosApproxTable[] = {}; -template constexpr T kHiSinKPi16Table[] = {}; -template constexpr T kHiCosKPi16Table[] = {}; -template constexpr T kPackedLowSinCosKPi16Table[] = {}; -""" -) -print( - f"""\ -template <> HWY_ALIGN constexpr double kHiSinKPi16Table[] = {{ -{nl.join(gen_kpi16(func="sin"))} -}}; -template <> HWY_ALIGN constexpr double kHiCosKPi16Table[] = {{ -{nl.join(gen_kpi16(func="cos"))} -}}; -template <> HWY_ALIGN constexpr double kPackedLowSinCosKPi16Table[] = {{ -{nl.join(gen_kpi16_low_pack())} -}};\ -""" -) -for fsize, T in ((32, "float"), (64, "double")): - print( - f"""\ -template <> HWY_ALIGN constexpr uint{fsize}_t kLargeReductionTable<{T}>[] = {{ -{nl.join(gen_reduction(fsize))} -}}; -template <> HWY_ALIGN constexpr {T} kSinApproxTable<{T}>[] = {{ -{nl.join(gen_approx(fsize, "sin", "cos"))} -}}; -template <> HWY_ALIGN constexpr {T} kCosApproxTable<{T}>[] = {{ -{nl.join(gen_approx(fsize, "cos", "-sin"))} -}};\ - """ - ) -print( - """ -} // namespace npsr::HWY_NAMESPACE::sincos -HWY_AFTER_NAMESPACE(); -#endif // NPSR_TRIG_LUT_INL_H_ -""" -) From 9743c737e0bf6e21794c2530728516ef4b2f98fc Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:23:14 +0300 Subject: [PATCH 07/20] Add Highway library as git submodule Highway provides portable SIMD intrinsics required by the testing framework --- .gitmodules | 3 +++ test/highway | 1 + 2 files changed, 4 insertions(+) create mode 100644 .gitmodules create mode 160000 test/highway diff --git a/.gitmodules b/.gitmodules new file mode 100644 index 0000000..d55a603 --- /dev/null +++ b/.gitmodules @@ -0,0 +1,3 @@ +[submodule "test/highway"] + path = test/highway + url = https://github.com/google/highway diff --git a/test/highway b/test/highway new file mode 160000 index 0000000..136317f --- /dev/null +++ b/test/highway @@ -0,0 +1 @@ +Subproject commit 136317f6366d0d5aa0dd24f660e3af1b1ce4dcbd From 93c7e109c36e0ff8c0922b9bfe9297bd9f9bae8e Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:25:06 +0300 Subject: [PATCH 08/20] Add npsr meson build placeholder Initialize build configuration for npsr module --- npsr/meson.build | 0 1 file changed, 0 insertions(+), 0 deletions(-) create mode 100644 npsr/meson.build diff --git a/npsr/meson.build b/npsr/meson.build new file mode 100644 index 0000000..e69de29 From 4c41d2369614739be9f7ccd9e0380c4de5371bb5 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:29:14 +0300 Subject: [PATCH 09/20] Add comprehensive stress tests for sin/cos functions - Generate test vectors using Sollya for high-precision reference values - Test challenging cases including large arguments, pi multiples, and edge cases - Cover both float32 and float64 precision with ULP accuracy validation - Include tests for standard and low-accuracy modes --- npsr/trig/tests/__init__.py | 0 npsr/trig/tests/data/__init__.py | 0 npsr/trig/tests/data/large.py | 12982 ++++++++++++++++++++++++++++ npsr/trig/tests/data/large.py.py | 46 + npsr/trig/tests/data/large.sollya | 164 + npsr/trig/tests/test_sincos.py | 26 + 6 files changed, 13218 insertions(+) create mode 100644 npsr/trig/tests/__init__.py create mode 100644 npsr/trig/tests/data/__init__.py create mode 100644 npsr/trig/tests/data/large.py create mode 100644 npsr/trig/tests/data/large.py.py create mode 100644 npsr/trig/tests/data/large.sollya create mode 100644 npsr/trig/tests/test_sincos.py diff --git a/npsr/trig/tests/__init__.py b/npsr/trig/tests/__init__.py new file mode 100644 index 0000000..e69de29 diff --git a/npsr/trig/tests/data/__init__.py b/npsr/trig/tests/data/__init__.py new file mode 100644 index 0000000..e69de29 diff --git a/npsr/trig/tests/data/large.py b/npsr/trig/tests/data/large.py new file mode 100644 index 0000000..2cd89cf --- /dev/null +++ b/npsr/trig/tests/data/large.py @@ -0,0 +1,12982 @@ +from numpy_sr import Vec, bitcast, float32_t, float64_t, uint32_t, uint64_t + +sin_float64_t = [ + +################ chunk 0 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5434d, 0x4073a28c59d54329, 0x4083a28c59d5433b, 0x4083a28c59d5433b, 0x4083a28c59d5433b, + 0x4083a28c59d54344, 0x4083a28c59d54332, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4e1, 0x408d73d286bfe4d0, 0x4093a28c59d5433b, + 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433f, 0x4093a28c59d54337, 0x40988b2f704a940a, 0x40988b2f704a940a, 0x40988b2f704a940a, 0x40988b2f704a940e, + 0x40988b2f704a9405, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4dd, 0x409d73d286bfe4d4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, + 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad6, 0x40a12e3ace9a9ad1, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433d, 0x40a3a28c59d54339, + 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba5, 0x40a616dde50feba0, 0x40a88b2f704a940a, 0x40a88b2f704a940a, 0x40a88b2f704a940a, + 0x40a88b2f704a940c, 0x40a88b2f704a9408, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c73, 0x40aaff80fb853c6f, 0x40ad73d286bfe4d8, + 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4db, 0x40ad73d286bfe4d6, 0x40afe82411fa8d40, 0x40afe82411fa8d40, 0x40afe82411fa8d40, 0x40afe82411fa8d42, + 0x40afe82411fa8d3e, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad5, 0x40b12e3ace9a9ad2, 0x40b268639437ef07, 0x40b268639437ef07, + 0x40b268639437ef07, 0x40b268639437ef08, 0x40b268639437ef06, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433c, 0x40b3a28c59d5433a, + 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f729770, 0x40b4dcb51f72976e, 0x40b616dde50feba2, 0x40b616dde50feba2, 0x40b616dde50feba2, + 0x40b616dde50feba3, 0x40b616dde50feba1, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd7, 0x40b75106aaad3fd5, 0x40b88b2f704a940a, + 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940b, 0x40b88b2f704a9409, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, 0x40b9c55835e7e83e, + 0x40b9c55835e7e83c, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c72, 0x40baff80fb853c70, 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, + 0x40bc39a9c12290a5, 0x40bc39a9c12290a6, 0x40bc39a9c12290a4, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4da, 0x40bd73d286bfe4d7, + 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390d, 0x40beadfb4c5d390b, 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, + 0x40bfe82411fa8d41, 0x40bfe82411fa8d3f, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0b9, 0x40c12e3ace9a9ad4, + 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad3, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, 0x40c1cb4f316944ee, + 0x40c1cb4f316944ed, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef08, 0x40c268639437ef07, 0x40c30577f7069921, 0x40c30577f7069921, + 0x40c30577f7069921, 0x40c30577f7069922, 0x40c30577f7069921, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433c, 0x40c3a28c59d5433a, + 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed54, 0x40c4dcb51f72976f, 0x40c4dcb51f72976f, 0x40c4dcb51f72976f, + 0x40c4dcb51f72976f, 0x40c4dcb51f72976e, 0x40c579c982414188, 0x40c579c982414188, 0x40c579c982414188, 0x40c579c982414189, 0x40c579c982414188, 0x40c616dde50feba2, + 0x40c616dde50feba2, 0x40c616dde50feba2, 0x40c616dde50feba3, 0x40c616dde50feba2, 0x40c6b3f247de95bc, 0x40c6b3f247de95bc, 0x40c6b3f247de95bc, 0x40c6b3f247de95bd, + 0x40c6b3f247de95bc, 0x40c75106aaad3fd6, 0x40c75106aaad3fd6, 0x40c75106aaad3fd6, 0x40c75106aaad3fd7, 0x40c75106aaad3fd5, 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9f0, + 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9ef, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a9409, + 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e23, 0x40c9c55835e7e83d, 0x40c9c55835e7e83d, 0x40c9c55835e7e83d, + 0x40c9c55835e7e83e, 0x40c9c55835e7e83d, 0x40ca626c98b69257, 0x40ca626c98b69257, 0x40ca626c98b69257, 0x40ca626c98b69258, 0x40ca626c98b69257, 0x40caff80fb853c71, + 0x40caff80fb853c71, 0x40caff80fb853c71, 0x40caff80fb853c72, 0x40caff80fb853c71, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, + 0x40cb9c955e53e68a, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a4, 0x40ccd6be23f13abf, 0x40ccd6be23f13abf, + 0x40ccd6be23f13abf, 0x40ccd6be23f13abf, 0x40ccd6be23f13abe, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d9, 0x40cd73d286bfe4d8, + 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef3, 0x40ce10e6e98e8ef2, 0x40ceadfb4c5d390c, 0x40ceadfb4c5d390c, 0x40ceadfb4c5d390c, + 0x40ceadfb4c5d390d, 0x40ceadfb4c5d390c, 0x40cf4b0faf2be326, 0x40cf4b0faf2be326, 0x40cf4b0faf2be326, 0x40cf4b0faf2be327, 0x40cf4b0faf2be325, 0x40cfe82411fa8d40, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ce1b19140c0c0d5, 0x3ce1b19140c0c0d5, 0x3ce1b19140c0c0d5, 0x3d7208d8c8a06060, 0xbd71f727375f9fa0, 0x3cf1b19140c0c0d5, 0x3cf1b19140c0c0d5, 0x3cf1b19140c0c0d5, + 0x3d7211b19140c0c1, 0xbd71ee4e6ebf3f3f, 0xbd2caeb4c3dbdbd8, 0xbd2caeb4c3dbdbd8, 0xbd2caeb4c3dbdbd8, 0x3d711a8a59e12121, 0xbd70e575a61ededf, 0x3d01b19140c0c0d5, + 0x3d01b19140c0c0d5, 0x3d01b19140c0c0d5, 0x3d70236322818182, 0xbd6fb939bafcfcfd, 0x3d32c3beb21e1e21, 0x3d32c3beb21e1e21, 0x3d32c3beb21e1e21, 0x3d712c3beb21e1e2, + 0xbd72d3c414de1e1e, 0xbd3caeb4c3dbdbd8, 0xbd3caeb4c3dbdbd8, 0xbd3caeb4c3dbdbd8, 0x3d723514b3c24242, 0xbd71caeb4c3dbdbe, 0x3d49ef6be3151517, 0x3d49ef6be3151517, + 0x3d49ef6be3151517, 0x3d733ded7c62a2a3, 0xbd74c212839d5d5d, 0x3d11b19140c0c0d5, 0x3d11b19140c0c0d5, 0x3d11b19140c0c0d5, 0x3d7046c645030303, 0xbd6f727375f9f9f9, + 0xbd45830792e4e4e2, 0xbd45830792e4e4e2, 0xbd45830792e4e4e2, 0x3d754f9f0da36364, 0xbd72b060f25c9c9c, 0x3d42c3beb21e1e21, 0x3d42c3beb21e1e21, 0x3d42c3beb21e1e21, + 0x3d725877d643c3c4, 0xbd6b4f1053787878, 0xbd23d5ec237b7b6e, 0xbd23d5ec237b7b6e, 0xbd23d5ec237b7b6e, 0x3d6ec2a13dc84849, 0xbd709eaf611bdbdb, 0xbd4caeb4c3dbdbd8, + 0xbd4caeb4c3dbdbd8, 0xbd4caeb4c3dbdbd8, 0x3d746a2967848485, 0xbd7395d6987b7b7b, 0x3d373023024e4e57, 0x3d373023024e4e57, 0x3d373023024e4e57, 0x3d7173023024e4e5, + 0xbd6d19fb9fb63635, 0x3d59ef6be3151517, 0x3d59ef6be3151517, 0x3d59ef6be3151517, 0x3d767bdaf8c54546, 0xbd798425073ababa, 0xbd51ed30fa696967, 0xbd51ed30fa696967, + 0xbd51ed30fa696967, 0x3d67096782cb4b4c, 0xbd747b4c3e9a5a5a, 0x3d21b19140c0c0d5, 0x3d21b19140c0c0d5, 0x3d21b19140c0c0d5, 0x3d708d8c8a060607, 0xbd6ee4e6ebf3f3f3, + 0x3d5659954a99999c, 0x3d5659954a99999c, 0x3d5659954a99999c, 0x3d75966552a66667, 0xbd64d3355ab33332, 0xbd55830792e4e4e2, 0xbd55830792e4e4e2, 0xbd55830792e4e4e2, + 0x3d653e7c368d8d8f, 0xbd7560c1e4b93939, 0xbd15fa4706363606, 0xbd15fa4706363606, 0xbd15fa4706363606, 0x3d6f502dc7ce4e50, 0xbd7057e91c18d8d8, 0x3d52c3beb21e1e21, + 0x3d52c3beb21e1e21, 0x3d52c3beb21e1e21, 0x3d74b0efac878788, 0xbd669e20a6f0f0ef, 0xbd5918de2b60605d, 0xbd5918de2b60605d, 0xbd5918de2b60605d, 0x3d637390ea4fcfd1, + 0xbd7646378ad81817, 0xbd33d5ec237b7b6e, 0xbd33d5ec237b7b6e, 0xbd33d5ec237b7b6e, 0x3d6d85427b909092, 0xbd713d5ec237b7b7, 0x3d4e5bd03345454d, 0x3d4e5bd03345454d, + 0x3d4e5bd03345454d, 0x3d73cb7a0668a8aa, 0xbd68690bf32eaead, 0xbd5caeb4c3dbdbd8, 0xbd5caeb4c3dbdbd8, 0xbd5caeb4c3dbdbd8, 0x3d78d452cf09090a, 0xbd772bad30f6f6f6, + 0xbd4116a342b4b4ad, 0xbd4116a342b4b4ad, 0xbd4116a342b4b4ad, 0x3d6bba572f52d2d5, 0xbd7222d468569696, 0x3d473023024e4e57, 0x3d473023024e4e57, 0x3d473023024e4e57, + 0x3d72e6046049c9cb, 0xbd6a33f73f6c6c6a, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0xbd781122d715d5d5, 0x3d69ef6be3151517, + 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0xbd73084a0e757574, 0xbd6bfee28baa2a28, 0xbd6bfee28baa2a28, 0xbd6bfee28baa2a28, 0x3d72008eba2aeaec, + 0xbd6bfee28baa2a28, 0xbd61ed30fa696967, 0xbd61ed30fa696967, 0xbd61ed30fa696967, 0x3d77096782cb4b4c, 0xbd61ed30fa696967, 0xbd4f6dfda4a2a299, 0xbd4f6dfda4a2a299, + 0xbd4f6dfda4a2a299, 0x3d7c12404b6babad, 0xbd4f6dfda4a2a299, 0x3d31b19140c0c0d5, 0x3d31b19140c0c0d5, 0x3d31b19140c0c0d5, 0x3d808d8c8a060607, 0xbd7ee4e6ebf3f3f3, + 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0xbd79dc0e23539392, 0x3d6659954a99999c, 0x3d6659954a99999c, 0x3d6659954a99999c, + 0x3d6659954a99999c, 0xbd74d3355ab33332, 0xbd6f94b92425a5a3, 0xbd6f94b92425a5a3, 0xbd6f94b92425a5a3, 0x3d7035a36ded2d2f, 0xbd6f94b92425a5a3, 0xbd65830792e4e4e2, + 0xbd65830792e4e4e2, 0xbd65830792e4e4e2, 0x3d753e7c368d8d8f, 0xbd65830792e4e4e2, 0xbd56e2ac03484842, 0xbd56e2ac03484842, 0xbd56e2ac03484842, 0x3d7a4754ff2dedef, + 0xbd56e2ac03484842, 0xbd25fa4706363606, 0xbd25fa4706363606, 0xbd25fa4706363606, 0x3d7f502dc7ce4e50, 0xbd8057e91c18d8d8, 0x3d51641a41babac1, 0x3d51641a41babac1, + 0x3d51641a41babac1, 0x3d51641a41babac1, 0xbd7ba6f96f915150, 0x3d62c3beb21e1e21, 0x3d62c3beb21e1e21, 0x3d62c3beb21e1e21, 0x3d62c3beb21e1e21, 0xbd769e20a6f0f0ef, + 0x3d6cd570435edee2, 0x3d6cd570435edee2, 0x3d6cd570435edee2, 0x3d6cd570435edee2, 0xbd719547de50908f, 0xbd6918de2b60605d, 0xbd6918de2b60605d, 0xbd6918de2b60605d, + 0x3d737390ea4fcfd1, 0xbd6918de2b60605d, 0xbd5e0e59343f3f38, 0xbd5e0e59343f3f38, 0xbd5e0e59343f3f38, 0x3d787c69b2f03032, 0xbd5e0e59343f3f38, 0xbd43d5ec237b7b6e, + 0xbd43d5ec237b7b6e, 0xbd43d5ec237b7b6e, 0x3d7d85427b909092, 0xbd43d5ec237b7b6e, 0x3d4470da21878796, 0x3d4470da21878796, 0x3d4470da21878796, 0x3d4470da21878796, + 0xbd7d71e4bbcf0f0d, 0x3d5e5bd03345454d, 0x3d5e5bd03345454d, 0x3d5e5bd03345454d, 0x3d5e5bd03345454d, 0xbd78690bf32eaead, 0x3d693f99aae36367, 0x3d693f99aae36367, + 0x3d693f99aae36367, 0x3d693f99aae36367, 0xbd7360332a8e4e4c, 0xbd6caeb4c3dbdbd8, 0xbd6caeb4c3dbdbd8, 0xbd6caeb4c3dbdbd8, 0x3d71a8a59e121214, 0xbd6caeb4c3dbdbd8, + 0xbd629d03329b1b17, 0xbd629d03329b1b17, 0xbd629d03329b1b17, 0x3d76b17e66b27274, 0xbd629d03329b1b17, 0xbd5116a342b4b4ad, 0xbd5116a342b4b4ad, 0xbd5116a342b4b4ad, + 0x3d7bba572f52d2d5, 0xbd5116a342b4b4ad, 0x3d2865fefe6666a7, 0x3d2865fefe6666a7, 0x3d2865fefe6666a7, 0x3d806197fbf9999b, 0xbd7f3cd0080ccccb, 0x3d573023024e4e57, +] )) ), + +################ chunk 512 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40cfe82411fa8d40, 0x40cfe82411fa8d40, 0x40cfe82411fa8d40, 0x40cfe82411fa8d3f, 0x40d0429c3a649bad, 0x40d0429c3a649bad, 0x40d0429c3a649bad, 0x40d0429c3a649bad, + 0x40d0429c3a649bad, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0b9, 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c7, + 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c6, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad3, + 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe0, 0x40d1cb4f316944ed, 0x40d1cb4f316944ed, 0x40d1cb4f316944ed, + 0x40d1cb4f316944ee, 0x40d1cb4f316944ed, 0x40d219d962d099fa, 0x40d219d962d099fa, 0x40d219d962d099fa, 0x40d219d962d099fb, 0x40d219d962d099fa, 0x40d268639437ef07, + 0x40d268639437ef07, 0x40d268639437ef07, 0x40d268639437ef08, 0x40d268639437ef07, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, + 0x40d2b6edc59f4414, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d35402286dee2e, 0x40d35402286dee2e, + 0x40d35402286dee2e, 0x40d35402286dee2e, 0x40d35402286dee2e, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, + 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, + 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4261, 0x40d4dcb51f72976f, + 0x40d4dcb51f72976f, 0x40d4dcb51f72976f, 0x40d4dcb51f72976f, 0x40d4dcb51f72976e, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, + 0x40d52b3f50d9ec7b, 0x40d579c982414188, 0x40d579c982414188, 0x40d579c982414188, 0x40d579c982414189, 0x40d579c982414188, 0x40d5c853b3a89695, 0x40d5c853b3a89695, + 0x40d5c853b3a89695, 0x40d5c853b3a89696, 0x40d5c853b3a89695, 0x40d616dde50feba2, 0x40d616dde50feba2, 0x40d616dde50feba2, 0x40d616dde50feba3, 0x40d616dde50feba2, + 0x40d66568167740af, 0x40d66568167740af, 0x40d66568167740af, 0x40d66568167740b0, 0x40d66568167740af, 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, + 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d75106aaad3fd6, + 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, + 0x40d79f90dc1494e3, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, + 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a9409, + 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e916, 0x40d92843d3193e24, 0x40d92843d3193e24, 0x40d92843d3193e24, + 0x40d92843d3193e24, 0x40d92843d3193e23, 0x40d976ce04809330, 0x40d976ce04809330, 0x40d976ce04809330, 0x40d976ce04809331, 0x40d976ce04809330, 0x40d9c55835e7e83d, + 0x40d9c55835e7e83d, 0x40d9c55835e7e83d, 0x40d9c55835e7e83e, 0x40d9c55835e7e83d, 0x40da13e2674f3d4a, 0x40da13e2674f3d4a, 0x40da13e2674f3d4a, 0x40da13e2674f3d4b, + 0x40da13e2674f3d4a, 0x40da626c98b69257, 0x40da626c98b69257, 0x40da626c98b69257, 0x40da626c98b69258, 0x40da626c98b69257, 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, + 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, + 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db9c955e53e68b, 0x40db9c955e53e68b, 0x40db9c955e53e68b, + 0x40db9c955e53e68b, 0x40db9c955e53e68b, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dc39a9c12290a5, + 0x40dc39a9c12290a5, 0x40dc39a9c12290a5, 0x40dc39a9c12290a5, 0x40dc39a9c12290a4, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, + 0x40dc8833f289e5b1, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abe, 0x40dd254855588fcc, 0x40dd254855588fcc, + 0x40dd254855588fcc, 0x40dd254855588fcc, 0x40dd254855588fcb, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d9, 0x40dd73d286bfe4d8, + 0x40ddc25cb82739e5, 0x40ddc25cb82739e5, 0x40ddc25cb82739e5, 0x40ddc25cb82739e6, 0x40ddc25cb82739e5, 0x40de10e6e98e8ef2, 0x40de10e6e98e8ef2, 0x40de10e6e98e8ef2, + 0x40de10e6e98e8ef3, 0x40de10e6e98e8ef2, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40deadfb4c5d390c, + 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40defc857dc48e19, 0x40defc857dc48e19, 0x40defc857dc48e19, 0x40defc857dc48e19, + 0x40defc857dc48e19, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df9999e0933833, 0x40df9999e0933833, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d573023024e4e57, 0x3d573023024e4e57, 0x3d573023024e4e57, 0xbd7a33f73f6c6c6a, 0x3d65a9c31267e7ec, 0x3d65a9c31267e7ec, 0x3d65a9c31267e7ec, 0x3d65a9c31267e7ec, + 0x3d65a9c31267e7ec, 0x3d6fbb74a3a8a8ad, 0x3d6fbb74a3a8a8ad, 0x3d6fbb74a3a8a8ad, 0x3d6fbb74a3a8a8ad, 0xbd881122d715d5d5, 0x3d74e6931a74b4b7, 0x3d74e6931a74b4b7, + 0x3d74e6931a74b4b7, 0x3d74e6931a74b4b7, 0xbd858cb672c5a5a5, 0x3d79ef6be3151517, 0x3d79ef6be3151517, 0x3d79ef6be3151517, 0x3d79ef6be3151517, 0xbd83084a0e757574, + 0x3d7ef844abb57578, 0x3d7ef844abb57578, 0x3d7ef844abb57578, 0x3d7ef844abb57578, 0xbd8083ddaa254544, 0xbd7bfee28baa2a28, 0xbd7bfee28baa2a28, 0xbd7bfee28baa2a28, + 0x3d82008eba2aeaec, 0xbd7bfee28baa2a28, 0xbd76f609c309c9c7, 0xbd76f609c309c9c7, 0xbd76f609c309c9c7, 0x3d8484fb1e7b1b1c, 0xbd76f609c309c9c7, 0xbd71ed30fa696967, + 0xbd71ed30fa696967, 0xbd71ed30fa696967, 0x3d87096782cb4b4c, 0xbd71ed30fa696967, 0xbd69c8b06392120d, 0xbd69c8b06392120d, 0xbd69c8b06392120d, 0xbd69c8b06392120d, + 0xbd69c8b06392120d, 0xbd5f6dfda4a2a299, 0xbd5f6dfda4a2a299, 0xbd5f6dfda4a2a299, 0xbd5f6dfda4a2a299, 0xbd5f6dfda4a2a299, 0xbd4695350442422e, 0xbd4695350442422e, + 0xbd4695350442422e, 0xbd4695350442422e, 0xbd4695350442422e, 0x3d41b19140c0c0d5, 0x3d41b19140c0c0d5, 0x3d41b19140c0c0d5, 0x3d41b19140c0c0d5, 0x3d41b19140c0c0d5, + 0x3d5cfc2bc2e1e1ec, 0x3d5cfc2bc2e1e1ec, 0x3d5cfc2bc2e1e1ec, 0x3d5cfc2bc2e1e1ec, 0x3d5cfc2bc2e1e1ec, 0x3d688fc772b1b1b7, 0x3d688fc772b1b1b7, 0x3d688fc772b1b1b7, + 0x3d688fc772b1b1b7, 0x3d688fc772b1b1b7, 0x3d7150bc81f9393c, 0x3d7150bc81f9393c, 0x3d7150bc81f9393c, 0x3d7150bc81f9393c, 0xbd8757a1bf036362, 0x3d7659954a99999c, + 0x3d7659954a99999c, 0x3d7659954a99999c, 0x3d7659954a99999c, 0xbd84d3355ab33332, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, + 0xbd824ec8f6630302, 0xbd7f94b92425a5a3, 0xbd7f94b92425a5a3, 0xbd7f94b92425a5a3, 0x3d8035a36ded2d2f, 0xbd7f94b92425a5a3, 0xbd7a8be05b854542, 0xbd7a8be05b854542, + 0xbd7a8be05b854542, 0x3d82ba0fd23d5d5f, 0xbd7a8be05b854542, 0xbd75830792e4e4e2, 0xbd75830792e4e4e2, 0xbd75830792e4e4e2, 0x3d853e7c368d8d8f, 0xbd75830792e4e4e2, + 0xbd707a2eca448482, 0xbd707a2eca448482, 0xbd707a2eca448482, 0x3d87c2e89addbdbf, 0xbd707a2eca448482, 0xbd66e2ac03484842, 0xbd66e2ac03484842, 0xbd66e2ac03484842, + 0xbd66e2ac03484842, 0xbd66e2ac03484842, 0xbd59a1f4e40f0f03, 0xbd59a1f4e40f0f03, 0xbd59a1f4e40f0f03, 0xbd59a1f4e40f0f03, 0xbd59a1f4e40f0f03, 0xbd35fa4706363606, + 0xbd35fa4706363606, 0xbd35fa4706363606, 0xbd35fa4706363606, 0xbd35fa4706363606, 0x3d4d49a2c1e7e800, 0x3d4d49a2c1e7e800, 0x3d4d49a2c1e7e800, 0x3d4d49a2c1e7e800, + 0x3d4d49a2c1e7e800, 0x3d61641a41babac1, 0x3d61641a41babac1, 0x3d61641a41babac1, 0x3d61641a41babac1, 0x3d61641a41babac1, 0x3d6b75cbd2fb7b82, 0x3d6b75cbd2fb7b82, + 0x3d6b75cbd2fb7b82, 0x3d6b75cbd2fb7b82, 0x3d6b75cbd2fb7b82, 0x3d72c3beb21e1e21, 0x3d72c3beb21e1e21, 0x3d72c3beb21e1e21, 0x3d72c3beb21e1e21, 0xbd869e20a6f0f0ef, + 0x3d77cc977abe7e82, 0x3d77cc977abe7e82, 0x3d77cc977abe7e82, 0x3d77cc977abe7e82, 0xbd8419b442a0c0bf, 0x3d7cd570435edee2, 0x3d7cd570435edee2, 0x3d7cd570435edee2, + 0x3d7cd570435edee2, 0xbd819547de50908f, 0xbd7e21b6f400c0bd, 0xbd7e21b6f400c0bd, 0xbd7e21b6f400c0bd, 0x3d80ef2485ff9fa1, 0xbd7e21b6f400c0bd, 0xbd7918de2b60605d, + 0xbd7918de2b60605d, 0xbd7918de2b60605d, 0x3d837390ea4fcfd1, 0xbd7918de2b60605d, 0xbd74100562bffffd, 0xbd74100562bffffd, 0xbd74100562bffffd, 0x3d85f7fd4ea00002, + 0xbd74100562bffffd, 0xbd6e0e59343f3f38, 0xbd6e0e59343f3f38, 0xbd6e0e59343f3f38, 0x3d887c69b2f03032, 0xbd6e0e59343f3f38, 0xbd63fca7a2fe7e78, 0xbd63fca7a2fe7e78, + 0xbd63fca7a2fe7e78, 0xbd63fca7a2fe7e78, 0xbd63fca7a2fe7e78, 0xbd53d5ec237b7b6e, 0xbd53d5ec237b7b6e, 0xbd53d5ec237b7b6e, 0xbd53d5ec237b7b6e, 0xbd53d5ec237b7b6e, + 0x3cf35dbfc1818507, 0x3cf35dbfc1818507, 0x3cf35dbfc1818507, 0x3cf35dbfc1818507, 0x3cf35dbfc1818507, 0x3d5470da21878796, 0x3d5470da21878796, 0x3d5470da21878796, + 0x3d5470da21878796, 0x3d5470da21878796, 0x3d644a1ea204848c, 0x3d644a1ea204848c, 0x3d644a1ea204848c, 0x3d644a1ea204848c, 0x3d644a1ea204848c, 0x3d6e5bd03345454d, + 0x3d6e5bd03345454d, 0x3d6e5bd03345454d, 0x3d6e5bd03345454d, 0xbd88690bf32eaead, 0x3d7436c0e2430307, 0x3d7436c0e2430307, 0x3d7436c0e2430307, 0x3d7436c0e2430307, + 0xbd85e49f8ede7e7d, 0x3d793f99aae36367, 0x3d793f99aae36367, 0x3d793f99aae36367, 0x3d793f99aae36367, 0xbd8360332a8e4e4c, 0x3d7e48727383c3c8, 0x3d7e48727383c3c8, + 0x3d7e48727383c3c8, 0x3d7e48727383c3c8, 0xbd80dbc6c63e1e1c, 0xbd7caeb4c3dbdbd8, 0xbd7caeb4c3dbdbd8, 0xbd7caeb4c3dbdbd8, 0x3d81a8a59e121214, 0xbd7caeb4c3dbdbd8, + 0xbd77a5dbfb3b7b78, 0xbd77a5dbfb3b7b78, 0xbd77a5dbfb3b7b78, 0x3d842d1202624244, 0xbd77a5dbfb3b7b78, 0xbd729d03329b1b17, 0xbd729d03329b1b17, 0xbd729d03329b1b17, + 0x3d86b17e66b27274, 0xbd729d03329b1b17, 0xbd6b2854d3f5756e, 0xbd6b2854d3f5756e, 0xbd6b2854d3f5756e, 0xbd6b2854d3f5756e, 0xbd6b2854d3f5756e, 0xbd6116a342b4b4ad, + 0xbd6116a342b4b4ad, 0xbd6116a342b4b4ad, 0xbd6116a342b4b4ad, 0xbd6116a342b4b4ad, 0xbd4c13c6c5cfcfb0, 0xbd4c13c6c5cfcfb0, 0xbd4c13c6c5cfcfb0, 0xbd4c13c6c5cfcfb0, + 0xbd4c13c6c5cfcfb0, 0x3d3865fefe6666a7, 0x3d3865fefe6666a7, 0x3d3865fefe6666a7, 0x3d3865fefe6666a7, 0x3d3865fefe6666a7, 0x3d5a3ce2e21b1b2b, 0x3d5a3ce2e21b1b2b, +] )) ), + +################ chunk 1024 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40df9999e0933833, 0x40df9999e0933833, 0x40df9999e0933833, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, + 0x40e01b5721b0f126, 0x40e01b5721b0f126, 0x40e01b5721b0f126, 0x40e01b5721b0f127, 0x40e01b5721b0f126, 0x40e0429c3a649bad, 0x40e0429c3a649bad, 0x40e0429c3a649bad, + 0x40e0429c3a649bad, 0x40e0429c3a649bad, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e091266bcbf0ba, + 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, + 0x40e0b86b847f9b40, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, + 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad3, + 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e17cc50001efe1, 0x40e17cc50001efe1, 0x40e17cc50001efe1, + 0x40e17cc50001efe1, 0x40e17cc50001efe0, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1cb4f316944ed, + 0x40e1cb4f316944ed, 0x40e1cb4f316944ed, 0x40e1cb4f316944ee, 0x40e1cb4f316944ed, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, + 0x40e1f2944a1cef74, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e2411e7b844481, 0x40e2411e7b844481, + 0x40e2411e7b844481, 0x40e2411e7b844481, 0x40e2411e7b844481, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, + 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, + 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e30577f7069921, + 0x40e30577f7069921, 0x40e30577f7069921, 0x40e30577f7069921, 0x40e30577f7069921, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, + 0x40e32cbd0fba43a7, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e37b47412198b5, 0x40e37b47412198b5, + 0x40e37b47412198b5, 0x40e37b47412198b5, 0x40e37b47412198b4, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, + 0x40e3c9d17288edc1, 0x40e3c9d17288edc1, 0x40e3c9d17288edc1, 0x40e3c9d17288edc2, 0x40e3c9d17288edc1, 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, + 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e43fa0bca3ed55, + 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e466e5d55797db, 0x40e466e5d55797db, 0x40e466e5d55797db, 0x40e466e5d55797db, + 0x40e466e5d55797db, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e4b57006beece8, 0x40e4b57006beece8, + 0x40e4b57006beece8, 0x40e4b57006beece8, 0x40e4b57006beece8, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, + 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7c, + 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7b, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e579c982414188, + 0x40e579c982414188, 0x40e579c982414188, 0x40e579c982414189, 0x40e579c982414188, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, + 0x40e5a10e9af4ec0f, 0x40e5c853b3a89695, 0x40e5c853b3a89695, 0x40e5c853b3a89695, 0x40e5c853b3a89696, 0x40e5c853b3a89695, 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, + 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, + 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e66568167740af, 0x40e66568167740af, 0x40e66568167740af, + 0x40e66568167740af, 0x40e66568167740af, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e6b3f247de95bc, + 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6db3760924043, 0x40e6db3760924043, 0x40e6db3760924043, 0x40e6db3760924043, + 0x40e6db3760924043, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e729c191f99550, 0x40e729c191f99550, + 0x40e729c191f99550, 0x40e729c191f99550, 0x40e729c191f9954f, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, + 0x40e7784bc360ea5c, 0x40e7784bc360ea5c, 0x40e7784bc360ea5c, 0x40e7784bc360ea5d, 0x40e7784bc360ea5c, 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d5a3ce2e21b1b2b, 0x3d5a3ce2e21b1b2b, 0x3d5a3ce2e21b1b2b, 0x3d673023024e4e57, 0x3d673023024e4e57, 0x3d673023024e4e57, 0x3d673023024e4e57, 0x3d673023024e4e57, + 0xbd87af8adb1c3c3a, 0xbd87af8adb1c3c3a, 0xbd87af8adb1c3c3a, 0x3d94283a9271e1e3, 0xbd87af8adb1c3c3a, 0x3d75a9c31267e7ec, 0x3d75a9c31267e7ec, 0x3d75a9c31267e7ec, + 0x3d75a9c31267e7ec, 0x3d75a9c31267e7ec, 0xbd82a6b2127bdbda, 0xbd82a6b2127bdbda, 0xbd82a6b2127bdbda, 0xbd82a6b2127bdbda, 0xbd82a6b2127bdbda, 0x3d7fbb74a3a8a8ad, + 0x3d7fbb74a3a8a8ad, 0x3d7fbb74a3a8a8ad, 0x3d7fbb74a3a8a8ad, 0x3d7fbb74a3a8a8ad, 0xbd7b3bb293b6f6f3, 0xbd7b3bb293b6f6f3, 0xbd7b3bb293b6f6f3, 0xbd7b3bb293b6f6f3, + 0xbd7b3bb293b6f6f3, 0x3d84e6931a74b4b7, 0x3d84e6931a74b4b7, 0x3d84e6931a74b4b7, 0x3d84e6931a74b4b7, 0x3d84e6931a74b4b7, 0xbd712a0102763632, 0xbd712a0102763632, + 0xbd712a0102763632, 0xbd712a0102763632, 0xbd712a0102763632, 0x3d89ef6be3151517, 0x3d89ef6be3151517, 0x3d89ef6be3151517, 0x3d89ef6be3151517, 0xbd93084a0e757574, + 0xbd5c613dc4d5d5c4, 0xbd5c613dc4d5d5c4, 0xbd5c613dc4d5d5c4, 0xbd5c613dc4d5d5c4, 0xbd5c613dc4d5d5c4, 0x3d8ef844abb57578, 0x3d8ef844abb57578, 0x3d8ef844abb57578, + 0x3d8ef844abb57578, 0xbd9083ddaa254544, 0x3d47cb11005a5a7f, 0x3d47cb11005a5a7f, 0x3d47cb11005a5a7f, 0x3d47cb11005a5a7f, 0x3d47cb11005a5a7f, 0xbd8bfee28baa2a28, + 0xbd8bfee28baa2a28, 0xbd8bfee28baa2a28, 0x3d92008eba2aeaec, 0xbd8bfee28baa2a28, 0x3d6a162762981821, 0x3d6a162762981821, 0x3d6a162762981821, 0x3d6a162762981821, + 0x3d6a162762981821, 0xbd86f609c309c9c7, 0xbd86f609c309c9c7, 0xbd86f609c309c9c7, 0xbd86f609c309c9c7, 0xbd86f609c309c9c7, 0x3d771cc5428cccd2, 0x3d771cc5428cccd2, + 0x3d771cc5428cccd2, 0x3d771cc5428cccd2, 0x3d771cc5428cccd2, 0xbd81ed30fa696967, 0xbd81ed30fa696967, 0xbd81ed30fa696967, 0xbd81ed30fa696967, 0xbd81ed30fa696967, + 0x3d80973b69e6c6c9, 0x3d80973b69e6c6c9, 0x3d80973b69e6c6c9, 0x3d80973b69e6c6c9, 0x3d80973b69e6c6c9, 0xbd79c8b06392120d, 0xbd79c8b06392120d, 0xbd79c8b06392120d, + 0xbd79c8b06392120d, 0xbd79c8b06392120d, 0x3d85a0143287272a, 0x3d85a0143287272a, 0x3d85a0143287272a, 0x3d85a0143287272a, 0x3d85a0143287272a, 0xbd6f6dfda4a2a299, + 0xbd6f6dfda4a2a299, 0xbd6f6dfda4a2a299, 0xbd6f6dfda4a2a299, 0xbd6f6dfda4a2a299, 0x3d8aa8ecfb27878a, 0x3d8aa8ecfb27878a, 0x3d8aa8ecfb27878a, 0x3d8aa8ecfb27878a, + 0xbd92ab89826c3c3b, 0xbd5695350442422e, 0xbd5695350442422e, 0xbd5695350442422e, 0xbd5695350442422e, 0xbd5695350442422e, 0x3d8fb1c5c3c7e7ea, 0x3d8fb1c5c3c7e7ea, + 0x3d8fb1c5c3c7e7ea, 0x3d8fb1c5c3c7e7ea, 0xbd90271d1e1c0c0b, 0x3d51b19140c0c0d5, 0x3d51b19140c0c0d5, 0x3d51b19140c0c0d5, 0x3d51b19140c0c0d5, 0x3d51b19140c0c0d5, + 0xbd8b45617397b7b5, 0xbd8b45617397b7b5, 0xbd8b45617397b7b5, 0x3d925d4f46342425, 0xbd8b45617397b7b5, 0x3d6cfc2bc2e1e1ec, 0x3d6cfc2bc2e1e1ec, 0x3d6cfc2bc2e1e1ec, + 0x3d6cfc2bc2e1e1ec, 0x3d6cfc2bc2e1e1ec, 0xbd863c88aaf75755, 0xbd863c88aaf75755, 0xbd863c88aaf75755, 0xbd863c88aaf75755, 0xbd863c88aaf75755, 0x3d788fc772b1b1b7, + 0x3d788fc772b1b1b7, 0x3d788fc772b1b1b7, 0x3d788fc772b1b1b7, 0x3d788fc772b1b1b7, 0xbd8133afe256f6f4, 0xbd8133afe256f6f4, 0xbd8133afe256f6f4, 0xbd8133afe256f6f4, + 0xbd8133afe256f6f4, 0x3d8150bc81f9393c, 0x3d8150bc81f9393c, 0x3d8150bc81f9393c, 0x3d8150bc81f9393c, 0x3d8150bc81f9393c, 0xbd7855ae336d2d28, 0xbd7855ae336d2d28, + 0xbd7855ae336d2d28, 0xbd7855ae336d2d28, 0xbd7855ae336d2d28, 0x3d8659954a99999c, 0x3d8659954a99999c, 0x3d8659954a99999c, 0x3d8659954a99999c, 0x3d8659954a99999c, + 0xbd6c87f94458d8ce, 0xbd6c87f94458d8ce, 0xbd6c87f94458d8ce, 0xbd6c87f94458d8ce, 0xbd6c87f94458d8ce, 0x3d8b626e1339f9fd, 0x3d8b626e1339f9fd, 0x3d8b626e1339f9fd, + 0x3d8b626e1339f9fd, 0xbd924ec8f6630302, 0xbd50c92c43aeae99, 0xbd50c92c43aeae99, 0xbd50c92c43aeae99, 0xbd50c92c43aeae99, 0xbd50c92c43aeae99, 0xbd8f94b92425a5a3, + 0xbd8f94b92425a5a3, 0xbd8f94b92425a5a3, 0x3d9035a36ded2d2f, 0xbd8f94b92425a5a3, 0x3d577d9a0154546b, 0x3d577d9a0154546b, 0x3d577d9a0154546b, 0x3d577d9a0154546b, + 0x3d577d9a0154546b, 0xbd8a8be05b854542, 0xbd8a8be05b854542, 0xbd8a8be05b854542, 0x3d92ba0fd23d5d5f, 0xbd8a8be05b854542, 0x3d6fe230232babb7, 0x3d6fe230232babb7, + 0x3d6fe230232babb7, 0x3d6fe230232babb7, 0x3d6fe230232babb7, 0xbd85830792e4e4e2, 0xbd85830792e4e4e2, 0xbd85830792e4e4e2, 0xbd85830792e4e4e2, 0xbd85830792e4e4e2, + 0x3d7a02c9a2d6969c, 0x3d7a02c9a2d6969c, 0x3d7a02c9a2d6969c, 0x3d7a02c9a2d6969c, 0x3d7a02c9a2d6969c, 0xbd807a2eca448482, 0xbd807a2eca448482, 0xbd807a2eca448482, + 0xbd807a2eca448482, 0xbd807a2eca448482, 0x3d820a3d9a0babaf, 0x3d820a3d9a0babaf, 0x3d820a3d9a0babaf, 0x3d820a3d9a0babaf, 0x3d820a3d9a0babaf, 0xbd76e2ac03484842, + 0xbd76e2ac03484842, 0xbd76e2ac03484842, 0xbd76e2ac03484842, 0xbd76e2ac03484842, 0x3d87131662ac0c0f, 0x3d87131662ac0c0f, 0x3d87131662ac0c0f, 0x3d87131662ac0c0f, + 0x3d87131662ac0c0f, 0xbd69a1f4e40f0f03, 0xbd69a1f4e40f0f03, 0xbd69a1f4e40f0f03, 0xbd69a1f4e40f0f03, 0xbd69a1f4e40f0f03, 0x3d8c1bef2b4c6c6f, 0x3d8c1bef2b4c6c6f, + 0x3d8c1bef2b4c6c6f, 0x3d8c1bef2b4c6c6f, 0xbd91f2086a59c9c8, 0xbd45fa4706363606, 0xbd45fa4706363606, 0xbd45fa4706363606, 0xbd45fa4706363606, 0xbd45fa4706363606, + 0xbd8edb380c133330, 0xbd8edb380c133330, 0xbd8edb380c133330, 0x3d909263f9f66668, 0xbd8edb380c133330, 0x3d5d49a2c1e7e800, 0x3d5d49a2c1e7e800, 0x3d5d49a2c1e7e800, +] )) ), + +################ chunk 1536 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f6a, 0x40e7c6d5f4c83f69, 0x40e7ee1b0d7be9f0, + 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e81560262f9476, 0x40e81560262f9476, 0x40e81560262f9476, 0x40e81560262f9476, + 0x40e81560262f9476, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e863ea5796e983, 0x40e863ea5796e983, + 0x40e863ea5796e983, 0x40e863ea5796e983, 0x40e863ea5796e983, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, + 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e917, + 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e916, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e92843d3193e24, + 0x40e92843d3193e24, 0x40e92843d3193e24, 0x40e92843d3193e24, 0x40e92843d3193e23, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, + 0x40e94f88ebcce8aa, 0x40e976ce04809330, 0x40e976ce04809330, 0x40e976ce04809330, 0x40e976ce04809331, 0x40e976ce04809330, 0x40e99e131d343db7, 0x40e99e131d343db7, + 0x40e99e131d343db7, 0x40e99e131d343db7, 0x40e99e131d343db7, 0x40e9c55835e7e83d, 0x40e9c55835e7e83d, 0x40e9c55835e7e83d, 0x40e9c55835e7e83e, 0x40e9c55835e7e83d, + 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, + 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea626c98b69257, + 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, + 0x40ea89b1b16a3cde, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40ead83be2d191eb, 0x40ead83be2d191eb, + 0x40ead83be2d191eb, 0x40ead83be2d191eb, 0x40ead83be2d191ea, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, + 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f7, 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, + 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, 0x40eb755045a03c04, 0x40eb755045a03c04, 0x40eb755045a03c04, 0x40eb755045a03c05, 0x40eb755045a03c04, 0x40eb9c955e53e68b, + 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40ebc3da77079111, 0x40ebc3da77079111, 0x40ebc3da77079111, 0x40ebc3da77079112, + 0x40ebc3da77079111, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, + 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, + 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, + 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecd6be23f13abf, + 0x40ecd6be23f13abf, 0x40ecd6be23f13abf, 0x40ecd6be23f13abf, 0x40ecd6be23f13abe, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, + 0x40ecfe033ca4e545, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcb, 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, + 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d9, 0x40ed73d286bfe4d8, + 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40edc25cb82739e5, 0x40edc25cb82739e5, 0x40edc25cb82739e5, + 0x40edc25cb82739e6, 0x40edc25cb82739e5, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ee10e6e98e8ef2, + 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee382c02423979, 0x40ee382c02423979, 0x40ee382c02423979, 0x40ee382c02423979, + 0x40ee382c02423979, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee86b633a98e86, 0x40ee86b633a98e86, + 0x40ee86b633a98e86, 0x40ee86b633a98e86, 0x40ee86b633a98e86, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, + 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e392, 0x40eefc857dc48e19, 0x40eefc857dc48e19, 0x40eefc857dc48e19, + 0x40eefc857dc48e19, 0x40eefc857dc48e19, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca9678389f, 0x40ef4b0faf2be326, + 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef7254c7df8dac, 0x40ef7254c7df8dac, 0x40ef7254c7df8dac, 0x40ef7254c7df8dad, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d5d49a2c1e7e800, 0x3d5d49a2c1e7e800, 0xbd89d25f4372d2d0, 0xbd89d25f4372d2d0, 0xbd89d25f4372d2d0, 0x3d9316d05e469698, 0xbd89d25f4372d2d0, 0x3d71641a41babac1, + 0x3d71641a41babac1, 0x3d71641a41babac1, 0x3d71641a41babac1, 0x3d71641a41babac1, 0xbd84c9867ad2726f, 0xbd84c9867ad2726f, 0xbd84c9867ad2726f, 0xbd84c9867ad2726f, + 0xbd84c9867ad2726f, 0x3d7b75cbd2fb7b82, 0x3d7b75cbd2fb7b82, 0x3d7b75cbd2fb7b82, 0x3d7b75cbd2fb7b82, 0x3d7b75cbd2fb7b82, 0xbd7f815b6464241e, 0xbd7f815b6464241e, + 0xbd7f815b6464241e, 0xbd7f815b6464241e, 0xbd7f815b6464241e, 0x3d82c3beb21e1e21, 0x3d82c3beb21e1e21, 0x3d82c3beb21e1e21, 0x3d82c3beb21e1e21, 0x3d82c3beb21e1e21, + 0xbd756fa9d323635d, 0xbd756fa9d323635d, 0xbd756fa9d323635d, 0xbd756fa9d323635d, 0xbd756fa9d323635d, 0x3d87cc977abe7e82, 0x3d87cc977abe7e82, 0x3d87cc977abe7e82, + 0x3d87cc977abe7e82, 0xbd9419b442a0c0bf, 0xbd66bbf083c54538, 0xbd66bbf083c54538, 0xbd66bbf083c54538, 0xbd66bbf083c54538, 0xbd66bbf083c54538, 0x3d8cd570435edee2, + 0x3d8cd570435edee2, 0x3d8cd570435edee2, 0x3d8cd570435edee2, 0xbd919547de50908f, 0xbd34c46b0a1e1db6, 0xbd34c46b0a1e1db6, 0xbd34c46b0a1e1db6, 0xbd34c46b0a1e1db6, + 0xbd34c46b0a1e1db6, 0xbd8e21b6f400c0bd, 0xbd8e21b6f400c0bd, 0xbd8e21b6f400c0bd, 0x3d90ef2485ff9fa1, 0xbd8e21b6f400c0bd, 0x3d618ad5c13dbdcb, 0x3d618ad5c13dbdcb, + 0x3d618ad5c13dbdcb, 0x3d618ad5c13dbdcb, 0x3d618ad5c13dbdcb, 0xbd8918de2b60605d, 0xbd8918de2b60605d, 0xbd8918de2b60605d, 0x3d937390ea4fcfd1, 0xbd8918de2b60605d, + 0x3d72d71c71df9fa6, 0x3d72d71c71df9fa6, 0x3d72d71c71df9fa6, 0x3d72d71c71df9fa6, 0x3d72d71c71df9fa6, 0xbd84100562bffffd, 0xbd84100562bffffd, 0xbd84100562bffffd, + 0xbd84100562bffffd, 0xbd84100562bffffd, 0x3d7ce8ce03206067, 0x3d7ce8ce03206067, 0x3d7ce8ce03206067, 0x3d7ce8ce03206067, 0x3d7ce8ce03206067, 0xbd7e0e59343f3f38, + 0xbd7e0e59343f3f38, 0xbd7e0e59343f3f38, 0xbd7e0e59343f3f38, 0xbd7e0e59343f3f38, 0x3d837d3fca309094, 0x3d837d3fca309094, 0x3d837d3fca309094, 0x3d837d3fca309094, + 0x3d837d3fca309094, 0xbd73fca7a2fe7e78, 0xbd73fca7a2fe7e78, 0xbd73fca7a2fe7e78, 0xbd73fca7a2fe7e78, 0xbd73fca7a2fe7e78, 0x3d88861892d0f0f4, 0x3d88861892d0f0f4, + 0x3d88861892d0f0f4, 0x3d88861892d0f0f4, 0xbd93bcf3b6978786, 0xbd63d5ec237b7b6e, 0xbd63d5ec237b7b6e, 0xbd63d5ec237b7b6e, 0xbd63d5ec237b7b6e, 0xbd63d5ec237b7b6e, + 0x3d8d8ef15b715155, 0x3d8d8ef15b715155, 0x3d8d8ef15b715155, 0x3d8d8ef15b715155, 0xbd91388752475756, 0x3d035dbfc1818507, 0x3d035dbfc1818507, 0x3d035dbfc1818507, + 0x3d035dbfc1818507, 0x3d035dbfc1818507, 0xbd8d6835dbee4e4b, 0xbd8d6835dbee4e4b, 0xbd8d6835dbee4e4b, 0x3d914be51208d8db, 0xbd8d6835dbee4e4b, 0x3d6470da21878796, + 0x3d6470da21878796, 0x3d6470da21878796, 0x3d6470da21878796, 0x3d6470da21878796, 0xbd885f5d134dedea, 0xbd885f5d134dedea, 0xbd885f5d134dedea, 0x3d93d0517659090b, + 0xbd885f5d134dedea, 0x3d744a1ea204848c, 0x3d744a1ea204848c, 0x3d744a1ea204848c, 0x3d744a1ea204848c, 0x3d744a1ea204848c, 0xbd8356844aad8d8a, 0xbd8356844aad8d8a, + 0xbd8356844aad8d8a, 0xbd8356844aad8d8a, 0xbd8356844aad8d8a, 0x3d7e5bd03345454d, 0x3d7e5bd03345454d, 0x3d7e5bd03345454d, 0x3d7e5bd03345454d, 0x3d7e5bd03345454d, + 0xbd7c9b57041a5a53, 0xbd7c9b57041a5a53, 0xbd7c9b57041a5a53, 0xbd7c9b57041a5a53, 0xbd7c9b57041a5a53, 0x3d8436c0e2430307, 0x3d8436c0e2430307, 0x3d8436c0e2430307, + 0x3d8436c0e2430307, 0x3d8436c0e2430307, 0xbd7289a572d99992, 0xbd7289a572d99992, 0xbd7289a572d99992, 0xbd7289a572d99992, 0xbd7289a572d99992, 0x3d893f99aae36367, + 0x3d893f99aae36367, 0x3d893f99aae36367, 0x3d893f99aae36367, 0xbd9360332a8e4e4c, 0xbd60efe7c331b1a3, 0xbd60efe7c331b1a3, 0xbd60efe7c331b1a3, 0xbd60efe7c331b1a3, + 0xbd60efe7c331b1a3, 0x3d8e48727383c3c8, 0x3d8e48727383c3c8, 0x3d8e48727383c3c8, 0x3d8e48727383c3c8, 0xbd90dbc6c63e1e1c, 0x3d399bdafa7e7ef7, 0x3d399bdafa7e7ef7, + 0x3d399bdafa7e7ef7, 0x3d399bdafa7e7ef7, 0x3d399bdafa7e7ef7, 0xbd8caeb4c3dbdbd8, 0xbd8caeb4c3dbdbd8, 0xbd8caeb4c3dbdbd8, 0x3d91a8a59e121214, 0xbd8caeb4c3dbdbd8, + 0x3d6756de81d15161, 0x3d6756de81d15161, 0x3d6756de81d15161, 0x3d6756de81d15161, 0x3d6756de81d15161, 0xbd87a5dbfb3b7b78, 0xbd87a5dbfb3b7b78, 0xbd87a5dbfb3b7b78, + 0x3d942d1202624244, 0xbd87a5dbfb3b7b78, 0x3d75bd20d2296971, 0x3d75bd20d2296971, 0x3d75bd20d2296971, 0x3d75bd20d2296971, 0x3d75bd20d2296971, 0xbd829d03329b1b17, + 0xbd829d03329b1b17, 0xbd829d03329b1b17, 0xbd829d03329b1b17, 0xbd829d03329b1b17, 0x3d7fced2636a2a32, 0x3d7fced2636a2a32, 0x3d7fced2636a2a32, 0x3d7fced2636a2a32, + 0x3d7fced2636a2a32, 0xbd7b2854d3f5756e, 0xbd7b2854d3f5756e, 0xbd7b2854d3f5756e, 0xbd7b2854d3f5756e, 0xbd7b2854d3f5756e, 0x3d84f041fa557579, 0x3d84f041fa557579, + 0x3d84f041fa557579, 0x3d84f041fa557579, 0x3d84f041fa557579, 0xbd7116a342b4b4ad, 0xbd7116a342b4b4ad, 0xbd7116a342b4b4ad, 0xbd7116a342b4b4ad, 0xbd7116a342b4b4ad, + 0x3d89f91ac2f5d5da, 0x3d89f91ac2f5d5da, 0x3d89f91ac2f5d5da, 0x3d89f91ac2f5d5da, 0xbd9303729e851513, 0xbd5c13c6c5cfcfb0, 0xbd5c13c6c5cfcfb0, 0xbd5c13c6c5cfcfb0, + 0xbd5c13c6c5cfcfb0, 0xbd5c13c6c5cfcfb0, 0x3d8f01f38b96363a, 0x3d8f01f38b96363a, 0x3d8f01f38b96363a, 0x3d8f01f38b96363a, 0xbd907f063a34e4e3, 0x3d4865fefe6666a7, + 0x3d4865fefe6666a7, 0x3d4865fefe6666a7, 0x3d4865fefe6666a7, 0x3d4865fefe6666a7, 0xbd8bf533abc96965, 0xbd8bf533abc96965, 0xbd8bf533abc96965, 0x3d9205662a1b4b4d, +] )) ), + +################ chunk 2048 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40ef7254c7df8dac, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40efc0def946e2b9, 0x40efc0def946e2b9, + 0x40efc0def946e2b9, 0x40efc0def946e2b9, 0x40efc0def946e2b9, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, + 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f01b5721b0f126, 0x40f01b5721b0f126, 0x40f01b5721b0f126, + 0x40f01b5721b0f126, 0x40f01b5721b0f126, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f0429c3a649bad, + 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, + 0x40f0563ec6be70f0, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f07d83df721b77, 0x40f07d83df721b77, + 0x40f07d83df721b77, 0x40f07d83df721b77, 0x40f07d83df721b76, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, + 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, + 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, 0x40f0cc0e10d97083, 0x40f0cc0e10d97083, 0x40f0cc0e10d97083, 0x40f0cc0e10d97084, 0x40f0cc0e10d97083, 0x40f0dfb09d3345c7, + 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, + 0x40f0f353298d1b0a, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f11a984240c590, 0x40f11a984240c590, + 0x40f11a984240c590, 0x40f11a984240c590, 0x40f11a984240c590, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, + 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f1557fe74e455a, 0x40f1557fe74e455a, 0x40f1557fe74e455a, + 0x40f1557fe74e455a, 0x40f1557fe74e455a, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f17cc50001efe1, + 0x40f17cc50001efe1, 0x40f17cc50001efe1, 0x40f17cc50001efe1, 0x40f17cc50001efe0, 0x40f190678c5bc524, 0x40f190678c5bc524, 0x40f190678c5bc524, 0x40f190678c5bc524, + 0x40f190678c5bc524, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, + 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, 0x40f1cb4f316944ed, 0x40f1cb4f316944ed, 0x40f1cb4f316944ed, 0x40f1cb4f316944ee, 0x40f1cb4f316944ed, + 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, + 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f219d962d099fa, + 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, + 0x40f22d7bef2a6f3e, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f254c107de19c4, 0x40f254c107de19c4, + 0x40f254c107de19c4, 0x40f254c107de19c4, 0x40f254c107de19c4, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, + 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44a, 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, + 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2b6edc59f4414, + 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2ca9051f91957, 0x40f2ca9051f91957, 0x40f2ca9051f91957, 0x40f2ca9051f91958, + 0x40f2ca9051f91957, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, + 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, + 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, + 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f35402286dee2e, + 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, + 0x40f367a4b4c7c371, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b4, 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, + 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbd8bf533abc96965, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0xbd86ec5ae3290905, 0xbd86ec5ae3290905, + 0xbd86ec5ae3290905, 0xbd86ec5ae3290905, 0xbd86ec5ae3290905, 0x3d773023024e4e57, 0x3d773023024e4e57, 0x3d773023024e4e57, 0x3d773023024e4e57, 0x3d773023024e4e57, + 0xbd81e3821a88a8a5, 0xbd81e3821a88a8a5, 0xbd81e3821a88a8a5, 0xbd81e3821a88a8a5, 0xbd81e3821a88a8a5, 0xbd97af8adb1c3c3a, 0xbd97af8adb1c3c3a, 0xbd97af8adb1c3c3a, + 0xbd97af8adb1c3c3a, 0xbd97af8adb1c3c3a, 0x3d9992ab570bdbde, 0x3d9992ab570bdbde, 0x3d9992ab570bdbde, 0x3d9992ab570bdbde, 0x3d9992ab570bdbde, 0x3d85a9c31267e7ec, + 0x3d85a9c31267e7ec, 0x3d85a9c31267e7ec, 0x3d85a9c31267e7ec, 0x3d85a9c31267e7ec, 0xbd6f4742251f9f8f, 0xbd6f4742251f9f8f, 0xbd6f4742251f9f8f, 0xbd6f4742251f9f8f, + 0xbd6f4742251f9f8f, 0xbd92a6b2127bdbda, 0xbd92a6b2127bdbda, 0xbd92a6b2127bdbda, 0xbd92a6b2127bdbda, 0xbd92a6b2127bdbda, 0x3d9e9b841fac3c3e, 0x3d9e9b841fac3c3e, + 0x3d9e9b841fac3c3e, 0x3d9e9b841fac3c3e, 0xbda0b23df029e1e1, 0x3d8fbb74a3a8a8ad, 0x3d8fbb74a3a8a8ad, 0x3d8fbb74a3a8a8ad, 0x3d8fbb74a3a8a8ad, 0x3d8fbb74a3a8a8ad, + 0x3d51ff083fc6c6e9, 0x3d51ff083fc6c6e9, 0x3d51ff083fc6c6e9, 0x3d51ff083fc6c6e9, 0x3d51ff083fc6c6e9, 0xbd8b3bb293b6f6f3, 0xbd8b3bb293b6f6f3, 0xbd8b3bb293b6f6f3, + 0xbd8b3bb293b6f6f3, 0xbd8b3bb293b6f6f3, 0xbd9c5ba317b36361, 0xbd9c5ba317b36361, 0xbd9c5ba317b36361, 0x3da1d22e74264e4f, 0xbd9c5ba317b36361, 0x3d94e6931a74b4b7, + 0x3d94e6931a74b4b7, 0x3d94e6931a74b4b7, 0x3d94e6931a74b4b7, 0x3d94e6931a74b4b7, 0x3d78a3253273333c, 0x3d78a3253273333c, 0x3d78a3253273333c, 0x3d78a3253273333c, + 0x3d78a3253273333c, 0xbd812a0102763632, 0xbd812a0102763632, 0xbd812a0102763632, 0xbd812a0102763632, 0xbd812a0102763632, 0xbd9752ca4f130301, 0xbd9752ca4f130301, + 0xbd9752ca4f130301, 0xbd9752ca4f130301, 0xbd9752ca4f130301, 0x3d99ef6be3151517, 0x3d99ef6be3151517, 0x3d99ef6be3151517, 0x3d99ef6be3151517, 0x3d99ef6be3151517, + 0x3d8663442a7a5a5f, 0x3d8663442a7a5a5f, 0x3d8663442a7a5a5f, 0x3d8663442a7a5a5f, 0x3d8663442a7a5a5f, 0xbd6c613dc4d5d5c4, 0xbd6c613dc4d5d5c4, 0xbd6c613dc4d5d5c4, + 0xbd6c613dc4d5d5c4, 0xbd6c613dc4d5d5c4, 0xbd9249f18672a2a0, 0xbd9249f18672a2a0, 0xbd9249f18672a2a0, 0xbd9249f18672a2a0, 0xbd9249f18672a2a0, 0x3d9ef844abb57578, + 0x3d9ef844abb57578, 0x3d9ef844abb57578, 0x3d9ef844abb57578, 0xbda083ddaa254544, 0x3d903a7adddd8d90, 0x3d903a7adddd8d90, 0x3d903a7adddd8d90, 0x3d903a7adddd8d90, + 0x3d903a7adddd8d90, 0x3d57cb11005a5a7f, 0x3d57cb11005a5a7f, 0x3d57cb11005a5a7f, 0x3d57cb11005a5a7f, 0x3d57cb11005a5a7f, 0xbd8a82317ba48480, 0xbd8a82317ba48480, + 0xbd8a82317ba48480, 0xbd8a82317ba48480, 0xbd8a82317ba48480, 0xbd9bfee28baa2a28, 0xbd9bfee28baa2a28, 0xbd9bfee28baa2a28, 0x3da2008eba2aeaec, 0xbd9bfee28baa2a28, + 0x3d954353a67dedf0, 0x3d954353a67dedf0, 0x3d954353a67dedf0, 0x3d954353a67dedf0, 0x3d954353a67dedf0, 0x3d7a162762981821, 0x3d7a162762981821, 0x3d7a162762981821, + 0x3d7a162762981821, 0x3d7a162762981821, 0xbd80707fea63c3bf, 0xbd80707fea63c3bf, 0xbd80707fea63c3bf, 0xbd80707fea63c3bf, 0xbd80707fea63c3bf, 0xbd96f609c309c9c7, + 0xbd96f609c309c9c7, 0xbd96f609c309c9c7, 0xbd96f609c309c9c7, 0xbd96f609c309c9c7, 0x3d9a4c2c6f1e4e51, 0x3d9a4c2c6f1e4e51, 0x3d9a4c2c6f1e4e51, 0x3d9a4c2c6f1e4e51, + 0x3d9a4c2c6f1e4e51, 0x3d871cc5428cccd2, 0x3d871cc5428cccd2, 0x3d871cc5428cccd2, 0x3d871cc5428cccd2, 0x3d871cc5428cccd2, 0xbd697b39648c0bf9, 0xbd697b39648c0bf9, + 0xbd697b39648c0bf9, 0xbd697b39648c0bf9, 0xbd697b39648c0bf9, 0xbd91ed30fa696967, 0xbd91ed30fa696967, 0xbd91ed30fa696967, 0xbd91ed30fa696967, 0xbd91ed30fa696967, + 0x3d9f550537beaeb1, 0x3d9f550537beaeb1, 0x3d9f550537beaeb1, 0x3d9f550537beaeb1, 0xbda0557d6420a8a7, 0x3d90973b69e6c6c9, 0x3d90973b69e6c6c9, 0x3d90973b69e6c6c9, + 0x3d90973b69e6c6c9, 0x3d90973b69e6c6c9, 0x3d5d9719c0edee14, 0x3d5d9719c0edee14, 0x3d5d9719c0edee14, 0x3d5d9719c0edee14, 0x3d5d9719c0edee14, 0xbd89c8b06392120d, + 0xbd89c8b06392120d, 0xbd89c8b06392120d, 0xbd89c8b06392120d, 0xbd89c8b06392120d, 0xbd9ba221ffa0f0ef, 0xbd9ba221ffa0f0ef, 0xbd9ba221ffa0f0ef, 0x3da22eef002f8789, + 0xbd9ba221ffa0f0ef, 0x3d95a0143287272a, 0x3d95a0143287272a, 0x3d95a0143287272a, 0x3d95a0143287272a, 0x3d95a0143287272a, 0x3d7b892992bcfd07, 0x3d7b892992bcfd07, + 0x3d7b892992bcfd07, 0x3d7b892992bcfd07, 0x3d7b892992bcfd07, 0xbd7f6dfda4a2a299, 0xbd7f6dfda4a2a299, 0xbd7f6dfda4a2a299, 0xbd7f6dfda4a2a299, 0xbd7f6dfda4a2a299, + 0xbd9699493700908e, 0xbd9699493700908e, 0xbd9699493700908e, 0xbd9699493700908e, 0xbd9699493700908e, 0x3d9aa8ecfb27878a, 0x3d9aa8ecfb27878a, 0x3d9aa8ecfb27878a, + 0x3d9aa8ecfb27878a, 0x3d9aa8ecfb27878a, 0x3d87d6465a9f3f44, 0x3d87d6465a9f3f44, 0x3d87d6465a9f3f44, 0x3d87d6465a9f3f44, 0x3d87d6465a9f3f44, 0xbd6695350442422e, + 0xbd6695350442422e, 0xbd6695350442422e, 0xbd6695350442422e, 0xbd6695350442422e, 0xbd9190706e60302e, 0xbd9190706e60302e, 0xbd9190706e60302e, 0xbd9190706e60302e, + 0xbd9190706e60302e, 0x3d9fb1c5c3c7e7ea, 0x3d9fb1c5c3c7e7ea, 0x3d9fb1c5c3c7e7ea, 0x3d9fb1c5c3c7e7ea, 0xbda0271d1e1c0c0b, 0x3d90f3fbf5f00003, 0x3d90f3fbf5f00003, + 0x3d90f3fbf5f00003, 0x3d90f3fbf5f00003, 0x3d90f3fbf5f00003, 0x3d61b19140c0c0d5, 0x3d61b19140c0c0d5, 0x3d61b19140c0c0d5, 0x3d61b19140c0c0d5, 0x3d61b19140c0c0d5, +] )) ), + +################ chunk 2560 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, + 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3f1168b3c9848, + 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f404b917966d8b, 0x40f404b917966d8b, 0x40f404b917966d8b, 0x40f404b917966d8b, + 0x40f404b917966d8b, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f42bfe304a1812, 0x40f42bfe304a1812, + 0x40f42bfe304a1812, 0x40f42bfe304a1812, 0x40f42bfe304a1812, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, + 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f466e5d55797db, 0x40f466e5d55797db, 0x40f466e5d55797db, + 0x40f466e5d55797db, 0x40f466e5d55797db, 0x40f47a8861b16d1e, 0x40f47a8861b16d1e, 0x40f47a8861b16d1e, 0x40f47a8861b16d1f, 0x40f47a8861b16d1e, 0x40f48e2aee0b4262, + 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, + 0x40f4a1cd7a6517a5, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4c9129318c22b, 0x40f4c9129318c22b, + 0x40f4c9129318c22b, 0x40f4c9129318c22b, 0x40f4c9129318c22b, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, + 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f503fa382641f5, 0x40f503fa382641f5, 0x40f503fa382641f5, + 0x40f503fa382641f5, 0x40f503fa382641f5, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f52b3f50d9ec7c, + 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, + 0x40f53ee1dd33c1bf, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f56626f5e76c45, 0x40f56626f5e76c45, + 0x40f56626f5e76c45, 0x40f56626f5e76c45, 0x40f56626f5e76c45, 0x40f579c982414188, 0x40f579c982414188, 0x40f579c982414188, 0x40f579c982414189, 0x40f579c982414188, + 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, + 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5c853b3a89695, + 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, + 0x40f5dbf640026bd9, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f6033b58b6165f, 0x40f6033b58b6165f, + 0x40f6033b58b6165f, 0x40f6033b58b6165f, 0x40f6033b58b6165f, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, + 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e5, 0x40f63e22fdc39629, 0x40f63e22fdc39629, 0x40f63e22fdc39629, + 0x40f63e22fdc39629, 0x40f63e22fdc39629, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f66568167740af, + 0x40f66568167740af, 0x40f66568167740af, 0x40f66568167740af, 0x40f66568167740af, 0x40f6790aa2d115f2, 0x40f6790aa2d115f2, 0x40f6790aa2d115f2, 0x40f6790aa2d115f3, + 0x40f6790aa2d115f2, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, + 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, + 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6db3760924043, 0x40f6db3760924043, 0x40f6db3760924043, + 0x40f6db3760924043, 0x40f6db3760924043, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f7027c7945eac9, + 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7161f059fc00c, 0x40f7161f059fc00c, 0x40f7161f059fc00c, 0x40f7161f059fc00c, + 0x40f7161f059fc00c, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f9954f, 0x40f73d641e536a93, 0x40f73d641e536a93, + 0x40f73d641e536a93, 0x40f73d641e536a93, 0x40f73d641e536a93, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, + 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f7784bc360ea5c, 0x40f7784bc360ea5c, 0x40f7784bc360ea5c, + 0x40f7784bc360ea5d, 0x40f7784bc360ea5c, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f79f90dc1494e3, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbd890f2f4b7f9f9b, 0xbd890f2f4b7f9f9b, 0xbd890f2f4b7f9f9b, 0xbd890f2f4b7f9f9b, 0xbd890f2f4b7f9f9b, 0xbd9b45617397b7b5, 0xbd9b45617397b7b5, 0xbd9b45617397b7b5, + 0xbd9b45617397b7b5, 0xbd9b45617397b7b5, 0x3d95fcd4be906063, 0x3d95fcd4be906063, 0x3d95fcd4be906063, 0x3d95fcd4be906063, 0x3d95fcd4be906063, 0x3d7cfc2bc2e1e1ec, + 0x3d7cfc2bc2e1e1ec, 0x3d7cfc2bc2e1e1ec, 0x3d7cfc2bc2e1e1ec, 0x3d7cfc2bc2e1e1ec, 0xbd7dfafb747dbdb3, 0xbd7dfafb747dbdb3, 0xbd7dfafb747dbdb3, 0xbd7dfafb747dbdb3, + 0xbd7dfafb747dbdb3, 0xbd963c88aaf75755, 0xbd963c88aaf75755, 0xbd963c88aaf75755, 0xbd963c88aaf75755, 0xbd963c88aaf75755, 0x3d9b05ad8730c0c3, 0x3d9b05ad8730c0c3, + 0x3d9b05ad8730c0c3, 0x3d9b05ad8730c0c3, 0x3d9b05ad8730c0c3, 0x3d888fc772b1b1b7, 0x3d888fc772b1b1b7, 0x3d888fc772b1b1b7, 0x3d888fc772b1b1b7, 0x3d888fc772b1b1b7, + 0xbd63af30a3f87864, 0xbd63af30a3f87864, 0xbd63af30a3f87864, 0xbd63af30a3f87864, 0xbd63af30a3f87864, 0xbd9133afe256f6f4, 0xbd9133afe256f6f4, 0xbd9133afe256f6f4, + 0xbd9133afe256f6f4, 0xbd9133afe256f6f4, 0xbd9ff179b02ededc, 0xbd9ff179b02ededc, 0xbd9ff179b02ededc, 0x3da0074327e89092, 0xbd9ff179b02ededc, 0x3d9150bc81f9393c, + 0x3d9150bc81f9393c, 0x3d9150bc81f9393c, 0x3d9150bc81f9393c, 0x3d9150bc81f9393c, 0x3d649795a10a8aa0, 0x3d649795a10a8aa0, 0x3d649795a10a8aa0, 0x3d649795a10a8aa0, + 0x3d649795a10a8aa0, 0xbd8855ae336d2d28, 0xbd8855ae336d2d28, 0xbd8855ae336d2d28, 0xbd8855ae336d2d28, 0xbd8855ae336d2d28, 0xbd9ae8a0e78e7e7c, 0xbd9ae8a0e78e7e7c, + 0xbd9ae8a0e78e7e7c, 0xbd9ae8a0e78e7e7c, 0xbd9ae8a0e78e7e7c, 0x3d9659954a99999c, 0x3d9659954a99999c, 0x3d9659954a99999c, 0x3d9659954a99999c, 0x3d9659954a99999c, + 0x3d7e6f2df306c6d2, 0x3d7e6f2df306c6d2, 0x3d7e6f2df306c6d2, 0x3d7e6f2df306c6d2, 0x3d7e6f2df306c6d2, 0xbd7c87f94458d8ce, 0xbd7c87f94458d8ce, 0xbd7c87f94458d8ce, + 0xbd7c87f94458d8ce, 0xbd7c87f94458d8ce, 0xbd95dfc81eee1e1b, 0xbd95dfc81eee1e1b, 0xbd95dfc81eee1e1b, 0xbd95dfc81eee1e1b, 0xbd95dfc81eee1e1b, 0x3d9b626e1339f9fd, + 0x3d9b626e1339f9fd, 0x3d9b626e1339f9fd, 0x3d9b626e1339f9fd, 0x3d9b626e1339f9fd, 0x3d8949488ac4242a, 0x3d8949488ac4242a, 0x3d8949488ac4242a, 0x3d8949488ac4242a, + 0x3d8949488ac4242a, 0xbd60c92c43aeae99, 0xbd60c92c43aeae99, 0xbd60c92c43aeae99, 0xbd60c92c43aeae99, 0xbd60c92c43aeae99, 0xbd90d6ef564dbdbb, 0xbd90d6ef564dbdbb, + 0xbd90d6ef564dbdbb, 0xbd90d6ef564dbdbb, 0xbd90d6ef564dbdbb, 0xbd9f94b92425a5a3, 0xbd9f94b92425a5a3, 0xbd9f94b92425a5a3, 0x3da035a36ded2d2f, 0xbd9f94b92425a5a3, + 0x3d91ad7d0e027275, 0x3d91ad7d0e027275, 0x3d91ad7d0e027275, 0x3d91ad7d0e027275, 0x3d91ad7d0e027275, 0x3d677d9a0154546b, 0x3d677d9a0154546b, 0x3d677d9a0154546b, + 0x3d677d9a0154546b, 0x3d677d9a0154546b, 0xbd879c2d1b5abab5, 0xbd879c2d1b5abab5, 0xbd879c2d1b5abab5, 0xbd879c2d1b5abab5, 0xbd879c2d1b5abab5, 0xbd9a8be05b854542, + 0xbd9a8be05b854542, 0xbd9a8be05b854542, 0xbd9a8be05b854542, 0xbd9a8be05b854542, 0x3d96b655d6a2d2d6, 0x3d96b655d6a2d2d6, 0x3d96b655d6a2d2d6, 0x3d96b655d6a2d2d6, + 0x3d96b655d6a2d2d6, 0x3d7fe230232babb7, 0x3d7fe230232babb7, 0x3d7fe230232babb7, 0x3d7fe230232babb7, 0x3d7fe230232babb7, 0xbd7b14f71433f3e9, 0xbd7b14f71433f3e9, + 0xbd7b14f71433f3e9, 0xbd7b14f71433f3e9, 0xbd7b14f71433f3e9, 0xbd95830792e4e4e2, 0xbd95830792e4e4e2, 0xbd95830792e4e4e2, 0xbd95830792e4e4e2, 0xbd95830792e4e4e2, + 0x3d9bbf2e9f433336, 0x3d9bbf2e9f433336, 0x3d9bbf2e9f433336, 0x3d9bbf2e9f433336, 0xbda22068b05e6665, 0x3d8a02c9a2d6969c, 0x3d8a02c9a2d6969c, 0x3d8a02c9a2d6969c, + 0x3d8a02c9a2d6969c, 0x3d8a02c9a2d6969c, 0xbd5bc64fc6c9c99c, 0xbd5bc64fc6c9c99c, 0xbd5bc64fc6c9c99c, 0xbd5bc64fc6c9c99c, 0xbd5bc64fc6c9c99c, 0xbd907a2eca448482, + 0xbd907a2eca448482, 0xbd907a2eca448482, 0xbd907a2eca448482, 0xbd907a2eca448482, 0xbd9f37f8981c6c6a, 0xbd9f37f8981c6c6a, 0xbd9f37f8981c6c6a, 0x3da06403b3f1c9cb, + 0xbd9f37f8981c6c6a, 0x3d920a3d9a0babaf, 0x3d920a3d9a0babaf, 0x3d920a3d9a0babaf, 0x3d920a3d9a0babaf, 0x3d920a3d9a0babaf, 0x3d6a639e619e1e35, 0x3d6a639e619e1e35, + 0x3d6a639e619e1e35, 0x3d6a639e619e1e35, 0x3d6a639e619e1e35, 0xbd86e2ac03484842, 0xbd86e2ac03484842, 0xbd86e2ac03484842, 0xbd86e2ac03484842, 0xbd86e2ac03484842, + 0xbd9a2f1fcf7c0c09, 0xbd9a2f1fcf7c0c09, 0xbd9a2f1fcf7c0c09, 0xbd9a2f1fcf7c0c09, 0xbd9a2f1fcf7c0c09, 0x3d97131662ac0c0f, 0x3d97131662ac0c0f, 0x3d97131662ac0c0f, + 0x3d97131662ac0c0f, 0x3d97131662ac0c0f, 0x3d80aa9929a8484e, 0x3d80aa9929a8484e, 0x3d80aa9929a8484e, 0x3d80aa9929a8484e, 0x3d80aa9929a8484e, 0xbd79a1f4e40f0f03, + 0xbd79a1f4e40f0f03, 0xbd79a1f4e40f0f03, 0xbd79a1f4e40f0f03, 0xbd79a1f4e40f0f03, 0xbd95264706dbaba9, 0xbd95264706dbaba9, 0xbd95264706dbaba9, 0xbd95264706dbaba9, + 0xbd95264706dbaba9, 0x3d9c1bef2b4c6c6f, 0x3d9c1bef2b4c6c6f, 0x3d9c1bef2b4c6c6f, 0x3d9c1bef2b4c6c6f, 0xbda1f2086a59c9c8, 0x3d8abc4abae9090f, 0x3d8abc4abae9090f, + 0x3d8abc4abae9090f, 0x3d8abc4abae9090f, 0x3d8abc4abae9090f, 0xbd55fa4706363606, 0xbd55fa4706363606, 0xbd55fa4706363606, 0xbd55fa4706363606, 0xbd55fa4706363606, + 0xbd901d6e3e3b4b48, 0xbd901d6e3e3b4b48, 0xbd901d6e3e3b4b48, 0xbd901d6e3e3b4b48, 0xbd901d6e3e3b4b48, 0xbd9edb380c133330, 0xbd9edb380c133330, 0xbd9edb380c133330, + 0x3da09263f9f66668, 0xbd9edb380c133330, 0x3d9266fe2614e4e8, 0x3d9266fe2614e4e8, 0x3d9266fe2614e4e8, 0x3d9266fe2614e4e8, 0x3d9266fe2614e4e8, 0x3d6d49a2c1e7e800, +] )) ), + +################ chunk 3072 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f7b333686e6a26, 0x40f7b333686e6a26, 0x40f7b333686e6a26, 0x40f7b333686e6a26, + 0x40f7b333686e6a26, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7da78812214ad, 0x40f7da78812214ad, + 0x40f7da78812214ad, 0x40f7da78812214ad, 0x40f7da78812214ad, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, + 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f81560262f9476, 0x40f81560262f9476, 0x40f81560262f9476, + 0x40f81560262f9476, 0x40f81560262f9476, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969b9, 0x40f83ca53ee33efd, + 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f85047cb3d1440, 0x40f85047cb3d1440, 0x40f85047cb3d1440, 0x40f85047cb3d1440, + 0x40f85047cb3d1440, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f8778ce3f0bec6, 0x40f8778ce3f0bec6, + 0x40f8778ce3f0bec6, 0x40f8778ce3f0bec7, 0x40f8778ce3f0bec6, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, + 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, + 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8d9b9a1b1e917, + 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, + 0x40f8ed5c2e0bbe5a, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f914a146bf68e0, 0x40f914a146bf68e0, + 0x40f914a146bf68e0, 0x40f914a146bf68e0, 0x40f914a146bf68e0, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e23, + 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, + 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f976ce04809330, + 0x40f976ce04809330, 0x40f976ce04809330, 0x40f976ce04809331, 0x40f976ce04809330, 0x40f98a7090da6874, 0x40f98a7090da6874, 0x40f98a7090da6874, 0x40f98a7090da6874, + 0x40f98a7090da6874, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, + 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, + 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, + 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa13e2674f3d4a, + 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, + 0x40fa2784f3a9128d, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, + 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, + 0x40fa760f2510679a, 0x40fa760f2510679a, 0x40fa760f2510679a, 0x40fa760f2510679b, 0x40fa760f2510679a, 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, + 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fab0f6ca1de764, + 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fac4995677bca7, 0x40fac4995677bca7, 0x40fac4995677bca7, 0x40fac4995677bca7, + 0x40fac4995677bca7, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40faebde6f2b672e, 0x40faebde6f2b672e, + 0x40faebde6f2b672e, 0x40faebde6f2b672e, 0x40faebde6f2b672e, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, + 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb26c61438e6f8, 0x40fb26c61438e6f8, 0x40fb26c61438e6f8, + 0x40fb26c61438e6f8, 0x40fb26c61438e6f7, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb4e0b2cec917e, + 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb61adb94666c1, 0x40fb61adb94666c1, 0x40fb61adb94666c1, 0x40fb61adb94666c1, + 0x40fb61adb94666c1, 0x40fb755045a03c04, 0x40fb755045a03c04, 0x40fb755045a03c04, 0x40fb755045a03c05, 0x40fb755045a03c04, 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d6d49a2c1e7e800, 0x3d6d49a2c1e7e800, 0x3d6d49a2c1e7e800, 0x3d6d49a2c1e7e800, 0xbd86292aeb35d5d0, 0xbd86292aeb35d5d0, 0xbd86292aeb35d5d0, 0xbd86292aeb35d5d0, + 0xbd86292aeb35d5d0, 0xbd99d25f4372d2d0, 0xbd99d25f4372d2d0, 0xbd99d25f4372d2d0, 0xbd99d25f4372d2d0, 0xbd99d25f4372d2d0, 0x3d976fd6eeb54548, 0x3d976fd6eeb54548, + 0x3d976fd6eeb54548, 0x3d976fd6eeb54548, 0x3d976fd6eeb54548, 0x3d81641a41babac1, 0x3d81641a41babac1, 0x3d81641a41babac1, 0x3d81641a41babac1, 0x3d81641a41babac1, + 0xbd782ef2b3ea2a1e, 0xbd782ef2b3ea2a1e, 0xbd782ef2b3ea2a1e, 0xbd782ef2b3ea2a1e, 0xbd782ef2b3ea2a1e, 0xbd94c9867ad2726f, 0xbd94c9867ad2726f, 0xbd94c9867ad2726f, + 0xbd94c9867ad2726f, 0xbd94c9867ad2726f, 0x3d9c78afb755a5a9, 0x3d9c78afb755a5a9, 0x3d9c78afb755a5a9, 0x3d9c78afb755a5a9, 0xbda1c3a824552d2c, 0x3d8b75cbd2fb7b82, + 0x3d8b75cbd2fb7b82, 0x3d8b75cbd2fb7b82, 0x3d8b75cbd2fb7b82, 0x3d8b75cbd2fb7b82, 0xbd502e3e45a2a270, 0xbd502e3e45a2a270, 0xbd502e3e45a2a270, 0xbd502e3e45a2a270, + 0xbd502e3e45a2a270, 0xbd8f815b6464241e, 0xbd8f815b6464241e, 0xbd8f815b6464241e, 0xbd8f815b6464241e, 0xbd8f815b6464241e, 0xbd9e7e778009f9f7, 0xbd9e7e778009f9f7, + 0xbd9e7e778009f9f7, 0x3da0c0c43ffb0305, 0xbd9e7e778009f9f7, 0x3d92c3beb21e1e21, 0x3d92c3beb21e1e21, 0x3d92c3beb21e1e21, 0x3d92c3beb21e1e21, 0x3d92c3beb21e1e21, + 0x3d7017d39118d8e6, 0x3d7017d39118d8e6, 0x3d7017d39118d8e6, 0x3d7017d39118d8e6, 0x3d7017d39118d8e6, 0xbd856fa9d323635d, 0xbd856fa9d323635d, 0xbd856fa9d323635d, + 0xbd856fa9d323635d, 0xbd856fa9d323635d, 0xbd99759eb7699996, 0xbd99759eb7699996, 0xbd99759eb7699996, 0xbd99759eb7699996, 0xbd99759eb7699996, 0x3d97cc977abe7e82, + 0x3d97cc977abe7e82, 0x3d97cc977abe7e82, 0x3d97cc977abe7e82, 0x3d97cc977abe7e82, 0x3d821d9b59cd2d34, 0x3d821d9b59cd2d34, 0x3d821d9b59cd2d34, 0x3d821d9b59cd2d34, + 0x3d821d9b59cd2d34, 0xbd76bbf083c54538, 0xbd76bbf083c54538, 0xbd76bbf083c54538, 0xbd76bbf083c54538, 0xbd76bbf083c54538, 0xbd946cc5eec93936, 0xbd946cc5eec93936, + 0xbd946cc5eec93936, 0xbd946cc5eec93936, 0xbd946cc5eec93936, 0x3d9cd570435edee2, 0x3d9cd570435edee2, 0x3d9cd570435edee2, 0x3d9cd570435edee2, 0xbda19547de50908f, + 0x3d8c2f4ceb0dedf4, 0x3d8c2f4ceb0dedf4, 0x3d8c2f4ceb0dedf4, 0x3d8c2f4ceb0dedf4, 0x3d8c2f4ceb0dedf4, 0xbd44c46b0a1e1db6, 0xbd44c46b0a1e1db6, 0xbd44c46b0a1e1db6, + 0xbd44c46b0a1e1db6, 0xbd44c46b0a1e1db6, 0xbd8ec7da4c51b1ab, 0xbd8ec7da4c51b1ab, 0xbd8ec7da4c51b1ab, 0xbd8ec7da4c51b1ab, 0xbd8ec7da4c51b1ab, 0xbd9e21b6f400c0bd, + 0xbd9e21b6f400c0bd, 0xbd9e21b6f400c0bd, 0x3da0ef2485ff9fa1, 0xbd9e21b6f400c0bd, 0x3d93207f3e27575b, 0x3d93207f3e27575b, 0x3d93207f3e27575b, 0x3d93207f3e27575b, + 0x3d93207f3e27575b, 0x3d718ad5c13dbdcb, 0x3d718ad5c13dbdcb, 0x3d718ad5c13dbdcb, 0x3d718ad5c13dbdcb, 0x3d718ad5c13dbdcb, 0xbd84b628bb10f0ea, 0xbd84b628bb10f0ea, + 0xbd84b628bb10f0ea, 0xbd84b628bb10f0ea, 0xbd84b628bb10f0ea, 0xbd9918de2b60605d, 0xbd9918de2b60605d, 0xbd9918de2b60605d, 0xbd9918de2b60605d, 0xbd9918de2b60605d, + 0x3d98295806c7b7bb, 0x3d98295806c7b7bb, 0x3d98295806c7b7bb, 0x3d98295806c7b7bb, 0x3d98295806c7b7bb, 0x3d82d71c71df9fa6, 0x3d82d71c71df9fa6, 0x3d82d71c71df9fa6, + 0x3d82d71c71df9fa6, 0x3d82d71c71df9fa6, 0xbd7548ee53a06053, 0xbd7548ee53a06053, 0xbd7548ee53a06053, 0xbd7548ee53a06053, 0xbd7548ee53a06053, 0xbd94100562bffffd, + 0xbd94100562bffffd, 0xbd94100562bffffd, 0xbd94100562bffffd, 0xbd94100562bffffd, 0x3d9d3230cf68181b, 0x3d9d3230cf68181b, 0x3d9d3230cf68181b, 0x3d9d3230cf68181b, + 0xbda166e7984bf3f2, 0x3d8ce8ce03206067, 0x3d8ce8ce03206067, 0x3d8ce8ce03206067, 0x3d8ce8ce03206067, 0x3d8ce8ce03206067, 0xbd3258b311eded15, 0xbd3258b311eded15, + 0xbd3258b311eded15, 0xbd3258b311eded15, 0xbd3258b311eded15, 0xbd8e0e59343f3f38, 0xbd8e0e59343f3f38, 0xbd8e0e59343f3f38, 0xbd8e0e59343f3f38, 0xbd8e0e59343f3f38, + 0xbd9dc4f667f78784, 0xbd9dc4f667f78784, 0xbd9dc4f667f78784, 0x3da11d84cc043c3e, 0xbd9dc4f667f78784, 0x3d937d3fca309094, 0x3d937d3fca309094, 0x3d937d3fca309094, + 0x3d937d3fca309094, 0x3d937d3fca309094, 0x3d72fdd7f162a2b0, 0x3d72fdd7f162a2b0, 0x3d72fdd7f162a2b0, 0x3d72fdd7f162a2b0, 0x3d72fdd7f162a2b0, 0xbd83fca7a2fe7e78, + 0xbd83fca7a2fe7e78, 0xbd83fca7a2fe7e78, 0xbd83fca7a2fe7e78, 0xbd83fca7a2fe7e78, 0xbd98bc1d9f572724, 0xbd98bc1d9f572724, 0xbd98bc1d9f572724, 0xbd98bc1d9f572724, + 0xbd98bc1d9f572724, 0x3d98861892d0f0f4, 0x3d98861892d0f0f4, 0x3d98861892d0f0f4, 0x3d98861892d0f0f4, 0x3d98861892d0f0f4, 0x3d83909d89f21219, 0x3d83909d89f21219, + 0x3d83909d89f21219, 0x3d83909d89f21219, 0x3d83909d89f21219, 0xbd73d5ec237b7b6e, 0xbd73d5ec237b7b6e, 0xbd73d5ec237b7b6e, 0xbd73d5ec237b7b6e, 0xbd73d5ec237b7b6e, + 0xbd93b344d6b6c6c3, 0xbd93b344d6b6c6c3, 0xbd93b344d6b6c6c3, 0xbd93b344d6b6c6c3, 0xbd93b344d6b6c6c3, 0x3d9d8ef15b715155, 0x3d9d8ef15b715155, 0x3d9d8ef15b715155, + 0x3d9d8ef15b715155, 0xbda1388752475756, 0x3d8da24f1b32d2da, 0x3d8da24f1b32d2da, 0x3d8da24f1b32d2da, 0x3d8da24f1b32d2da, 0x3d8da24f1b32d2da, 0x3d135dbfc1818507, + 0x3d135dbfc1818507, 0x3d135dbfc1818507, 0x3d135dbfc1818507, 0x3d135dbfc1818507, 0xbd8d54d81c2cccc6, 0xbd8d54d81c2cccc6, 0xbd8d54d81c2cccc6, 0xbd8d54d81c2cccc6, + 0xbd8d54d81c2cccc6, 0xbd9d6835dbee4e4b, 0xbd9d6835dbee4e4b, 0xbd9d6835dbee4e4b, 0x3da14be51208d8db, 0xbd9d6835dbee4e4b, 0x3d93da005639c9cd, 0x3d93da005639c9cd, +] )) ), + +################ chunk 3584 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, + 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbc3da77079111, 0x40fbc3da77079111, 0x40fbc3da77079111, + 0x40fbc3da77079111, 0x40fbc3da77079111, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbeb1f8fbb3b98, + 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbfec21c1510db, 0x40fbfec21c1510db, 0x40fbfec21c1510db, 0x40fbfec21c1510db, + 0x40fbfec21c1510db, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc260734c8bb62, 0x40fc260734c8bb62, + 0x40fc260734c8bb62, 0x40fc260734c8bb62, 0x40fc260734c8bb61, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, + 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, + 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, 0x40fc74916630106e, 0x40fc74916630106e, 0x40fc74916630106e, 0x40fc74916630106f, 0x40fc74916630106e, 0x40fc8833f289e5b2, + 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, + 0x40fc9bd67ee3baf5, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcc31b9797657b, 0x40fcc31b9797657b, + 0x40fcc31b9797657b, 0x40fcc31b9797657b, 0x40fcc31b9797657b, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, + 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, + 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd254855588fcc, + 0x40fd254855588fcc, 0x40fd254855588fcc, 0x40fd254855588fcc, 0x40fd254855588fcb, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, + 0x40fd38eae1b2650f, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd602ffa660f95, 0x40fd602ffa660f95, + 0x40fd602ffa660f95, 0x40fd602ffa660f95, 0x40fd602ffa660f95, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d9, 0x40fd73d286bfe4d8, + 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, + 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdc25cb82739e5, + 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, + 0x40fdd5ff44810f29, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, + 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, + 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86435, 0x40fe382c02423979, 0x40fe382c02423979, 0x40fe382c02423979, + 0x40fe382c02423979, 0x40fe382c02423979, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe5f711af5e3ff, + 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe7313a74fb942, 0x40fe7313a74fb942, 0x40fe7313a74fb942, 0x40fe7313a74fb943, + 0x40fe7313a74fb942, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, + 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, + 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fed5406510e393, 0x40fed5406510e393, 0x40fed5406510e393, + 0x40fed5406510e393, 0x40fed5406510e393, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fefc857dc48e19, + 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40ff10280a1e635c, 0x40ff10280a1e635c, 0x40ff10280a1e635c, 0x40ff10280a1e635c, + 0x40ff10280a1e635c, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca9678389f, 0x40ff376d22d20de3, 0x40ff376d22d20de3, + 0x40ff376d22d20de3, 0x40ff376d22d20de3, 0x40ff376d22d20de3, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, + 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff7254c7df8dac, 0x40ff7254c7df8dac, 0x40ff7254c7df8dac, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d93da005639c9cd, 0x3d93da005639c9cd, 0x3d93da005639c9cd, 0x3d7470da21878796, 0x3d7470da21878796, 0x3d7470da21878796, 0x3d7470da21878796, 0x3d7470da21878796, + 0xbd8343268aec0c05, 0xbd8343268aec0c05, 0xbd8343268aec0c05, 0xbd8343268aec0c05, 0xbd8343268aec0c05, 0xbd985f5d134dedea, 0xbd985f5d134dedea, 0xbd985f5d134dedea, + 0xbd985f5d134dedea, 0xbd985f5d134dedea, 0x3d98e2d91eda2a2e, 0x3d98e2d91eda2a2e, 0x3d98e2d91eda2a2e, 0x3d98e2d91eda2a2e, 0x3d98e2d91eda2a2e, 0x3d844a1ea204848c, + 0x3d844a1ea204848c, 0x3d844a1ea204848c, 0x3d844a1ea204848c, 0x3d844a1ea204848c, 0xbd7262e9f3569688, 0xbd7262e9f3569688, 0xbd7262e9f3569688, 0xbd7262e9f3569688, + 0xbd7262e9f3569688, 0xbd9356844aad8d8a, 0xbd9356844aad8d8a, 0xbd9356844aad8d8a, 0xbd9356844aad8d8a, 0xbd9356844aad8d8a, 0x3d9debb1e77a8a8e, 0x3d9debb1e77a8a8e, + 0x3d9debb1e77a8a8e, 0x3d9debb1e77a8a8e, 0xbda10a270c42bab9, 0x3d8e5bd03345454d, 0x3d8e5bd03345454d, 0x3d8e5bd03345454d, 0x3d8e5bd03345454d, 0x3d8e5bd03345454d, + 0x3d3c0792f2aeaf98, 0x3d3c0792f2aeaf98, 0x3d3c0792f2aeaf98, 0x3d3c0792f2aeaf98, 0x3d3c0792f2aeaf98, 0xbd8c9b57041a5a53, 0xbd8c9b57041a5a53, 0xbd8c9b57041a5a53, + 0xbd8c9b57041a5a53, 0xbd8c9b57041a5a53, 0xbd9d0b754fe51511, 0xbd9d0b754fe51511, 0xbd9d0b754fe51511, 0x3da17a45580d7577, 0xbd9d0b754fe51511, 0x3d9436c0e2430307, + 0x3d9436c0e2430307, 0x3d9436c0e2430307, 0x3d9436c0e2430307, 0x3d9436c0e2430307, 0x3d75e3dc51ac6c7b, 0x3d75e3dc51ac6c7b, 0x3d75e3dc51ac6c7b, 0x3d75e3dc51ac6c7b, + 0x3d75e3dc51ac6c7b, 0xbd8289a572d99992, 0xbd8289a572d99992, 0xbd8289a572d99992, 0xbd8289a572d99992, 0xbd8289a572d99992, 0xbd98029c8744b4b1, 0xbd98029c8744b4b1, + 0xbd98029c8744b4b1, 0xbd98029c8744b4b1, 0xbd98029c8744b4b1, 0x3d993f99aae36367, 0x3d993f99aae36367, 0x3d993f99aae36367, 0x3d993f99aae36367, 0x3d993f99aae36367, + 0x3d85039fba16f6fe, 0x3d85039fba16f6fe, 0x3d85039fba16f6fe, 0x3d85039fba16f6fe, 0x3d85039fba16f6fe, 0xbd70efe7c331b1a3, 0xbd70efe7c331b1a3, 0xbd70efe7c331b1a3, + 0xbd70efe7c331b1a3, 0xbd70efe7c331b1a3, 0xbd92f9c3bea45451, 0xbd92f9c3bea45451, 0xbd92f9c3bea45451, 0xbd92f9c3bea45451, 0xbd92f9c3bea45451, 0x3d9e48727383c3c8, + 0x3d9e48727383c3c8, 0x3d9e48727383c3c8, 0x3d9e48727383c3c8, 0xbda0dbc6c63e1e1c, 0x3d8f15514b57b7bf, 0x3d8f15514b57b7bf, 0x3d8f15514b57b7bf, 0x3d8f15514b57b7bf, + 0x3d8f15514b57b7bf, 0x3d499bdafa7e7ef7, 0x3d499bdafa7e7ef7, 0x3d499bdafa7e7ef7, 0x3d499bdafa7e7ef7, 0x3d499bdafa7e7ef7, 0xbd8be1d5ec07e7e0, 0xbd8be1d5ec07e7e0, + 0xbd8be1d5ec07e7e0, 0xbd8be1d5ec07e7e0, 0xbd8be1d5ec07e7e0, 0xbd9caeb4c3dbdbd8, 0xbd9caeb4c3dbdbd8, 0xbd9caeb4c3dbdbd8, 0x3da1a8a59e121214, 0xbd9caeb4c3dbdbd8, + 0x3d9493816e4c3c40, 0x3d9493816e4c3c40, 0x3d9493816e4c3c40, 0x3d9493816e4c3c40, 0x3d9493816e4c3c40, 0x3d7756de81d15161, 0x3d7756de81d15161, 0x3d7756de81d15161, + 0x3d7756de81d15161, 0x3d7756de81d15161, 0xbd81d0245ac7271f, 0xbd81d0245ac7271f, 0xbd81d0245ac7271f, 0xbd81d0245ac7271f, 0xbd81d0245ac7271f, 0xbd97a5dbfb3b7b78, + 0xbd97a5dbfb3b7b78, 0xbd97a5dbfb3b7b78, 0xbd97a5dbfb3b7b78, 0xbd97a5dbfb3b7b78, 0x3d999c5a36ec9ca0, 0x3d999c5a36ec9ca0, 0x3d999c5a36ec9ca0, 0x3d999c5a36ec9ca0, + 0x3d999c5a36ec9ca0, 0x3d85bd20d2296971, 0x3d85bd20d2296971, 0x3d85bd20d2296971, 0x3d85bd20d2296971, 0x3d85bd20d2296971, 0xbd6ef9cb2619997b, 0xbd6ef9cb2619997b, + 0xbd6ef9cb2619997b, 0xbd6ef9cb2619997b, 0xbd6ef9cb2619997b, 0xbd929d03329b1b17, 0xbd929d03329b1b17, 0xbd929d03329b1b17, 0xbd929d03329b1b17, 0xbd929d03329b1b17, + 0x3d9ea532ff8cfd01, 0x3d9ea532ff8cfd01, 0x3d9ea532ff8cfd01, 0x3d9ea532ff8cfd01, 0xbda0ad6680398180, 0x3d8fced2636a2a32, 0x3d8fced2636a2a32, 0x3d8fced2636a2a32, + 0x3d8fced2636a2a32, 0x3d8fced2636a2a32, 0x3d5299f63dd2d311, 0x3d5299f63dd2d311, 0x3d5299f63dd2d311, 0x3d5299f63dd2d311, 0x3d5299f63dd2d311, 0xbd8b2854d3f5756e, + 0xbd8b2854d3f5756e, 0xbd8b2854d3f5756e, 0xbd8b2854d3f5756e, 0xbd8b2854d3f5756e, 0xbd9c51f437d2a29f, 0xbd9c51f437d2a29f, 0xbd9c51f437d2a29f, 0x3da1d705e416aeb1, + 0xbd9c51f437d2a29f, 0x3d94f041fa557579, 0x3d94f041fa557579, 0x3d94f041fa557579, 0x3d94f041fa557579, 0x3d94f041fa557579, 0x3d78c9e0b1f63646, 0x3d78c9e0b1f63646, + 0x3d78c9e0b1f63646, 0x3d78c9e0b1f63646, 0x3d78c9e0b1f63646, 0xbd8116a342b4b4ad, 0xbd8116a342b4b4ad, 0xbd8116a342b4b4ad, 0xbd8116a342b4b4ad, 0xbd8116a342b4b4ad, + 0xbd97491b6f32423e, 0xbd97491b6f32423e, 0xbd97491b6f32423e, 0xbd97491b6f32423e, 0xbd97491b6f32423e, 0x3d99f91ac2f5d5da, 0x3d99f91ac2f5d5da, 0x3d99f91ac2f5d5da, + 0x3d99f91ac2f5d5da, 0x3d99f91ac2f5d5da, 0x3d8676a1ea3bdbe4, 0x3d8676a1ea3bdbe4, 0x3d8676a1ea3bdbe4, 0x3d8676a1ea3bdbe4, 0x3d8676a1ea3bdbe4, 0xbd6c13c6c5cfcfb0, + 0xbd6c13c6c5cfcfb0, 0xbd6c13c6c5cfcfb0, 0xbd6c13c6c5cfcfb0, 0xbd6c13c6c5cfcfb0, 0xbd924042a691e1de, 0xbd924042a691e1de, 0xbd924042a691e1de, 0xbd924042a691e1de, + 0xbd924042a691e1de, 0x3d9f01f38b96363a, 0x3d9f01f38b96363a, 0x3d9f01f38b96363a, 0x3d9f01f38b96363a, 0xbda07f063a34e4e3, 0x3d904429bdbe4e52, 0x3d904429bdbe4e52, + 0x3d904429bdbe4e52, 0x3d904429bdbe4e52, 0x3d904429bdbe4e52, 0x3d5865fefe6666a7, 0x3d5865fefe6666a7, 0x3d5865fefe6666a7, 0x3d5865fefe6666a7, 0x3d5865fefe6666a7, + 0xbd8a6ed3bbe302fb, 0xbd8a6ed3bbe302fb, 0xbd8a6ed3bbe302fb, 0xbd8a6ed3bbe302fb, 0xbd8a6ed3bbe302fb, 0xbd9bf533abc96965, 0xbd9bf533abc96965, 0xbd9bf533abc96965, +] )) ), + +################ chunk 4096 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40ff7254c7df8dad, 0x40ff7254c7df8dac, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff9999e0933833, + 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, + 0x40ffad3c6ced0d76, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, + 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, + 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x410007b495571be3, 0x410007b495571be3, 0x410007b495571be3, + 0x410007b495571be3, 0x410007b495571be3, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001b5721b0f126, + 0x41001b5721b0f126, 0x41001b5721b0f126, 0x41001b5721b0f126, 0x41001b5721b0f126, 0x4100252867dddbc8, 0x4100252867dddbc8, 0x4100252867dddbc8, 0x4100252867dddbc8, + 0x4100252867dddbc8, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x410038caf437b10b, 0x410038caf437b10b, + 0x410038caf437b10b, 0x410038caf437b10b, 0x410038caf437b10b, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, + 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x4100563ec6be70f0, 0x4100563ec6be70f0, 0x4100563ec6be70f0, + 0x4100563ec6be70f0, 0x4100563ec6be70f0, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410069e153184633, + 0x410069e153184633, 0x410069e153184633, 0x410069e153184633, 0x410069e153184633, 0x410073b2994530d5, 0x410073b2994530d5, 0x410073b2994530d5, 0x410073b2994530d5, + 0x410073b2994530d5, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b76, 0x41008755259f0618, 0x41008755259f0618, + 0x41008755259f0618, 0x41008755259f0618, 0x41008755259f0618, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, + 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, + 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100b86b847f9b40, + 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, + 0x4100c23ccaac85e2, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100d5df57065b25, 0x4100d5df57065b25, + 0x4100d5df57065b25, 0x4100d5df57065b25, 0x4100d5df57065b25, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, + 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100f353298d1b0a, 0x4100f353298d1b0a, 0x4100f353298d1b0a, + 0x4100f353298d1b0a, 0x4100f353298d1b0a, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ab, 0x410106f5b5e6f04d, + 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410110c6fc13daef, 0x410110c6fc13daef, 0x410110c6fc13daef, 0x410110c6fc13daef, + 0x410110c6fc13daef, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41012469886db032, 0x41012469886db032, + 0x41012469886db032, 0x41012469886db032, 0x41012469886db032, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, + 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x410141dd5af47017, 0x410141dd5af47017, 0x410141dd5af47017, + 0x410141dd5af47017, 0x410141dd5af47017, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x4101557fe74e455a, + 0x4101557fe74e455a, 0x4101557fe74e455a, 0x4101557fe74e455a, 0x4101557fe74e455a, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, + 0x41015f512d7b2ffc, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x410172f3b9d5053f, 0x410172f3b9d5053f, + 0x410172f3b9d5053f, 0x410172f3b9d5053f, 0x410172f3b9d5053f, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe0, + 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x410190678c5bc524, 0x410190678c5bc524, 0x410190678c5bc524, + 0x410190678c5bc524, 0x410190678c5bc524, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x4101a40a18b59a67, + 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101addb5ee28509, 0x4101addb5ee28509, 0x4101addb5ee28509, 0x4101addb5ee28509, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3da205662a1b4b4d, 0xbd9bf533abc96965, 0x3d954d02865eaeb3, 0x3d954d02865eaeb3, 0x3d954d02865eaeb3, 0x3d954d02865eaeb3, 0x3d954d02865eaeb3, 0x3d7a3ce2e21b1b2b, + 0x3d7a3ce2e21b1b2b, 0x3d7a3ce2e21b1b2b, 0x3d7a3ce2e21b1b2b, 0x3d7a3ce2e21b1b2b, 0xbd805d222aa2423a, 0xbd805d222aa2423a, 0xbd805d222aa2423a, 0xbd805d222aa2423a, + 0xbd805d222aa2423a, 0xbd96ec5ae3290905, 0xbd96ec5ae3290905, 0xbd96ec5ae3290905, 0xbd96ec5ae3290905, 0xbd96ec5ae3290905, 0x3d9a55db4eff0f13, 0x3d9a55db4eff0f13, + 0x3d9a55db4eff0f13, 0x3d9a55db4eff0f13, 0x3d9a55db4eff0f13, 0x3d873023024e4e57, 0x3d873023024e4e57, 0x3d873023024e4e57, 0x3d873023024e4e57, 0x3d873023024e4e57, + 0xbd692dc2658605e5, 0xbd692dc2658605e5, 0xbd692dc2658605e5, 0xbd692dc2658605e5, 0xbd692dc2658605e5, 0xbd91e3821a88a8a5, 0xbd91e3821a88a8a5, 0xbd91e3821a88a8a5, + 0xbd91e3821a88a8a5, 0xbd91e3821a88a8a5, 0x3d9f5eb4179f6f74, 0x3d9f5eb4179f6f74, 0x3d9f5eb4179f6f74, 0x3d9f5eb4179f6f74, 0x3d9f5eb4179f6f74, 0xbda7af8adb1c3c3a, + 0xbda7af8adb1c3c3a, 0xbda7af8adb1c3c3a, 0xbda7af8adb1c3c3a, 0xbda7af8adb1c3c3a, 0x3d5e3207bef9fa3d, 0x3d5e3207bef9fa3d, 0x3d5e3207bef9fa3d, 0x3d5e3207bef9fa3d, + 0x3d5e3207bef9fa3d, 0x3da992ab570bdbde, 0x3da992ab570bdbde, 0x3da992ab570bdbde, 0x3da992ab570bdbde, 0x3da992ab570bdbde, 0xbd9b98731fc0302c, 0xbd9b98731fc0302c, + 0xbd9b98731fc0302c, 0xbd9b98731fc0302c, 0xbd9b98731fc0302c, 0x3d95a9c31267e7ec, 0x3d95a9c31267e7ec, 0x3d95a9c31267e7ec, 0x3d95a9c31267e7ec, 0x3d95a9c31267e7ec, + 0xbdac8a035db7fffe, 0xbdac8a035db7fffe, 0xbdac8a035db7fffe, 0xbdac8a035db7fffe, 0xbdac8a035db7fffe, 0xbd7f4742251f9f8f, 0xbd7f4742251f9f8f, 0xbd7f4742251f9f8f, + 0xbd7f4742251f9f8f, 0xbd7f4742251f9f8f, 0x3da4b832d470181a, 0x3da4b832d470181a, 0x3da4b832d470181a, 0x3da4b832d470181a, 0x3da4b832d470181a, 0xbda2a6b2127bdbda, + 0xbda2a6b2127bdbda, 0xbda2a6b2127bdbda, 0xbda2a6b2127bdbda, 0xbda2a6b2127bdbda, 0x3d87e9a41a60c0c9, 0x3d87e9a41a60c0c9, 0x3d87e9a41a60c0c9, 0x3d87e9a41a60c0c9, + 0x3d87e9a41a60c0c9, 0x3dae9b841fac3c3e, 0x3dae9b841fac3c3e, 0x3dae9b841fac3c3e, 0x3dae9b841fac3c3e, 0xbdb0b23df029e1e1, 0xbd9186c18e7f6f6b, 0xbd9186c18e7f6f6b, + 0xbd9186c18e7f6f6b, 0xbd9186c18e7f6f6b, 0xbd9186c18e7f6f6b, 0x3d9fbb74a3a8a8ad, 0x3d9fbb74a3a8a8ad, 0x3d9fbb74a3a8a8ad, 0x3d9fbb74a3a8a8ad, 0x3d9fbb74a3a8a8ad, + 0xbda7812a95179f9d, 0xbda7812a95179f9d, 0xbda7812a95179f9d, 0xbda7812a95179f9d, 0xbda7812a95179f9d, 0x3d61ff083fc6c6e9, 0x3d61ff083fc6c6e9, 0x3d61ff083fc6c6e9, + 0x3d61ff083fc6c6e9, 0x3d61ff083fc6c6e9, 0x3da9c10b9d10787b, 0x3da9c10b9d10787b, 0x3da9c10b9d10787b, 0x3da9c10b9d10787b, 0x3da9c10b9d10787b, 0xbd9b3bb293b6f6f3, + 0xbd9b3bb293b6f6f3, 0xbd9b3bb293b6f6f3, 0xbd9b3bb293b6f6f3, 0xbd9b3bb293b6f6f3, 0x3d9606839e712125, 0x3d9606839e712125, 0x3d9606839e712125, 0x3d9606839e712125, + 0x3d9606839e712125, 0xbdac5ba317b36361, 0xbdac5ba317b36361, 0xbdac5ba317b36361, 0xbdac5ba317b36361, 0xbdac5ba317b36361, 0xbd7dd43ff4fabaa9, 0xbd7dd43ff4fabaa9, + 0xbd7dd43ff4fabaa9, 0xbd7dd43ff4fabaa9, 0xbd7dd43ff4fabaa9, 0x3da4e6931a74b4b7, 0x3da4e6931a74b4b7, 0x3da4e6931a74b4b7, 0x3da4e6931a74b4b7, 0x3da4e6931a74b4b7, + 0xbda27851cc773f3d, 0xbda27851cc773f3d, 0xbda27851cc773f3d, 0xbda27851cc773f3d, 0xbda27851cc773f3d, 0x3d88a3253273333c, 0x3d88a3253273333c, 0x3d88a3253273333c, + 0x3d88a3253273333c, 0x3d88a3253273333c, 0x3daec9e465b0d8db, 0x3daec9e465b0d8db, 0x3daec9e465b0d8db, 0x3daec9e465b0d8db, 0xbdb09b0dcd279392, 0xbd912a0102763632, + 0xbd912a0102763632, 0xbd912a0102763632, 0xbd912a0102763632, 0xbd912a0102763632, 0x3da00c1a97d8f0f3, 0x3da00c1a97d8f0f3, 0x3da00c1a97d8f0f3, 0x3da00c1a97d8f0f3, + 0x3da00c1a97d8f0f3, 0xbda752ca4f130301, 0xbda752ca4f130301, 0xbda752ca4f130301, 0xbda752ca4f130301, 0xbda752ca4f130301, 0x3d64e50ca01090b4, 0x3d64e50ca01090b4, + 0x3d64e50ca01090b4, 0x3d64e50ca01090b4, 0x3d64e50ca01090b4, 0x3da9ef6be3151517, 0x3da9ef6be3151517, 0x3da9ef6be3151517, 0x3da9ef6be3151517, 0x3da9ef6be3151517, + 0xbd9adef207adbdb9, 0xbd9adef207adbdb9, 0xbd9adef207adbdb9, 0xbd9adef207adbdb9, 0xbd9adef207adbdb9, 0x3d9663442a7a5a5f, 0x3d9663442a7a5a5f, 0x3d9663442a7a5a5f, + 0x3d9663442a7a5a5f, 0x3d9663442a7a5a5f, 0xbdac2d42d1aec6c5, 0xbdac2d42d1aec6c5, 0xbdac2d42d1aec6c5, 0xbdac2d42d1aec6c5, 0xbdac2d42d1aec6c5, 0xbd7c613dc4d5d5c4, + 0xbd7c613dc4d5d5c4, 0xbd7c613dc4d5d5c4, 0xbd7c613dc4d5d5c4, 0xbd7c613dc4d5d5c4, 0x3da514f360795154, 0x3da514f360795154, 0x3da514f360795154, 0x3da514f360795154, + 0x3da514f360795154, 0xbda249f18672a2a0, 0xbda249f18672a2a0, 0xbda249f18672a2a0, 0xbda249f18672a2a0, 0xbda249f18672a2a0, 0x3d895ca64a85a5af, 0x3d895ca64a85a5af, + 0x3d895ca64a85a5af, 0x3d895ca64a85a5af, 0x3d895ca64a85a5af, 0x3daef844abb57578, 0x3daef844abb57578, 0x3daef844abb57578, 0x3daef844abb57578, 0xbdb083ddaa254544, + 0xbd90cd40766cfcf8, 0xbd90cd40766cfcf8, 0xbd90cd40766cfcf8, 0xbd90cd40766cfcf8, 0xbd90cd40766cfcf8, 0x3da03a7adddd8d90, 0x3da03a7adddd8d90, 0x3da03a7adddd8d90, + 0x3da03a7adddd8d90, 0x3da03a7adddd8d90, 0xbda7246a090e6664, 0xbda7246a090e6664, 0xbda7246a090e6664, 0xbda7246a090e6664, 0xbda7246a090e6664, 0x3d67cb11005a5a7f, + 0x3d67cb11005a5a7f, 0x3d67cb11005a5a7f, 0x3d67cb11005a5a7f, 0x3d67cb11005a5a7f, 0x3daa1dcc2919b1b4, 0x3daa1dcc2919b1b4, 0x3daa1dcc2919b1b4, 0x3daa1dcc2919b1b4, +] )) ), + +################ chunk 4608 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4101addb5ee28509, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, + 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, + 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101def1bdc31a31, 0x4101def1bdc31a31, 0x4101def1bdc31a31, + 0x4101def1bdc31a31, 0x4101def1bdc31a31, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101f2944a1cef74, + 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101fc659049da16, 0x4101fc659049da16, 0x4101fc659049da16, 0x4101fc659049da16, + 0x4101fc659049da15, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x410210081ca3af59, 0x410210081ca3af59, + 0x410210081ca3af59, 0x410210081ca3af59, 0x410210081ca3af59, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, + 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, + 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102411e7b844481, + 0x4102411e7b844481, 0x4102411e7b844481, 0x4102411e7b844481, 0x4102411e7b844481, 0x41024aefc1b12f22, 0x41024aefc1b12f22, 0x41024aefc1b12f22, 0x41024aefc1b12f22, + 0x41024aefc1b12f22, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x41025e924e0b0466, 0x41025e924e0b0466, + 0x41025e924e0b0466, 0x41025e924e0b0466, 0x41025e924e0b0466, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, + 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027c062091c44b, 0x41027c062091c44b, 0x41027c062091c44b, + 0x41027c062091c44b, 0x41027c062091c44a, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x41028fa8aceb998e, + 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41029979f318842f, 0x41029979f318842f, 0x41029979f318842f, 0x41029979f318842f, + 0x41029979f318842f, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102ad1c7f725973, 0x4102ad1c7f725973, + 0x4102ad1c7f725973, 0x4102ad1c7f725973, 0x4102ad1c7f725973, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, + 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102ca9051f91957, 0x4102ca9051f91957, 0x4102ca9051f91957, + 0x4102ca9051f91957, 0x4102ca9051f91957, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102de32de52ee9b, + 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102e804247fd93c, 0x4102e804247fd93c, 0x4102e804247fd93c, 0x4102e804247fd93c, + 0x4102e804247fd93c, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae80, + 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae7f, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, + 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x4103191a83606e64, 0x4103191a83606e64, 0x4103191a83606e64, + 0x4103191a83606e64, 0x4103191a83606e64, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x41032cbd0fba43a8, + 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x4103368e55e72e49, 0x4103368e55e72e49, 0x4103368e55e72e49, 0x4103368e55e72e49, + 0x4103368e55e72e49, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x41034a30e241038c, 0x41034a30e241038c, + 0x41034a30e241038c, 0x41034a30e241038c, 0x41034a30e241038c, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, + 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x410367a4b4c7c371, 0x410367a4b4c7c371, 0x410367a4b4c7c371, + 0x410367a4b4c7c371, 0x410367a4b4c7c371, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037b47412198b5, + 0x41037b47412198b5, 0x41037b47412198b5, 0x41037b47412198b5, 0x41037b47412198b4, 0x41038518874e8356, 0x41038518874e8356, 0x41038518874e8356, 0x41038518874e8356, + 0x41038518874e8356, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x410398bb13a85899, 0x410398bb13a85899, + 0x410398bb13a85899, 0x410398bb13a85899, 0x410398bb13a85899, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3daa1dcc2919b1b4, 0xbd9a82317ba48480, 0xbd9a82317ba48480, 0xbd9a82317ba48480, 0xbd9a82317ba48480, 0xbd9a82317ba48480, 0x3d96c004b6839398, 0x3d96c004b6839398, + 0x3d96c004b6839398, 0x3d96c004b6839398, 0x3d96c004b6839398, 0xbdabfee28baa2a28, 0xbdabfee28baa2a28, 0xbdabfee28baa2a28, 0xbdabfee28baa2a28, 0xbdabfee28baa2a28, + 0xbd7aee3b94b0f0df, 0xbd7aee3b94b0f0df, 0xbd7aee3b94b0f0df, 0xbd7aee3b94b0f0df, 0xbd7aee3b94b0f0df, 0x3da54353a67dedf0, 0x3da54353a67dedf0, 0x3da54353a67dedf0, + 0x3da54353a67dedf0, 0x3da54353a67dedf0, 0xbda21b91406e0604, 0xbda21b91406e0604, 0xbda21b91406e0604, 0xbda21b91406e0604, 0xbda21b91406e0604, 0x3d8a162762981821, + 0x3d8a162762981821, 0x3d8a162762981821, 0x3d8a162762981821, 0x3d8a162762981821, 0x3daf26a4f1ba1214, 0x3daf26a4f1ba1214, 0x3daf26a4f1ba1214, 0x3daf26a4f1ba1214, + 0xbdb06cad8722f6f6, 0xbd90707fea63c3bf, 0xbd90707fea63c3bf, 0xbd90707fea63c3bf, 0xbd90707fea63c3bf, 0xbd90707fea63c3bf, 0x3da068db23e22a2c, 0x3da068db23e22a2c, + 0x3da068db23e22a2c, 0x3da068db23e22a2c, 0x3da068db23e22a2c, 0xbda6f609c309c9c7, 0xbda6f609c309c9c7, 0xbda6f609c309c9c7, 0xbda6f609c309c9c7, 0xbda6f609c309c9c7, + 0x3d6ab11560a4244a, 0x3d6ab11560a4244a, 0x3d6ab11560a4244a, 0x3d6ab11560a4244a, 0x3d6ab11560a4244a, 0x3daa4c2c6f1e4e51, 0x3daa4c2c6f1e4e51, 0x3daa4c2c6f1e4e51, + 0x3daa4c2c6f1e4e51, 0x3daa4c2c6f1e4e51, 0xbd9a2570ef9b4b47, 0xbd9a2570ef9b4b47, 0xbd9a2570ef9b4b47, 0xbd9a2570ef9b4b47, 0xbd9a2570ef9b4b47, 0x3d971cc5428cccd2, + 0x3d971cc5428cccd2, 0x3d971cc5428cccd2, 0x3d971cc5428cccd2, 0x3d971cc5428cccd2, 0xbdabd08245a58d8b, 0xbdabd08245a58d8b, 0xbdabd08245a58d8b, 0xbdabd08245a58d8b, + 0xbdabd08245a58d8b, 0xbd797b39648c0bf9, 0xbd797b39648c0bf9, 0xbd797b39648c0bf9, 0xbd797b39648c0bf9, 0xbd797b39648c0bf9, 0x3da571b3ec828a8d, 0x3da571b3ec828a8d, + 0x3da571b3ec828a8d, 0x3da571b3ec828a8d, 0x3da571b3ec828a8d, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, + 0x3d8acfa87aaa8a94, 0x3d8acfa87aaa8a94, 0x3d8acfa87aaa8a94, 0x3d8acfa87aaa8a94, 0x3d8acfa87aaa8a94, 0x3daf550537beaeb1, 0x3daf550537beaeb1, 0x3daf550537beaeb1, + 0x3daf550537beaeb1, 0xbdb0557d6420a8a7, 0xbd9013bf5e5a8a86, 0xbd9013bf5e5a8a86, 0xbd9013bf5e5a8a86, 0xbd9013bf5e5a8a86, 0xbd9013bf5e5a8a86, 0x3da0973b69e6c6c9, + 0x3da0973b69e6c6c9, 0x3da0973b69e6c6c9, 0x3da0973b69e6c6c9, 0x3da0973b69e6c6c9, 0xbda6c7a97d052d2b, 0xbda6c7a97d052d2b, 0xbda6c7a97d052d2b, 0xbda6c7a97d052d2b, + 0xbda6c7a97d052d2b, 0x3d6d9719c0edee14, 0x3d6d9719c0edee14, 0x3d6d9719c0edee14, 0x3d6d9719c0edee14, 0x3d6d9719c0edee14, 0x3daa7a8cb522eaed, 0x3daa7a8cb522eaed, + 0x3daa7a8cb522eaed, 0x3daa7a8cb522eaed, 0x3daa7a8cb522eaed, 0xbd99c8b06392120d, 0xbd99c8b06392120d, 0xbd99c8b06392120d, 0xbd99c8b06392120d, 0xbd99c8b06392120d, + 0x3d977985ce96060b, 0x3d977985ce96060b, 0x3d977985ce96060b, 0x3d977985ce96060b, 0x3d977985ce96060b, 0xbdaba221ffa0f0ef, 0xbdaba221ffa0f0ef, 0xbdaba221ffa0f0ef, + 0xbdaba221ffa0f0ef, 0xbdaba221ffa0f0ef, 0xbd78083734672714, 0xbd78083734672714, 0xbd78083734672714, 0xbd78083734672714, 0xbd78083734672714, 0x3da5a0143287272a, + 0x3da5a0143287272a, 0x3da5a0143287272a, 0x3da5a0143287272a, 0x3da5a0143287272a, 0xbda1bed0b464ccca, 0xbda1bed0b464ccca, 0xbda1bed0b464ccca, 0xbda1bed0b464ccca, + 0xbda1bed0b464ccca, 0x3d8b892992bcfd07, 0x3d8b892992bcfd07, 0x3d8b892992bcfd07, 0x3d8b892992bcfd07, 0x3d8b892992bcfd07, 0x3daf83657dc34b4e, 0x3daf83657dc34b4e, + 0x3daf83657dc34b4e, 0x3daf83657dc34b4e, 0xbdb03e4d411e5a59, 0xbd8f6dfda4a2a299, 0xbd8f6dfda4a2a299, 0xbd8f6dfda4a2a299, 0xbd8f6dfda4a2a299, 0xbd8f6dfda4a2a299, + 0x3da0c59bafeb6366, 0x3da0c59bafeb6366, 0x3da0c59bafeb6366, 0x3da0c59bafeb6366, 0x3da0c59bafeb6366, 0xbda699493700908e, 0xbda699493700908e, 0xbda699493700908e, + 0xbda699493700908e, 0xbda699493700908e, 0x3d703e8f109bdbf0, 0x3d703e8f109bdbf0, 0x3d703e8f109bdbf0, 0x3d703e8f109bdbf0, 0x3d703e8f109bdbf0, 0x3daaa8ecfb27878a, + 0x3daaa8ecfb27878a, 0x3daaa8ecfb27878a, 0x3daaa8ecfb27878a, 0x3daaa8ecfb27878a, 0xbd996befd788d8d4, 0xbd996befd788d8d4, 0xbd996befd788d8d4, 0xbd996befd788d8d4, + 0xbd996befd788d8d4, 0x3d97d6465a9f3f44, 0x3d97d6465a9f3f44, 0x3d97d6465a9f3f44, 0x3d97d6465a9f3f44, 0x3d97d6465a9f3f44, 0xbdab73c1b99c5452, 0xbdab73c1b99c5452, + 0xbdab73c1b99c5452, 0xbdab73c1b99c5452, 0xbdab73c1b99c5452, 0xbd7695350442422e, 0xbd7695350442422e, 0xbd7695350442422e, 0xbd7695350442422e, 0xbd7695350442422e, + 0x3da5ce74788bc3c6, 0x3da5ce74788bc3c6, 0x3da5ce74788bc3c6, 0x3da5ce74788bc3c6, 0x3da5ce74788bc3c6, 0xbda190706e60302e, 0xbda190706e60302e, 0xbda190706e60302e, + 0xbda190706e60302e, 0xbda190706e60302e, 0x3d8c42aaaacf6f79, 0x3d8c42aaaacf6f79, 0x3d8c42aaaacf6f79, 0x3d8c42aaaacf6f79, 0x3d8c42aaaacf6f79, 0x3dafb1c5c3c7e7ea, + 0x3dafb1c5c3c7e7ea, 0x3dafb1c5c3c7e7ea, 0x3dafb1c5c3c7e7ea, 0xbdb0271d1e1c0c0b, 0xbd8eb47c8c903026, 0xbd8eb47c8c903026, 0xbd8eb47c8c903026, 0xbd8eb47c8c903026, + 0xbd8eb47c8c903026, 0x3da0f3fbf5f00003, 0x3da0f3fbf5f00003, 0x3da0f3fbf5f00003, 0x3da0f3fbf5f00003, 0x3da0f3fbf5f00003, 0xbda66ae8f0fbf3f1, 0xbda66ae8f0fbf3f1, + 0xbda66ae8f0fbf3f1, 0xbda66ae8f0fbf3f1, 0xbda66ae8f0fbf3f1, 0x3d71b19140c0c0d5, 0x3d71b19140c0c0d5, 0x3d71b19140c0c0d5, 0x3d71b19140c0c0d5, 0x3d71b19140c0c0d5, +] )) ), + +################ chunk 5120 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103b62ee62f187e, 0x4103b62ee62f187e, 0x4103b62ee62f187e, + 0x4103b62ee62f187e, 0x4103b62ee62f187e, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c9d17288edc1, + 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, + 0x4103d3a2b8b5d863, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103e745450fada6, 0x4103e745450fada6, + 0x4103e745450fada6, 0x4103e745450fada6, 0x4103e745450fada6, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, + 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982e9, 0x410404b917966d8b, 0x410404b917966d8b, 0x410404b917966d8b, + 0x410404b917966d8b, 0x410404b917966d8b, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x4104185ba3f042ce, + 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104222cea1d2d70, 0x4104222cea1d2d70, 0x4104222cea1d2d70, 0x4104222cea1d2d70, + 0x4104222cea1d2d70, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x410435cf767702b3, 0x410435cf767702b3, + 0x410435cf767702b3, 0x410435cf767702b3, 0x410435cf767702b3, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, + 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104534348fdc298, 0x4104534348fdc298, 0x4104534348fdc298, + 0x4104534348fdc298, 0x4104534348fdc298, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x410466e5d55797db, + 0x410466e5d55797db, 0x410466e5d55797db, 0x410466e5d55797db, 0x410466e5d55797db, 0x410470b71b84827d, 0x410470b71b84827d, 0x410470b71b84827d, 0x410470b71b84827d, + 0x410470b71b84827d, 0x41047a8861b16d1e, 0x41047a8861b16d1e, 0x41047a8861b16d1e, 0x41047a8861b16d1f, 0x41047a8861b16d1e, 0x41048459a7de57c0, 0x41048459a7de57c0, + 0x41048459a7de57c0, 0x41048459a7de57c0, 0x41048459a7de57c0, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, + 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, + 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104b57006beece8, + 0x4104b57006beece8, 0x4104b57006beece8, 0x4104b57006beece8, 0x4104b57006beece8, 0x4104bf414cebd78a, 0x4104bf414cebd78a, 0x4104bf414cebd78a, 0x4104bf414cebd78a, + 0x4104bf414cebd78a, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104d2e3d945accd, 0x4104d2e3d945accd, + 0x4104d2e3d945accd, 0x4104d2e3d945accd, 0x4104d2e3d945accd, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, + 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, + 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, 0x4104fa28f1f95753, 0x4104fa28f1f95753, 0x4104fa28f1f95753, 0x4104fa28f1f95754, 0x4104fa28f1f95753, 0x410503fa382641f5, + 0x410503fa382641f5, 0x410503fa382641f5, 0x410503fa382641f5, 0x410503fa382641f5, 0x41050dcb7e532c97, 0x41050dcb7e532c97, 0x41050dcb7e532c97, 0x41050dcb7e532c97, + 0x41050dcb7e532c97, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105216e0aad01da, 0x4105216e0aad01da, + 0x4105216e0aad01da, 0x4105216e0aad01da, 0x4105216e0aad01da, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, + 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, + 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x41055284698d9702, + 0x41055284698d9702, 0x41055284698d9702, 0x41055284698d9702, 0x41055284698d9702, 0x41055c55afba81a4, 0x41055c55afba81a4, 0x41055c55afba81a4, 0x41055c55afba81a4, + 0x41055c55afba81a4, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056ff83c1456e7, 0x41056ff83c1456e7, + 0x41056ff83c1456e7, 0x41056ff83c1456e7, 0x41056ff83c1456e7, 0x410579c982414188, 0x410579c982414188, 0x410579c982414188, 0x410579c982414189, 0x410579c982414188, + 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, + 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105a10e9af4ec0f, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3daad74d412c2427, 0x3daad74d412c2427, 0x3daad74d412c2427, 0x3daad74d412c2427, 0x3daad74d412c2427, 0xbd990f2f4b7f9f9b, 0xbd990f2f4b7f9f9b, 0xbd990f2f4b7f9f9b, + 0xbd990f2f4b7f9f9b, 0xbd990f2f4b7f9f9b, 0x3d983306e6a8787e, 0x3d983306e6a8787e, 0x3d983306e6a8787e, 0x3d983306e6a8787e, 0x3d983306e6a8787e, 0xbdab45617397b7b5, + 0xbdab45617397b7b5, 0xbdab45617397b7b5, 0xbdab45617397b7b5, 0xbdab45617397b7b5, 0xbd752232d41d5d49, 0xbd752232d41d5d49, 0xbd752232d41d5d49, 0xbd752232d41d5d49, + 0xbd752232d41d5d49, 0x3da5fcd4be906063, 0x3da5fcd4be906063, 0x3da5fcd4be906063, 0x3da5fcd4be906063, 0x3da5fcd4be906063, 0xbda16210285b9391, 0xbda16210285b9391, + 0xbda16210285b9391, 0xbda16210285b9391, 0xbda16210285b9391, 0x3d8cfc2bc2e1e1ec, 0x3d8cfc2bc2e1e1ec, 0x3d8cfc2bc2e1e1ec, 0x3d8cfc2bc2e1e1ec, 0x3d8cfc2bc2e1e1ec, + 0x3dafe02609cc8487, 0x3dafe02609cc8487, 0x3dafe02609cc8487, 0x3dafe02609cc8487, 0xbdb00fecfb19bdbc, 0xbd8dfafb747dbdb3, 0xbd8dfafb747dbdb3, 0xbd8dfafb747dbdb3, + 0xbd8dfafb747dbdb3, 0xbd8dfafb747dbdb3, 0x3da1225c3bf49c9f, 0x3da1225c3bf49c9f, 0x3da1225c3bf49c9f, 0x3da1225c3bf49c9f, 0x3da1225c3bf49c9f, 0xbda63c88aaf75755, + 0xbda63c88aaf75755, 0xbda63c88aaf75755, 0xbda63c88aaf75755, 0xbda63c88aaf75755, 0x3d73249370e5a5ba, 0x3d73249370e5a5ba, 0x3d73249370e5a5ba, 0x3d73249370e5a5ba, + 0x3d73249370e5a5ba, 0x3dab05ad8730c0c3, 0x3dab05ad8730c0c3, 0x3dab05ad8730c0c3, 0x3dab05ad8730c0c3, 0x3dab05ad8730c0c3, 0xbd98b26ebf766661, 0xbd98b26ebf766661, + 0xbd98b26ebf766661, 0xbd98b26ebf766661, 0xbd98b26ebf766661, 0x3d988fc772b1b1b7, 0x3d988fc772b1b1b7, 0x3d988fc772b1b1b7, 0x3d988fc772b1b1b7, 0x3d988fc772b1b1b7, + 0xbdab17012d931b18, 0xbdab17012d931b18, 0xbdab17012d931b18, 0xbdab17012d931b18, 0xbdab17012d931b18, 0xbd73af30a3f87864, 0xbd73af30a3f87864, 0xbd73af30a3f87864, + 0xbd73af30a3f87864, 0xbd73af30a3f87864, 0x3da62b350494fd00, 0x3da62b350494fd00, 0x3da62b350494fd00, 0x3da62b350494fd00, 0x3da62b350494fd00, 0xbda133afe256f6f4, + 0xbda133afe256f6f4, 0xbda133afe256f6f4, 0xbda133afe256f6f4, 0xbda133afe256f6f4, 0x3d8db5acdaf4545f, 0x3d8db5acdaf4545f, 0x3d8db5acdaf4545f, 0x3d8db5acdaf4545f, + 0x3d8db5acdaf4545f, 0xbdaff179b02ededc, 0xbdaff179b02ededc, 0xbdaff179b02ededc, 0x3db0074327e89092, 0xbdaff179b02ededc, 0xbd8d417a5c6b4b41, 0xbd8d417a5c6b4b41, + 0xbd8d417a5c6b4b41, 0xbd8d417a5c6b4b41, 0xbd8d417a5c6b4b41, 0x3da150bc81f9393c, 0x3da150bc81f9393c, 0x3da150bc81f9393c, 0x3da150bc81f9393c, 0x3da150bc81f9393c, + 0xbda60e2864f2bab8, 0xbda60e2864f2bab8, 0xbda60e2864f2bab8, 0xbda60e2864f2bab8, 0xbda60e2864f2bab8, 0x3d749795a10a8aa0, 0x3d749795a10a8aa0, 0x3d749795a10a8aa0, + 0x3d749795a10a8aa0, 0x3d749795a10a8aa0, 0x3dab340dcd355d60, 0x3dab340dcd355d60, 0x3dab340dcd355d60, 0x3dab340dcd355d60, 0x3dab340dcd355d60, 0xbd9855ae336d2d28, + 0xbd9855ae336d2d28, 0xbd9855ae336d2d28, 0xbd9855ae336d2d28, 0xbd9855ae336d2d28, 0x3d98ec87febaeaf0, 0x3d98ec87febaeaf0, 0x3d98ec87febaeaf0, 0x3d98ec87febaeaf0, + 0x3d98ec87febaeaf0, 0xbdaae8a0e78e7e7c, 0xbdaae8a0e78e7e7c, 0xbdaae8a0e78e7e7c, 0xbdaae8a0e78e7e7c, 0xbdaae8a0e78e7e7c, 0xbd723c2e73d3937e, 0xbd723c2e73d3937e, + 0xbd723c2e73d3937e, 0xbd723c2e73d3937e, 0xbd723c2e73d3937e, 0x3da659954a99999c, 0x3da659954a99999c, 0x3da659954a99999c, 0x3da659954a99999c, 0x3da659954a99999c, + 0xbda1054f9c525a58, 0xbda1054f9c525a58, 0xbda1054f9c525a58, 0xbda1054f9c525a58, 0xbda1054f9c525a58, 0x3d8e6f2df306c6d2, 0x3d8e6f2df306c6d2, 0x3d8e6f2df306c6d2, + 0x3d8e6f2df306c6d2, 0x3d8e6f2df306c6d2, 0xbdafc3196a2a4240, 0xbdafc3196a2a4240, 0xbdafc3196a2a4240, 0x3db01e734aeadee0, 0xbdafc3196a2a4240, 0xbd8c87f94458d8ce, + 0xbd8c87f94458d8ce, 0xbd8c87f94458d8ce, 0xbd8c87f94458d8ce, 0xbd8c87f94458d8ce, 0x3da17f1cc7fdd5d9, 0x3da17f1cc7fdd5d9, 0x3da17f1cc7fdd5d9, 0x3da17f1cc7fdd5d9, + 0x3da17f1cc7fdd5d9, 0xbda5dfc81eee1e1b, 0xbda5dfc81eee1e1b, 0xbda5dfc81eee1e1b, 0xbda5dfc81eee1e1b, 0xbda5dfc81eee1e1b, 0x3d760a97d12f6f85, 0x3d760a97d12f6f85, + 0x3d760a97d12f6f85, 0x3d760a97d12f6f85, 0x3d760a97d12f6f85, 0x3dab626e1339f9fd, 0x3dab626e1339f9fd, 0x3dab626e1339f9fd, 0x3dab626e1339f9fd, 0x3dab626e1339f9fd, + 0xbd97f8eda763f3ee, 0xbd97f8eda763f3ee, 0xbd97f8eda763f3ee, 0xbd97f8eda763f3ee, 0xbd97f8eda763f3ee, 0x3d9949488ac4242a, 0x3d9949488ac4242a, 0x3d9949488ac4242a, + 0x3d9949488ac4242a, 0x3d9949488ac4242a, 0xbdaaba40a189e1df, 0xbdaaba40a189e1df, 0xbdaaba40a189e1df, 0xbdaaba40a189e1df, 0xbdaaba40a189e1df, 0xbd70c92c43aeae99, + 0xbd70c92c43aeae99, 0xbd70c92c43aeae99, 0xbd70c92c43aeae99, 0xbd70c92c43aeae99, 0x3da687f5909e3639, 0x3da687f5909e3639, 0x3da687f5909e3639, 0x3da687f5909e3639, + 0x3da687f5909e3639, 0xbda0d6ef564dbdbb, 0xbda0d6ef564dbdbb, 0xbda0d6ef564dbdbb, 0xbda0d6ef564dbdbb, 0xbda0d6ef564dbdbb, 0x3d8f28af0b193944, 0x3d8f28af0b193944, + 0x3d8f28af0b193944, 0x3d8f28af0b193944, 0x3d8f28af0b193944, 0xbdaf94b92425a5a3, 0xbdaf94b92425a5a3, 0xbdaf94b92425a5a3, 0x3db035a36ded2d2f, 0xbdaf94b92425a5a3, + 0xbd8bce782c46665b, 0xbd8bce782c46665b, 0xbd8bce782c46665b, 0xbd8bce782c46665b, 0xbd8bce782c46665b, 0x3da1ad7d0e027275, 0x3da1ad7d0e027275, 0x3da1ad7d0e027275, + 0x3da1ad7d0e027275, 0x3da1ad7d0e027275, 0xbda5b167d8e9817f, 0xbda5b167d8e9817f, 0xbda5b167d8e9817f, 0xbda5b167d8e9817f, 0xbda5b167d8e9817f, 0x3d777d9a0154546b, +] )) ), + +################ chunk 5632 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, + 0x4105aadfe121d6b1, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105be826d7babf4, 0x4105be826d7babf4, + 0x4105be826d7babf4, 0x4105be826d7babf4, 0x4105be826d7babf4, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, + 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105dbf640026bd9, 0x4105dbf640026bd9, 0x4105dbf640026bd9, + 0x4105dbf640026bd9, 0x4105dbf640026bd9, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105ef98cc5c411c, + 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105f96a12892bbd, 0x4105f96a12892bbd, 0x4105f96a12892bbd, 0x4105f96a12892bbe, + 0x4105f96a12892bbd, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x41060d0c9ee30101, 0x41060d0c9ee30101, + 0x41060d0c9ee30101, 0x41060d0c9ee30101, 0x41060d0c9ee30101, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, + 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x41062a807169c0e6, 0x41062a807169c0e6, 0x41062a807169c0e6, + 0x41062a807169c0e6, 0x41062a807169c0e6, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063e22fdc39629, + 0x41063e22fdc39629, 0x41063e22fdc39629, 0x41063e22fdc39629, 0x41063e22fdc39629, 0x410647f443f080ca, 0x410647f443f080ca, 0x410647f443f080ca, 0x410647f443f080ca, + 0x410647f443f080ca, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x41065b96d04a560e, 0x41065b96d04a560e, + 0x41065b96d04a560e, 0x41065b96d04a560e, 0x41065b96d04a560e, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, + 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x4106790aa2d115f2, 0x4106790aa2d115f2, 0x4106790aa2d115f2, + 0x4106790aa2d115f3, 0x4106790aa2d115f2, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x41068cad2f2aeb36, + 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x4106967e7557d5d7, 0x4106967e7557d5d7, 0x4106967e7557d5d7, 0x4106967e7557d5d7, + 0x4106967e7557d5d7, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, + 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, + 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106c794d4386aff, 0x4106c794d4386aff, 0x4106c794d4386aff, + 0x4106c794d4386aff, 0x4106c794d4386aff, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106db3760924043, + 0x4106db3760924043, 0x4106db3760924043, 0x4106db3760924043, 0x4106db3760924043, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, + 0x4106e508a6bf2ae4, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106f8ab33190027, 0x4106f8ab33190027, + 0x4106f8ab33190027, 0x4106f8ab33190028, 0x4106f8ab33190027, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, + 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x4107161f059fc00c, 0x4107161f059fc00c, 0x4107161f059fc00c, + 0x4107161f059fc00c, 0x4107161f059fc00c, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x410729c191f99550, + 0x410729c191f99550, 0x410729c191f99550, 0x410729c191f99550, 0x410729c191f99550, 0x41073392d8267ff1, 0x41073392d8267ff1, 0x41073392d8267ff1, 0x41073392d8267ff1, + 0x41073392d8267ff1, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x4107473564805534, 0x4107473564805534, + 0x4107473564805534, 0x4107473564805534, 0x4107473564805534, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, + 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x410764a937071519, 0x410764a937071519, 0x410764a937071519, + 0x410764a937071519, 0x410764a937071519, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x4107784bc360ea5c, + 0x4107784bc360ea5c, 0x4107784bc360ea5c, 0x4107784bc360ea5d, 0x4107784bc360ea5c, 0x4107821d098dd4fe, 0x4107821d098dd4fe, 0x4107821d098dd4fe, 0x4107821d098dd4fe, + 0x4107821d098dd4fe, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x410795bf95e7aa41, 0x410795bf95e7aa41, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d777d9a0154546b, 0x3d777d9a0154546b, 0x3d777d9a0154546b, 0x3d777d9a0154546b, 0x3dab90ce593e9699, 0x3dab90ce593e9699, 0x3dab90ce593e9699, 0x3dab90ce593e9699, + 0x3dab90ce593e9699, 0xbd979c2d1b5abab5, 0xbd979c2d1b5abab5, 0xbd979c2d1b5abab5, 0xbd979c2d1b5abab5, 0xbd979c2d1b5abab5, 0x3d99a60916cd5d63, 0x3d99a60916cd5d63, + 0x3d99a60916cd5d63, 0x3d99a60916cd5d63, 0x3d99a60916cd5d63, 0xbdaa8be05b854542, 0xbdaa8be05b854542, 0xbdaa8be05b854542, 0xbdaa8be05b854542, 0xbdaa8be05b854542, + 0xbd6eac5427139367, 0xbd6eac5427139367, 0xbd6eac5427139367, 0xbd6eac5427139367, 0xbd6eac5427139367, 0x3da6b655d6a2d2d6, 0x3da6b655d6a2d2d6, 0x3da6b655d6a2d2d6, + 0x3da6b655d6a2d2d6, 0x3da6b655d6a2d2d6, 0xbda0a88f1049211e, 0xbda0a88f1049211e, 0xbda0a88f1049211e, 0xbda0a88f1049211e, 0xbda0a88f1049211e, 0x3d8fe230232babb7, + 0x3d8fe230232babb7, 0x3d8fe230232babb7, 0x3d8fe230232babb7, 0x3d8fe230232babb7, 0xbdaf6658de210906, 0xbdaf6658de210906, 0xbdaf6658de210906, 0x3db04cd390ef7b7d, + 0xbdaf6658de210906, 0xbd8b14f71433f3e9, 0xbd8b14f71433f3e9, 0xbd8b14f71433f3e9, 0xbd8b14f71433f3e9, 0xbd8b14f71433f3e9, 0x3da1dbdd54070f12, 0x3da1dbdd54070f12, + 0x3da1dbdd54070f12, 0x3da1dbdd54070f12, 0x3da1dbdd54070f12, 0xbda5830792e4e4e2, 0xbda5830792e4e4e2, 0xbda5830792e4e4e2, 0xbda5830792e4e4e2, 0xbda5830792e4e4e2, + 0x3d78f09c31793950, 0x3d78f09c31793950, 0x3d78f09c31793950, 0x3d78f09c31793950, 0x3d78f09c31793950, 0x3dabbf2e9f433336, 0x3dabbf2e9f433336, 0x3dabbf2e9f433336, + 0x3dabbf2e9f433336, 0x3dabbf2e9f433336, 0xbd973f6c8f51817c, 0xbd973f6c8f51817c, 0xbd973f6c8f51817c, 0xbd973f6c8f51817c, 0xbd973f6c8f51817c, 0x3d9a02c9a2d6969c, + 0x3d9a02c9a2d6969c, 0x3d9a02c9a2d6969c, 0x3d9a02c9a2d6969c, 0x3d9a02c9a2d6969c, 0xbdaa5d801580a8a6, 0xbdaa5d801580a8a6, 0xbdaa5d801580a8a6, 0xbdaa5d801580a8a6, + 0xbdaa5d801580a8a6, 0xbd6bc64fc6c9c99c, 0xbd6bc64fc6c9c99c, 0xbd6bc64fc6c9c99c, 0xbd6bc64fc6c9c99c, 0xbd6bc64fc6c9c99c, 0x3da6e4b61ca76f72, 0x3da6e4b61ca76f72, + 0x3da6e4b61ca76f72, 0x3da6e4b61ca76f72, 0x3da6e4b61ca76f72, 0xbda07a2eca448482, 0xbda07a2eca448482, 0xbda07a2eca448482, 0xbda07a2eca448482, 0xbda07a2eca448482, + 0x3d904dd89d9f0f15, 0x3d904dd89d9f0f15, 0x3d904dd89d9f0f15, 0x3d904dd89d9f0f15, 0x3d904dd89d9f0f15, 0xbdaf37f8981c6c6a, 0xbdaf37f8981c6c6a, 0xbdaf37f8981c6c6a, + 0x3db06403b3f1c9cb, 0xbdaf37f8981c6c6a, 0xbd8a5b75fc218176, 0xbd8a5b75fc218176, 0xbd8a5b75fc218176, 0xbd8a5b75fc218176, 0xbd8a5b75fc218176, 0x3da20a3d9a0babaf, + 0x3da20a3d9a0babaf, 0x3da20a3d9a0babaf, 0x3da20a3d9a0babaf, 0x3da20a3d9a0babaf, 0xbda554a74ce04845, 0xbda554a74ce04845, 0xbda554a74ce04845, 0xbda554a74ce04845, + 0xbda554a74ce04845, 0x3d7a639e619e1e35, 0x3d7a639e619e1e35, 0x3d7a639e619e1e35, 0x3d7a639e619e1e35, 0x3d7a639e619e1e35, 0x3dabed8ee547cfd3, 0x3dabed8ee547cfd3, + 0x3dabed8ee547cfd3, 0x3dabed8ee547cfd3, 0x3dabed8ee547cfd3, 0xbd96e2ac03484842, 0xbd96e2ac03484842, 0xbd96e2ac03484842, 0xbd96e2ac03484842, 0xbd96e2ac03484842, + 0x3d9a5f8a2edfcfd6, 0x3d9a5f8a2edfcfd6, 0x3d9a5f8a2edfcfd6, 0x3d9a5f8a2edfcfd6, 0x3d9a5f8a2edfcfd6, 0xbdaa2f1fcf7c0c09, 0xbdaa2f1fcf7c0c09, 0xbdaa2f1fcf7c0c09, + 0xbdaa2f1fcf7c0c09, 0xbdaa2f1fcf7c0c09, 0xbd68e04b667fffd1, 0xbd68e04b667fffd1, 0xbd68e04b667fffd1, 0xbd68e04b667fffd1, 0xbd68e04b667fffd1, 0x3da7131662ac0c0f, + 0x3da7131662ac0c0f, 0x3da7131662ac0c0f, 0x3da7131662ac0c0f, 0x3da7131662ac0c0f, 0xbda04bce843fe7e5, 0xbda04bce843fe7e5, 0xbda04bce843fe7e5, 0xbda04bce843fe7e5, + 0xbda04bce843fe7e5, 0x3d90aa9929a8484e, 0x3d90aa9929a8484e, 0x3d90aa9929a8484e, 0x3d90aa9929a8484e, 0x3d90aa9929a8484e, 0xbdaf09985217cfcd, 0xbdaf09985217cfcd, + 0xbdaf09985217cfcd, 0x3db07b33d6f4181a, 0xbdaf09985217cfcd, 0xbd89a1f4e40f0f03, 0xbd89a1f4e40f0f03, 0xbd89a1f4e40f0f03, 0xbd89a1f4e40f0f03, 0xbd89a1f4e40f0f03, + 0x3da2389de010484b, 0x3da2389de010484b, 0x3da2389de010484b, 0x3da2389de010484b, 0x3da2389de010484b, 0xbda5264706dbaba9, 0xbda5264706dbaba9, 0xbda5264706dbaba9, + 0xbda5264706dbaba9, 0xbda5264706dbaba9, 0x3d7bd6a091c3031b, 0x3d7bd6a091c3031b, 0x3d7bd6a091c3031b, 0x3d7bd6a091c3031b, 0x3d7bd6a091c3031b, 0x3dac1bef2b4c6c6f, + 0x3dac1bef2b4c6c6f, 0x3dac1bef2b4c6c6f, 0x3dac1bef2b4c6c6f, 0x3dac1bef2b4c6c6f, 0xbd9685eb773f0f09, 0xbd9685eb773f0f09, 0xbd9685eb773f0f09, 0xbd9685eb773f0f09, + 0xbd9685eb773f0f09, 0x3d9abc4abae9090f, 0x3d9abc4abae9090f, 0x3d9abc4abae9090f, 0x3d9abc4abae9090f, 0x3d9abc4abae9090f, 0xbdaa00bf89776f6c, 0xbdaa00bf89776f6c, + 0xbdaa00bf89776f6c, 0xbdaa00bf89776f6c, 0xbdaa00bf89776f6c, 0xbd65fa4706363606, 0xbd65fa4706363606, 0xbd65fa4706363606, 0xbd65fa4706363606, 0xbd65fa4706363606, + 0x3da74176a8b0a8ac, 0x3da74176a8b0a8ac, 0x3da74176a8b0a8ac, 0x3da74176a8b0a8ac, 0x3da74176a8b0a8ac, 0xbda01d6e3e3b4b48, 0xbda01d6e3e3b4b48, 0xbda01d6e3e3b4b48, + 0xbda01d6e3e3b4b48, 0xbda01d6e3e3b4b48, 0x3d910759b5b18188, 0x3d910759b5b18188, 0x3d910759b5b18188, 0x3d910759b5b18188, 0x3d910759b5b18188, 0xbdaedb380c133330, + 0xbdaedb380c133330, 0xbdaedb380c133330, 0x3db09263f9f66668, 0xbdaedb380c133330, 0xbd88e873cbfc9c90, 0xbd88e873cbfc9c90, 0xbd88e873cbfc9c90, 0xbd88e873cbfc9c90, + 0xbd88e873cbfc9c90, 0x3da266fe2614e4e8, 0x3da266fe2614e4e8, 0x3da266fe2614e4e8, 0x3da266fe2614e4e8, 0x3da266fe2614e4e8, 0xbda4f7e6c0d70f0c, 0xbda4f7e6c0d70f0c, +] )) ), + +################ chunk 6144 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x410795bf95e7aa41, 0x410795bf95e7aa41, 0x410795bf95e7aa41, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, + 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107b333686e6a26, 0x4107b333686e6a26, 0x4107b333686e6a26, + 0x4107b333686e6a26, 0x4107b333686e6a26, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107c6d5f4c83f69, + 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, + 0x4107d0a73af52a0b, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107e449c74eff4e, 0x4107e449c74eff4e, + 0x4107e449c74eff4e, 0x4107e449c74eff4e, 0x4107e449c74eff4e, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, + 0x4107f7ec53a8d491, 0x4107f7ec53a8d491, 0x4107f7ec53a8d491, 0x4107f7ec53a8d492, 0x4107f7ec53a8d491, 0x410801bd99d5bf33, 0x410801bd99d5bf33, 0x410801bd99d5bf33, + 0x410801bd99d5bf33, 0x410801bd99d5bf33, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41081560262f9476, + 0x41081560262f9476, 0x41081560262f9476, 0x41081560262f9476, 0x41081560262f9476, 0x41081f316c5c7f18, 0x41081f316c5c7f18, 0x41081f316c5c7f18, 0x41081f316c5c7f18, + 0x41081f316c5c7f18, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x410832d3f8b6545b, 0x410832d3f8b6545b, + 0x410832d3f8b6545b, 0x410832d3f8b6545b, 0x410832d3f8b6545b, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, + 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x41085047cb3d1440, 0x41085047cb3d1440, 0x41085047cb3d1440, + 0x41085047cb3d1440, 0x41085047cb3d1440, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x410863ea5796e983, + 0x410863ea5796e983, 0x410863ea5796e983, 0x410863ea5796e983, 0x410863ea5796e983, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, + 0x41086dbb9dc3d425, 0x4108778ce3f0bec6, 0x4108778ce3f0bec6, 0x4108778ce3f0bec6, 0x4108778ce3f0bec7, 0x4108778ce3f0bec6, 0x4108815e2a1da968, 0x4108815e2a1da968, + 0x4108815e2a1da968, 0x4108815e2a1da968, 0x4108815e2a1da968, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, + 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089ed1fca4694d, 0x41089ed1fca4694d, 0x41089ed1fca4694d, + 0x41089ed1fca4694d, 0x41089ed1fca4694d, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108b27488fe3e90, + 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, + 0x4108bc45cf2b2932, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, + 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, + 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, + 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, 0x4108f72d7438a8fb, 0x4108f72d7438a8fb, 0x4108f72d7438a8fb, 0x4108f72d7438a8fc, 0x4108f72d7438a8fb, 0x410900feba65939d, + 0x410900feba65939d, 0x410900feba65939d, 0x410900feba65939d, 0x410900feba65939d, 0x41090ad000927e3f, 0x41090ad000927e3f, 0x41090ad000927e3f, 0x41090ad000927e3f, + 0x41090ad000927e3f, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x41091e728cec5382, 0x41091e728cec5382, + 0x41091e728cec5382, 0x41091e728cec5382, 0x41091e728cec5382, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, + 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093be65f731367, 0x41093be65f731367, 0x41093be65f731367, + 0x41093be65f731367, 0x41093be65f731367, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x41094f88ebcce8aa, + 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x4109595a31f9d34c, 0x4109595a31f9d34c, 0x4109595a31f9d34c, 0x4109595a31f9d34c, + 0x4109595a31f9d34c, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, + 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, 0x410976ce04809330, 0x410976ce04809330, 0x410976ce04809330, 0x410976ce04809331, 0x410976ce04809330, + 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x41098a7090da6874, 0x41098a7090da6874, 0x41098a7090da6874, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbda4f7e6c0d70f0c, 0xbda4f7e6c0d70f0c, 0xbda4f7e6c0d70f0c, 0x3d7d49a2c1e7e800, 0x3d7d49a2c1e7e800, 0x3d7d49a2c1e7e800, 0x3d7d49a2c1e7e800, 0x3d7d49a2c1e7e800, + 0x3dac4a4f7151090c, 0x3dac4a4f7151090c, 0x3dac4a4f7151090c, 0x3dac4a4f7151090c, 0x3dac4a4f7151090c, 0xbd96292aeb35d5d0, 0xbd96292aeb35d5d0, 0xbd96292aeb35d5d0, + 0xbd96292aeb35d5d0, 0xbd96292aeb35d5d0, 0x3d9b190b46f24248, 0x3d9b190b46f24248, 0x3d9b190b46f24248, 0x3d9b190b46f24248, 0x3d9b190b46f24248, 0xbda9d25f4372d2d0, + 0xbda9d25f4372d2d0, 0xbda9d25f4372d2d0, 0xbda9d25f4372d2d0, 0xbda9d25f4372d2d0, 0xbd631442a5ec6c3b, 0xbd631442a5ec6c3b, 0xbd631442a5ec6c3b, 0xbd631442a5ec6c3b, + 0xbd631442a5ec6c3b, 0x3da76fd6eeb54548, 0x3da76fd6eeb54548, 0x3da76fd6eeb54548, 0x3da76fd6eeb54548, 0x3da76fd6eeb54548, 0xbd9fde1bf06d5d57, 0xbd9fde1bf06d5d57, + 0xbd9fde1bf06d5d57, 0xbd9fde1bf06d5d57, 0xbd9fde1bf06d5d57, 0x3d91641a41babac1, 0x3d91641a41babac1, 0x3d91641a41babac1, 0x3d91641a41babac1, 0x3d91641a41babac1, + 0xbdaeacd7c60e9693, 0xbdaeacd7c60e9693, 0xbdaeacd7c60e9693, 0x3db0a9941cf8b4b6, 0xbdaeacd7c60e9693, 0xbd882ef2b3ea2a1e, 0xbd882ef2b3ea2a1e, 0xbd882ef2b3ea2a1e, + 0xbd882ef2b3ea2a1e, 0xbd882ef2b3ea2a1e, 0x3da2955e6c198185, 0x3da2955e6c198185, 0x3da2955e6c198185, 0x3da2955e6c198185, 0x3da2955e6c198185, 0xbda4c9867ad2726f, + 0xbda4c9867ad2726f, 0xbda4c9867ad2726f, 0xbda4c9867ad2726f, 0xbda4c9867ad2726f, 0x3d7ebca4f20ccce6, 0x3d7ebca4f20ccce6, 0x3d7ebca4f20ccce6, 0x3d7ebca4f20ccce6, + 0x3d7ebca4f20ccce6, 0x3dac78afb755a5a9, 0x3dac78afb755a5a9, 0x3dac78afb755a5a9, 0x3dac78afb755a5a9, 0x3dac78afb755a5a9, 0xbd95cc6a5f2c9c96, 0xbd95cc6a5f2c9c96, + 0xbd95cc6a5f2c9c96, 0xbd95cc6a5f2c9c96, 0xbd95cc6a5f2c9c96, 0x3d9b75cbd2fb7b82, 0x3d9b75cbd2fb7b82, 0x3d9b75cbd2fb7b82, 0x3d9b75cbd2fb7b82, 0x3d9b75cbd2fb7b82, + 0xbda9a3fefd6e3633, 0xbda9a3fefd6e3633, 0xbda9a3fefd6e3633, 0xbda9a3fefd6e3633, 0xbda9a3fefd6e3633, 0xbd602e3e45a2a270, 0xbd602e3e45a2a270, 0xbd602e3e45a2a270, + 0xbd602e3e45a2a270, 0xbd602e3e45a2a270, 0x3da79e3734b9e1e5, 0x3da79e3734b9e1e5, 0x3da79e3734b9e1e5, 0x3da79e3734b9e1e5, 0x3da79e3734b9e1e5, 0xbd9f815b6464241e, + 0xbd9f815b6464241e, 0xbd9f815b6464241e, 0xbd9f815b6464241e, 0xbd9f815b6464241e, 0x3d91c0dacdc3f3fa, 0x3d91c0dacdc3f3fa, 0x3d91c0dacdc3f3fa, 0x3d91c0dacdc3f3fa, + 0x3d91c0dacdc3f3fa, 0xbdae7e778009f9f7, 0xbdae7e778009f9f7, 0xbdae7e778009f9f7, 0x3db0c0c43ffb0305, 0xbdae7e778009f9f7, 0xbd8775719bd7b7ab, 0xbd8775719bd7b7ab, + 0xbd8775719bd7b7ab, 0xbd8775719bd7b7ab, 0xbd8775719bd7b7ab, 0x3da2c3beb21e1e21, 0x3da2c3beb21e1e21, 0x3da2c3beb21e1e21, 0x3da2c3beb21e1e21, 0x3da2c3beb21e1e21, + 0xbda49b2634cdd5d3, 0xbda49b2634cdd5d3, 0xbda49b2634cdd5d3, 0xbda49b2634cdd5d3, 0xbda49b2634cdd5d3, 0x3d8017d39118d8e6, 0x3d8017d39118d8e6, 0x3d8017d39118d8e6, + 0x3d8017d39118d8e6, 0x3d8017d39118d8e6, 0x3daca70ffd5a4245, 0x3daca70ffd5a4245, 0x3daca70ffd5a4245, 0x3daca70ffd5a4245, 0x3daca70ffd5a4245, 0xbd956fa9d323635d, + 0xbd956fa9d323635d, 0xbd956fa9d323635d, 0xbd956fa9d323635d, 0xbd956fa9d323635d, 0x3d9bd28c5f04b4bb, 0x3d9bd28c5f04b4bb, 0x3d9bd28c5f04b4bb, 0x3d9bd28c5f04b4bb, + 0x3d9bd28c5f04b4bb, 0xbda9759eb7699996, 0xbda9759eb7699996, 0xbda9759eb7699996, 0xbda9759eb7699996, 0xbda9759eb7699996, 0xbd5a9073cab1b14b, 0xbd5a9073cab1b14b, + 0xbd5a9073cab1b14b, 0xbd5a9073cab1b14b, 0xbd5a9073cab1b14b, 0x3da7cc977abe7e82, 0x3da7cc977abe7e82, 0x3da7cc977abe7e82, 0x3da7cc977abe7e82, 0x3da7cc977abe7e82, + 0xbd9f249ad85aeae4, 0xbd9f249ad85aeae4, 0xbd9f249ad85aeae4, 0xbd9f249ad85aeae4, 0xbd9f249ad85aeae4, 0x3d921d9b59cd2d34, 0x3d921d9b59cd2d34, 0x3d921d9b59cd2d34, + 0x3d921d9b59cd2d34, 0x3d921d9b59cd2d34, 0xbdae50173a055d5a, 0xbdae50173a055d5a, 0xbdae50173a055d5a, 0x3db0d7f462fd5153, 0xbdae50173a055d5a, 0xbd86bbf083c54538, + 0xbd86bbf083c54538, 0xbd86bbf083c54538, 0xbd86bbf083c54538, 0xbd86bbf083c54538, 0x3da2f21ef822babe, 0x3da2f21ef822babe, 0x3da2f21ef822babe, 0x3da2f21ef822babe, + 0x3da2f21ef822babe, 0xbda46cc5eec93936, 0xbda46cc5eec93936, 0xbda46cc5eec93936, 0xbda46cc5eec93936, 0xbda46cc5eec93936, 0x3d80d154a92b4b58, 0x3d80d154a92b4b58, + 0x3d80d154a92b4b58, 0x3d80d154a92b4b58, 0x3d80d154a92b4b58, 0x3dacd570435edee2, 0x3dacd570435edee2, 0x3dacd570435edee2, 0x3dacd570435edee2, 0x3dacd570435edee2, + 0xbd9512e9471a2a24, 0xbd9512e9471a2a24, 0xbd9512e9471a2a24, 0xbd9512e9471a2a24, 0xbd9512e9471a2a24, 0x3d9c2f4ceb0dedf4, 0x3d9c2f4ceb0dedf4, 0x3d9c2f4ceb0dedf4, + 0x3d9c2f4ceb0dedf4, 0x3d9c2f4ceb0dedf4, 0xbda9473e7164fcfa, 0xbda9473e7164fcfa, 0xbda9473e7164fcfa, 0xbda9473e7164fcfa, 0xbda9473e7164fcfa, 0xbd54c46b0a1e1db6, + 0xbd54c46b0a1e1db6, 0xbd54c46b0a1e1db6, 0xbd54c46b0a1e1db6, 0xbd54c46b0a1e1db6, 0x3da7faf7c0c31b1e, 0x3da7faf7c0c31b1e, 0x3da7faf7c0c31b1e, 0x3da7faf7c0c31b1e, + 0x3da7faf7c0c31b1e, 0xbd9ec7da4c51b1ab, 0xbd9ec7da4c51b1ab, 0xbd9ec7da4c51b1ab, 0xbd9ec7da4c51b1ab, 0xbd9ec7da4c51b1ab, 0x3d927a5be5d6666d, 0x3d927a5be5d6666d, + 0x3d927a5be5d6666d, 0x3d927a5be5d6666d, 0x3d927a5be5d6666d, 0xbdae21b6f400c0bd, 0xbdae21b6f400c0bd, 0xbdae21b6f400c0bd, 0x3db0ef2485ff9fa1, 0xbdae21b6f400c0bd, + 0xbd86026f6bb2d2c6, 0xbd86026f6bb2d2c6, 0xbd86026f6bb2d2c6, 0xbd86026f6bb2d2c6, 0xbd86026f6bb2d2c6, 0x3da3207f3e27575b, 0x3da3207f3e27575b, 0x3da3207f3e27575b, +] )) ), + +################ chunk 6656 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x41098a7090da6874, 0x41098a7090da6874, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099e131d343db7, + 0x41099e131d343db7, 0x41099e131d343db7, 0x41099e131d343db7, 0x41099e131d343db7, 0x4109a7e463612859, 0x4109a7e463612859, 0x4109a7e463612859, 0x4109a7e463612859, + 0x4109a7e463612859, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, + 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, + 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109d8fac241bd81, 0x4109d8fac241bd81, 0x4109d8fac241bd81, + 0x4109d8fac241bd81, 0x4109d8fac241bd81, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109ec9d4e9b92c4, + 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109f66e94c87d65, 0x4109f66e94c87d65, 0x4109f66e94c87d65, 0x4109f66e94c87d66, + 0x4109f66e94c87d65, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a0a11212252a9, 0x410a0a11212252a9, + 0x410a0a11212252a9, 0x410a0a11212252a9, 0x410a0a11212252a9, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, + 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a2784f3a9128e, 0x410a2784f3a9128e, 0x410a2784f3a9128e, + 0x410a2784f3a9128e, 0x410a2784f3a9128e, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a3b278002e7d1, + 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a44f8c62fd272, 0x410a44f8c62fd272, 0x410a44f8c62fd272, 0x410a44f8c62fd272, + 0x410a44f8c62fd272, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a589b5289a7b6, 0x410a589b5289a7b6, + 0x410a589b5289a7b6, 0x410a589b5289a7b6, 0x410a589b5289a7b6, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, + 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a760f2510679a, 0x410a760f2510679a, 0x410a760f2510679a, + 0x410a760f2510679a, 0x410a760f2510679a, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a89b1b16a3cde, + 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a9382f797277f, 0x410a9382f797277f, 0x410a9382f797277f, 0x410a9382f797277f, + 0x410a9382f797277f, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, + 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, + 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410ac4995677bca7, 0x410ac4995677bca7, 0x410ac4995677bca7, + 0x410ac4995677bca7, 0x410ac4995677bca7, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ad83be2d191eb, + 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, + 0x410ae20d28fe7c8c, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410af5afb55851cf, 0x410af5afb55851cf, + 0x410af5afb55851cf, 0x410af5afb55851cf, 0x410af5afb55851cf, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, + 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b132387df11b4, 0x410b132387df11b4, 0x410b132387df11b4, + 0x410b132387df11b4, 0x410b132387df11b4, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b26c61438e6f8, + 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b30975a65d199, 0x410b30975a65d199, 0x410b30975a65d199, 0x410b30975a65d199, + 0x410b30975a65d199, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, + 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, + 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b61adb94666c1, 0x410b61adb94666c1, 0x410b61adb94666c1, + 0x410b61adb94666c1, 0x410b61adb94666c1, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b755045a03c04, + 0x410b755045a03c04, 0x410b755045a03c04, 0x410b755045a03c04, 0x410b755045a03c04, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3da3207f3e27575b, 0x3da3207f3e27575b, 0xbda43e65a8c49c99, 0xbda43e65a8c49c99, 0xbda43e65a8c49c99, 0xbda43e65a8c49c99, 0xbda43e65a8c49c99, 0x3d818ad5c13dbdcb, + 0x3d818ad5c13dbdcb, 0x3d818ad5c13dbdcb, 0x3d818ad5c13dbdcb, 0x3d818ad5c13dbdcb, 0x3dad03d089637b7f, 0x3dad03d089637b7f, 0x3dad03d089637b7f, 0x3dad03d089637b7f, + 0x3dad03d089637b7f, 0xbd94b628bb10f0ea, 0xbd94b628bb10f0ea, 0xbd94b628bb10f0ea, 0xbd94b628bb10f0ea, 0xbd94b628bb10f0ea, 0x3d9c8c0d7717272e, 0x3d9c8c0d7717272e, + 0x3d9c8c0d7717272e, 0x3d9c8c0d7717272e, 0x3d9c8c0d7717272e, 0xbda918de2b60605d, 0xbda918de2b60605d, 0xbda918de2b60605d, 0xbda918de2b60605d, 0xbda918de2b60605d, + 0xbd4df0c493151440, 0xbd4df0c493151440, 0xbd4df0c493151440, 0xbd4df0c493151440, 0xbd4df0c493151440, 0x3da8295806c7b7bb, 0x3da8295806c7b7bb, 0x3da8295806c7b7bb, + 0x3da8295806c7b7bb, 0x3da8295806c7b7bb, 0xbd9e6b19c0487872, 0xbd9e6b19c0487872, 0xbd9e6b19c0487872, 0xbd9e6b19c0487872, 0xbd9e6b19c0487872, 0x3d92d71c71df9fa6, + 0x3d92d71c71df9fa6, 0x3d92d71c71df9fa6, 0x3d92d71c71df9fa6, 0x3d92d71c71df9fa6, 0xbdadf356adfc2421, 0xbdadf356adfc2421, 0xbdadf356adfc2421, 0x3db10654a901edf0, + 0xbdadf356adfc2421, 0xbd8548ee53a06053, 0xbd8548ee53a06053, 0xbd8548ee53a06053, 0xbd8548ee53a06053, 0xbd8548ee53a06053, 0x3da34edf842bf3f7, 0x3da34edf842bf3f7, + 0x3da34edf842bf3f7, 0x3da34edf842bf3f7, 0x3da34edf842bf3f7, 0xbda4100562bffffd, 0xbda4100562bffffd, 0xbda4100562bffffd, 0xbda4100562bffffd, 0xbda4100562bffffd, + 0x3d824456d950303e, 0x3d824456d950303e, 0x3d824456d950303e, 0x3d824456d950303e, 0x3d824456d950303e, 0x3dad3230cf68181b, 0x3dad3230cf68181b, 0x3dad3230cf68181b, + 0x3dad3230cf68181b, 0x3dad3230cf68181b, 0xbd9459682f07b7b1, 0xbd9459682f07b7b1, 0xbd9459682f07b7b1, 0xbd9459682f07b7b1, 0xbd9459682f07b7b1, 0x3d9ce8ce03206067, + 0x3d9ce8ce03206067, 0x3d9ce8ce03206067, 0x3d9ce8ce03206067, 0x3d9ce8ce03206067, 0xbda8ea7de55bc3c0, 0xbda8ea7de55bc3c0, 0xbda8ea7de55bc3c0, 0xbda8ea7de55bc3c0, + 0xbda8ea7de55bc3c0, 0xbd4258b311eded15, 0xbd4258b311eded15, 0xbd4258b311eded15, 0xbd4258b311eded15, 0xbd4258b311eded15, 0x3da857b84ccc5458, 0x3da857b84ccc5458, + 0x3da857b84ccc5458, 0x3da857b84ccc5458, 0x3da857b84ccc5458, 0xbd9e0e59343f3f38, 0xbd9e0e59343f3f38, 0xbd9e0e59343f3f38, 0xbd9e0e59343f3f38, 0xbd9e0e59343f3f38, + 0x3d9333dcfde8d8e0, 0x3d9333dcfde8d8e0, 0x3d9333dcfde8d8e0, 0x3d9333dcfde8d8e0, 0x3d9333dcfde8d8e0, 0xbdadc4f667f78784, 0xbdadc4f667f78784, 0xbdadc4f667f78784, + 0xbdadc4f667f78784, 0xbdadc4f667f78784, 0xbd848f6d3b8dede0, 0xbd848f6d3b8dede0, 0xbd848f6d3b8dede0, 0xbd848f6d3b8dede0, 0xbd848f6d3b8dede0, 0x3da37d3fca309094, + 0x3da37d3fca309094, 0x3da37d3fca309094, 0x3da37d3fca309094, 0x3da37d3fca309094, 0xbda3e1a51cbb6360, 0xbda3e1a51cbb6360, 0xbda3e1a51cbb6360, 0xbda3e1a51cbb6360, + 0xbda3e1a51cbb6360, 0x3d82fdd7f162a2b0, 0x3d82fdd7f162a2b0, 0x3d82fdd7f162a2b0, 0x3d82fdd7f162a2b0, 0x3d82fdd7f162a2b0, 0x3dad6091156cb4b8, 0x3dad6091156cb4b8, + 0x3dad6091156cb4b8, 0x3dad6091156cb4b8, 0x3dad6091156cb4b8, 0xbd93fca7a2fe7e78, 0xbd93fca7a2fe7e78, 0xbd93fca7a2fe7e78, 0xbd93fca7a2fe7e78, 0xbd93fca7a2fe7e78, + 0x3d9d458e8f2999a0, 0x3d9d458e8f2999a0, 0x3d9d458e8f2999a0, 0x3d9d458e8f2999a0, 0x3d9d458e8f2999a0, 0xbda8bc1d9f572724, 0xbda8bc1d9f572724, 0xbda8bc1d9f572724, + 0xbda8bc1d9f572724, 0xbda8bc1d9f572724, 0xbd2b0286431b17a6, 0xbd2b0286431b17a6, 0xbd2b0286431b17a6, 0xbd2b0286431b17a6, 0xbd2b0286431b17a6, 0x3da8861892d0f0f4, + 0x3da8861892d0f0f4, 0x3da8861892d0f0f4, 0x3da8861892d0f0f4, 0x3da8861892d0f0f4, 0xbd9db198a83605ff, 0xbd9db198a83605ff, 0xbd9db198a83605ff, 0xbd9db198a83605ff, + 0xbd9db198a83605ff, 0x3d93909d89f21219, 0x3d93909d89f21219, 0x3d93909d89f21219, 0x3d93909d89f21219, 0x3d93909d89f21219, 0xbdad969621f2eae7, 0xbdad969621f2eae7, + 0xbdad969621f2eae7, 0xbdad969621f2eae7, 0xbdad969621f2eae7, 0xbd83d5ec237b7b6e, 0xbd83d5ec237b7b6e, 0xbd83d5ec237b7b6e, 0xbd83d5ec237b7b6e, 0xbd83d5ec237b7b6e, + 0x3da3aba010352d31, 0x3da3aba010352d31, 0x3da3aba010352d31, 0x3da3aba010352d31, 0x3da3aba010352d31, 0xbda3b344d6b6c6c3, 0xbda3b344d6b6c6c3, 0xbda3b344d6b6c6c3, + 0xbda3b344d6b6c6c3, 0xbda3b344d6b6c6c3, 0x3d83b75909751523, 0x3d83b75909751523, 0x3d83b75909751523, 0x3d83b75909751523, 0x3d83b75909751523, 0x3dad8ef15b715155, + 0x3dad8ef15b715155, 0x3dad8ef15b715155, 0x3dad8ef15b715155, 0x3dad8ef15b715155, 0xbd939fe716f5453e, 0xbd939fe716f5453e, 0xbd939fe716f5453e, 0xbd939fe716f5453e, + 0xbd939fe716f5453e, 0x3d9da24f1b32d2da, 0x3d9da24f1b32d2da, 0x3d9da24f1b32d2da, 0x3d9da24f1b32d2da, 0x3d9da24f1b32d2da, 0xbda88dbd59528a87, 0xbda88dbd59528a87, + 0xbda88dbd59528a87, 0xbda88dbd59528a87, 0xbda88dbd59528a87, 0x3d235dbfc1818507, 0x3d235dbfc1818507, 0x3d235dbfc1818507, 0x3d235dbfc1818507, 0x3d235dbfc1818507, + 0x3da8b478d8d58d91, 0x3da8b478d8d58d91, 0x3da8b478d8d58d91, 0x3da8b478d8d58d91, 0x3da8b478d8d58d91, 0xbd9d54d81c2cccc6, 0xbd9d54d81c2cccc6, 0xbd9d54d81c2cccc6, + 0xbd9d54d81c2cccc6, 0xbd9d54d81c2cccc6, 0x3d93ed5e15fb4b52, 0x3d93ed5e15fb4b52, 0x3d93ed5e15fb4b52, 0x3d93ed5e15fb4b52, 0x3d93ed5e15fb4b52, 0xbdad6835dbee4e4b, + 0xbdad6835dbee4e4b, 0xbdad6835dbee4e4b, 0xbdad6835dbee4e4b, 0xbdad6835dbee4e4b, 0xbd831c6b0b6908fb, 0xbd831c6b0b6908fb, 0xbd831c6b0b6908fb, 0xbd831c6b0b6908fb, +] )) ), + +################ chunk 7168 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x410b7f218bcd26a6, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b92c41826fbe9, 0x410b92c41826fbe9, + 0x410b92c41826fbe9, 0x410b92c41826fbe9, 0x410b92c41826fbe9, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, + 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410bb037eaadbbce, 0x410bb037eaadbbce, 0x410bb037eaadbbce, + 0x410bb037eaadbbce, 0x410bb037eaadbbce, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bc3da77079111, + 0x410bc3da77079111, 0x410bc3da77079111, 0x410bc3da77079111, 0x410bc3da77079111, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, + 0x410bcdabbd347bb3, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410be14e498e50f6, 0x410be14e498e50f6, + 0x410be14e498e50f6, 0x410be14e498e50f6, 0x410be14e498e50f6, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, + 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bfec21c1510db, 0x410bfec21c1510db, 0x410bfec21c1510db, + 0x410bfec21c1510db, 0x410bfec21c1510db, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c1264a86ee61e, + 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, + 0x410c1c35ee9bd0c0, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb61, 0x410c2fd87af5a603, 0x410c2fd87af5a603, + 0x410c2fd87af5a603, 0x410c2fd87af5a603, 0x410c2fd87af5a603, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, + 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, + 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c60eed9d63b2b, + 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c6ac0200325cd, 0x410c6ac0200325cd, 0x410c6ac0200325cd, 0x410c6ac0200325cd, + 0x410c6ac0200325cd, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, + 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, + 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, + 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a596, 0x410caf790b3d9038, + 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410cb94a516a7ada, 0x410cb94a516a7ada, 0x410cb94a516a7ada, 0x410cb94a516a7ada, + 0x410cb94a516a7ada, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cccecddc4501d, 0x410cccecddc4501d, + 0x410cccecddc4501d, 0x410cccecddc4501d, 0x410cccecddc4501d, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, + 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410cea60b04b1002, 0x410cea60b04b1002, 0x410cea60b04b1002, + 0x410cea60b04b1002, 0x410cea60b04b1002, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cfe033ca4e545, + 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, + 0x410d07d482d1cfe7, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, + 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcb, + 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d38eae1b2650f, 0x410d38eae1b2650f, 0x410d38eae1b2650f, + 0x410d38eae1b2650f, 0x410d38eae1b2650f, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d4c8d6e0c3a52, + 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d565eb43924f4, 0x410d565eb43924f4, 0x410d565eb43924f4, 0x410d565eb43924f4, + 0x410d565eb43924f4, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d6a014092fa37, 0x410d6a014092fa37, + 0x410d6a014092fa37, 0x410d6a014092fa37, 0x410d6a014092fa37, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbd831c6b0b6908fb, 0x3da3da005639c9cd, 0x3da3da005639c9cd, 0x3da3da005639c9cd, 0x3da3da005639c9cd, 0x3da3da005639c9cd, 0xbda384e490b22a27, 0xbda384e490b22a27, + 0xbda384e490b22a27, 0xbda384e490b22a27, 0xbda384e490b22a27, 0x3d8470da21878796, 0x3d8470da21878796, 0x3d8470da21878796, 0x3d8470da21878796, 0x3d8470da21878796, + 0x3dadbd51a175edf1, 0x3dadbd51a175edf1, 0x3dadbd51a175edf1, 0x3dadbd51a175edf1, 0x3dadbd51a175edf1, 0xbd9343268aec0c05, 0xbd9343268aec0c05, 0xbd9343268aec0c05, + 0xbd9343268aec0c05, 0xbd9343268aec0c05, 0x3d9dff0fa73c0c13, 0x3d9dff0fa73c0c13, 0x3d9dff0fa73c0c13, 0x3d9dff0fa73c0c13, 0x3d9dff0fa73c0c13, 0xbda85f5d134dedea, + 0xbda85f5d134dedea, 0xbda85f5d134dedea, 0xbda85f5d134dedea, 0xbda85f5d134dedea, 0x3d406f817187886d, 0x3d406f817187886d, 0x3d406f817187886d, 0x3d406f817187886d, + 0x3d406f817187886d, 0x3da8e2d91eda2a2e, 0x3da8e2d91eda2a2e, 0x3da8e2d91eda2a2e, 0x3da8e2d91eda2a2e, 0x3da8e2d91eda2a2e, 0xbd9cf8179023938c, 0xbd9cf8179023938c, + 0xbd9cf8179023938c, 0xbd9cf8179023938c, 0xbd9cf8179023938c, 0x3d944a1ea204848c, 0x3d944a1ea204848c, 0x3d944a1ea204848c, 0x3d944a1ea204848c, 0x3d944a1ea204848c, + 0xbdad39d595e9b1ae, 0xbdad39d595e9b1ae, 0xbdad39d595e9b1ae, 0xbdad39d595e9b1ae, 0xbdad39d595e9b1ae, 0xbd8262e9f3569688, 0xbd8262e9f3569688, 0xbd8262e9f3569688, + 0xbd8262e9f3569688, 0xbd8262e9f3569688, 0x3da408609c3e666a, 0x3da408609c3e666a, 0x3da408609c3e666a, 0x3da408609c3e666a, 0x3da408609c3e666a, 0xbda356844aad8d8a, + 0xbda356844aad8d8a, 0xbda356844aad8d8a, 0xbda356844aad8d8a, 0xbda356844aad8d8a, 0x3d852a5b3999fa08, 0x3d852a5b3999fa08, 0x3d852a5b3999fa08, 0x3d852a5b3999fa08, + 0x3d852a5b3999fa08, 0x3dadebb1e77a8a8e, 0x3dadebb1e77a8a8e, 0x3dadebb1e77a8a8e, 0x3dadebb1e77a8a8e, 0xbdb10a270c42bab9, 0xbd92e665fee2d2cc, 0xbd92e665fee2d2cc, + 0xbd92e665fee2d2cc, 0xbd92e665fee2d2cc, 0xbd92e665fee2d2cc, 0x3d9e5bd03345454d, 0x3d9e5bd03345454d, 0x3d9e5bd03345454d, 0x3d9e5bd03345454d, 0x3d9e5bd03345454d, + 0xbda830fccd49514e, 0xbda830fccd49514e, 0xbda830fccd49514e, 0xbda830fccd49514e, 0xbda830fccd49514e, 0x3d4c0792f2aeaf98, 0x3d4c0792f2aeaf98, 0x3d4c0792f2aeaf98, + 0x3d4c0792f2aeaf98, 0x3d4c0792f2aeaf98, 0x3da9113964dec6ca, 0x3da9113964dec6ca, 0x3da9113964dec6ca, 0x3da9113964dec6ca, 0x3da9113964dec6ca, 0xbd9c9b57041a5a53, + 0xbd9c9b57041a5a53, 0xbd9c9b57041a5a53, 0xbd9c9b57041a5a53, 0xbd9c9b57041a5a53, 0x3d94a6df2e0dbdc5, 0x3d94a6df2e0dbdc5, 0x3d94a6df2e0dbdc5, 0x3d94a6df2e0dbdc5, + 0x3d94a6df2e0dbdc5, 0xbdad0b754fe51511, 0xbdad0b754fe51511, 0xbdad0b754fe51511, 0xbdad0b754fe51511, 0xbdad0b754fe51511, 0xbd81a968db442415, 0xbd81a968db442415, + 0xbd81a968db442415, 0xbd81a968db442415, 0xbd81a968db442415, 0x3da436c0e2430307, 0x3da436c0e2430307, 0x3da436c0e2430307, 0x3da436c0e2430307, 0x3da436c0e2430307, + 0xbda3282404a8f0ed, 0xbda3282404a8f0ed, 0xbda3282404a8f0ed, 0xbda3282404a8f0ed, 0xbda3282404a8f0ed, 0x3d85e3dc51ac6c7b, 0x3d85e3dc51ac6c7b, 0x3d85e3dc51ac6c7b, + 0x3d85e3dc51ac6c7b, 0x3d85e3dc51ac6c7b, 0x3dae1a122d7f272b, 0x3dae1a122d7f272b, 0x3dae1a122d7f272b, 0x3dae1a122d7f272b, 0xbdb0f2f6e9406c6b, 0xbd9289a572d99992, + 0xbd9289a572d99992, 0xbd9289a572d99992, 0xbd9289a572d99992, 0xbd9289a572d99992, 0x3d9eb890bf4e7e86, 0x3d9eb890bf4e7e86, 0x3d9eb890bf4e7e86, 0x3d9eb890bf4e7e86, + 0x3d9eb890bf4e7e86, 0xbda8029c8744b4b1, 0xbda8029c8744b4b1, 0xbda8029c8744b4b1, 0xbda8029c8744b4b1, 0xbda8029c8744b4b1, 0x3d53cfd239eaeb62, 0x3d53cfd239eaeb62, + 0x3d53cfd239eaeb62, 0x3d53cfd239eaeb62, 0x3d53cfd239eaeb62, 0x3da93f99aae36367, 0x3da93f99aae36367, 0x3da93f99aae36367, 0x3da93f99aae36367, 0x3da93f99aae36367, + 0xbd9c3e967811211a, 0xbd9c3e967811211a, 0xbd9c3e967811211a, 0xbd9c3e967811211a, 0xbd9c3e967811211a, 0x3d95039fba16f6fe, 0x3d95039fba16f6fe, 0x3d95039fba16f6fe, + 0x3d95039fba16f6fe, 0x3d95039fba16f6fe, 0xbdacdd1509e07875, 0xbdacdd1509e07875, 0xbdacdd1509e07875, 0xbdacdd1509e07875, 0xbdacdd1509e07875, 0xbd80efe7c331b1a3, + 0xbd80efe7c331b1a3, 0xbd80efe7c331b1a3, 0xbd80efe7c331b1a3, 0xbd80efe7c331b1a3, 0x3da4652128479fa3, 0x3da4652128479fa3, 0x3da4652128479fa3, 0x3da4652128479fa3, + 0x3da4652128479fa3, 0xbda2f9c3bea45451, 0xbda2f9c3bea45451, 0xbda2f9c3bea45451, 0xbda2f9c3bea45451, 0xbda2f9c3bea45451, 0x3d869d5d69bedeee, 0x3d869d5d69bedeee, + 0x3d869d5d69bedeee, 0x3d869d5d69bedeee, 0x3d869d5d69bedeee, 0x3dae48727383c3c8, 0x3dae48727383c3c8, 0x3dae48727383c3c8, 0x3dae48727383c3c8, 0xbdb0dbc6c63e1e1c, + 0xbd922ce4e6d06059, 0xbd922ce4e6d06059, 0xbd922ce4e6d06059, 0xbd922ce4e6d06059, 0xbd922ce4e6d06059, 0x3d9f15514b57b7bf, 0x3d9f15514b57b7bf, 0x3d9f15514b57b7bf, + 0x3d9f15514b57b7bf, 0x3d9f15514b57b7bf, 0xbda7d43c41401814, 0xbda7d43c41401814, 0xbda7d43c41401814, 0xbda7d43c41401814, 0xbda7d43c41401814, 0x3d599bdafa7e7ef7, + 0x3d599bdafa7e7ef7, 0x3d599bdafa7e7ef7, 0x3d599bdafa7e7ef7, 0x3d599bdafa7e7ef7, 0x3da96df9f0e80004, 0x3da96df9f0e80004, 0x3da96df9f0e80004, 0x3da96df9f0e80004, + 0x3da96df9f0e80004, 0xbd9be1d5ec07e7e0, 0xbd9be1d5ec07e7e0, 0xbd9be1d5ec07e7e0, 0xbd9be1d5ec07e7e0, 0xbd9be1d5ec07e7e0, 0x3d95606046203038, 0x3d95606046203038, + 0x3d95606046203038, 0x3d95606046203038, 0x3d95606046203038, 0xbdacaeb4c3dbdbd8, 0xbdacaeb4c3dbdbd8, 0xbdacaeb4c3dbdbd8, 0xbdacaeb4c3dbdbd8, 0xbdacaeb4c3dbdbd8, +] )) ), + +################ chunk 7680 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d87751319ba1c, 0x410d87751319ba1c, 0x410d87751319ba1c, + 0x410d87751319ba1c, 0x410d87751319ba1c, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d9b179f738f5f, + 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, + 0x410da4e8e5a07a00, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410db88b71fa4f44, 0x410db88b71fa4f44, + 0x410db88b71fa4f44, 0x410db88b71fa4f44, 0x410db88b71fa4f44, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, + 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dd5ff44810f29, 0x410dd5ff44810f29, 0x410dd5ff44810f29, + 0x410dd5ff44810f29, 0x410dd5ff44810f29, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410de9a1d0dae46c, + 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410df3731707cf0d, 0x410df3731707cf0d, 0x410df3731707cf0d, 0x410df3731707cf0d, + 0x410df3731707cf0d, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410e0715a361a451, 0x410e0715a361a451, + 0x410e0715a361a451, 0x410e0715a361a451, 0x410e0715a361a451, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, + 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e248975e86436, 0x410e248975e86436, 0x410e248975e86436, + 0x410e248975e86436, 0x410e248975e86435, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e382c02423979, + 0x410e382c02423979, 0x410e382c02423979, 0x410e382c02423979, 0x410e382c02423979, 0x410e41fd486f241a, 0x410e41fd486f241a, 0x410e41fd486f241a, 0x410e41fd486f241a, + 0x410e41fd486f241a, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, + 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, + 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e7313a74fb942, 0x410e7313a74fb942, 0x410e7313a74fb942, + 0x410e7313a74fb942, 0x410e7313a74fb942, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e86b633a98e86, + 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e908779d67927, 0x410e908779d67927, 0x410e908779d67927, 0x410e908779d67927, + 0x410e908779d67927, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410ea42a06304e6b, 0x410ea42a06304e6b, + 0x410ea42a06304e6b, 0x410ea42a06304e6b, 0x410ea42a06304e6a, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, + 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, + 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ed5406510e393, + 0x410ed5406510e393, 0x410ed5406510e393, 0x410ed5406510e393, 0x410ed5406510e393, 0x410edf11ab3dce34, 0x410edf11ab3dce34, 0x410edf11ab3dce34, 0x410edf11ab3dce34, + 0x410edf11ab3dce34, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ef2b43797a377, 0x410ef2b43797a377, + 0x410ef2b43797a377, 0x410ef2b43797a377, 0x410ef2b43797a377, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, + 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f10280a1e635c, 0x410f10280a1e635c, 0x410f10280a1e635c, + 0x410f10280a1e635c, 0x410f10280a1e635c, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f23ca967838a0, + 0x410f23ca967838a0, 0x410f23ca967838a0, 0x410f23ca967838a0, 0x410f23ca9678389f, 0x410f2d9bdca52341, 0x410f2d9bdca52341, 0x410f2d9bdca52341, 0x410f2d9bdca52341, + 0x410f2d9bdca52341, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f413e68fef884, 0x410f413e68fef884, + 0x410f413e68fef884, 0x410f413e68fef884, 0x410f413e68fef884, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, + 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f5eb23b85b869, 0x410f5eb23b85b869, 0x410f5eb23b85b869, + 0x410f5eb23b85b869, 0x410f5eb23b85b869, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f7254c7df8dac, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbd803666ab1f3f30, 0xbd803666ab1f3f30, 0xbd803666ab1f3f30, 0xbd803666ab1f3f30, 0xbd803666ab1f3f30, 0x3da493816e4c3c40, 0x3da493816e4c3c40, 0x3da493816e4c3c40, + 0x3da493816e4c3c40, 0x3da493816e4c3c40, 0xbda2cb63789fb7b4, 0xbda2cb63789fb7b4, 0xbda2cb63789fb7b4, 0xbda2cb63789fb7b4, 0xbda2cb63789fb7b4, 0x3d8756de81d15161, + 0x3d8756de81d15161, 0x3d8756de81d15161, 0x3d8756de81d15161, 0x3d8756de81d15161, 0x3dae76d2b9886064, 0x3dae76d2b9886064, 0x3dae76d2b9886064, 0x3dae76d2b9886064, + 0xbdb0c496a33bcfce, 0xbd91d0245ac7271f, 0xbd91d0245ac7271f, 0xbd91d0245ac7271f, 0xbd91d0245ac7271f, 0xbd91d0245ac7271f, 0x3d9f7211d760f0f9, 0x3d9f7211d760f0f9, + 0x3d9f7211d760f0f9, 0x3d9f7211d760f0f9, 0x3d9f7211d760f0f9, 0xbda7a5dbfb3b7b78, 0xbda7a5dbfb3b7b78, 0xbda7a5dbfb3b7b78, 0xbda7a5dbfb3b7b78, 0xbda7a5dbfb3b7b78, + 0x3d5f67e3bb12128d, 0x3d5f67e3bb12128d, 0x3d5f67e3bb12128d, 0x3d5f67e3bb12128d, 0x3d5f67e3bb12128d, 0x3da99c5a36ec9ca0, 0x3da99c5a36ec9ca0, 0x3da99c5a36ec9ca0, + 0x3da99c5a36ec9ca0, 0x3da99c5a36ec9ca0, 0xbd9b85155ffeaea7, 0xbd9b85155ffeaea7, 0xbd9b85155ffeaea7, 0xbd9b85155ffeaea7, 0xbd9b85155ffeaea7, 0x3d95bd20d2296971, + 0x3d95bd20d2296971, 0x3d95bd20d2296971, 0x3d95bd20d2296971, 0x3d95bd20d2296971, 0xbdac80547dd73f3b, 0xbdac80547dd73f3b, 0xbdac80547dd73f3b, 0xbdac80547dd73f3b, + 0xbdac80547dd73f3b, 0xbd7ef9cb2619997b, 0xbd7ef9cb2619997b, 0xbd7ef9cb2619997b, 0xbd7ef9cb2619997b, 0xbd7ef9cb2619997b, 0x3da4c1e1b450d8dd, 0x3da4c1e1b450d8dd, + 0x3da4c1e1b450d8dd, 0x3da4c1e1b450d8dd, 0x3da4c1e1b450d8dd, 0xbda29d03329b1b17, 0xbda29d03329b1b17, 0xbda29d03329b1b17, 0xbda29d03329b1b17, 0xbda29d03329b1b17, + 0x3d88105f99e3c3d3, 0x3d88105f99e3c3d3, 0x3d88105f99e3c3d3, 0x3d88105f99e3c3d3, 0x3d88105f99e3c3d3, 0x3daea532ff8cfd01, 0x3daea532ff8cfd01, 0x3daea532ff8cfd01, + 0x3daea532ff8cfd01, 0xbdb0ad6680398180, 0xbd917363cebdede6, 0xbd917363cebdede6, 0xbd917363cebdede6, 0xbd917363cebdede6, 0xbd917363cebdede6, 0x3d9fced2636a2a32, + 0x3d9fced2636a2a32, 0x3d9fced2636a2a32, 0x3d9fced2636a2a32, 0x3d9fced2636a2a32, 0xbda7777bb536dedb, 0xbda7777bb536dedb, 0xbda7777bb536dedb, 0xbda7777bb536dedb, + 0xbda7777bb536dedb, 0x3d6299f63dd2d311, 0x3d6299f63dd2d311, 0x3d6299f63dd2d311, 0x3d6299f63dd2d311, 0x3d6299f63dd2d311, 0x3da9caba7cf1393d, 0x3da9caba7cf1393d, + 0x3da9caba7cf1393d, 0x3da9caba7cf1393d, 0x3da9caba7cf1393d, 0xbd9b2854d3f5756e, 0xbd9b2854d3f5756e, 0xbd9b2854d3f5756e, 0xbd9b2854d3f5756e, 0xbd9b2854d3f5756e, + 0x3d9619e15e32a2aa, 0x3d9619e15e32a2aa, 0x3d9619e15e32a2aa, 0x3d9619e15e32a2aa, 0x3d9619e15e32a2aa, 0xbdac51f437d2a29f, 0xbdac51f437d2a29f, 0xbdac51f437d2a29f, + 0xbdac51f437d2a29f, 0xbdac51f437d2a29f, 0xbd7d86c8f5f4b495, 0xbd7d86c8f5f4b495, 0xbd7d86c8f5f4b495, 0xbd7d86c8f5f4b495, 0xbd7d86c8f5f4b495, 0x3da4f041fa557579, + 0x3da4f041fa557579, 0x3da4f041fa557579, 0x3da4f041fa557579, 0x3da4f041fa557579, 0xbda26ea2ec967e7b, 0xbda26ea2ec967e7b, 0xbda26ea2ec967e7b, 0xbda26ea2ec967e7b, + 0xbda26ea2ec967e7b, 0x3d88c9e0b1f63646, 0x3d88c9e0b1f63646, 0x3d88c9e0b1f63646, 0x3d88c9e0b1f63646, 0x3d88c9e0b1f63646, 0x3daed3934591999e, 0x3daed3934591999e, + 0x3daed3934591999e, 0x3daed3934591999e, 0xbdb096365d373331, 0xbd9116a342b4b4ad, 0xbd9116a342b4b4ad, 0xbd9116a342b4b4ad, 0xbd9116a342b4b4ad, 0xbd9116a342b4b4ad, + 0x3da015c977b9b1b6, 0x3da015c977b9b1b6, 0x3da015c977b9b1b6, 0x3da015c977b9b1b6, 0x3da015c977b9b1b6, 0xbda7491b6f32423e, 0xbda7491b6f32423e, 0xbda7491b6f32423e, + 0xbda7491b6f32423e, 0xbda7491b6f32423e, 0x3d657ffa9e1c9cdc, 0x3d657ffa9e1c9cdc, 0x3d657ffa9e1c9cdc, 0x3d657ffa9e1c9cdc, 0x3d657ffa9e1c9cdc, 0x3da9f91ac2f5d5da, + 0x3da9f91ac2f5d5da, 0x3da9f91ac2f5d5da, 0x3da9f91ac2f5d5da, 0x3da9f91ac2f5d5da, 0xbd9acb9447ec3c34, 0xbd9acb9447ec3c34, 0xbd9acb9447ec3c34, 0xbd9acb9447ec3c34, + 0xbd9acb9447ec3c34, 0x3d9676a1ea3bdbe4, 0x3d9676a1ea3bdbe4, 0x3d9676a1ea3bdbe4, 0x3d9676a1ea3bdbe4, 0x3d9676a1ea3bdbe4, 0xbdac2393f1ce0602, 0xbdac2393f1ce0602, + 0xbdac2393f1ce0602, 0xbdac2393f1ce0602, 0xbdac2393f1ce0602, 0xbd7c13c6c5cfcfb0, 0xbd7c13c6c5cfcfb0, 0xbd7c13c6c5cfcfb0, 0xbd7c13c6c5cfcfb0, 0xbd7c13c6c5cfcfb0, + 0x3da51ea2405a1216, 0x3da51ea2405a1216, 0x3da51ea2405a1216, 0x3da51ea2405a1216, 0x3da51ea2405a1216, 0xbda24042a691e1de, 0xbda24042a691e1de, 0xbda24042a691e1de, + 0xbda24042a691e1de, 0xbda24042a691e1de, 0x3d898361ca08a8b9, 0x3d898361ca08a8b9, 0x3d898361ca08a8b9, 0x3d898361ca08a8b9, 0x3d898361ca08a8b9, 0x3daf01f38b96363a, + 0x3daf01f38b96363a, 0x3daf01f38b96363a, 0x3daf01f38b96363a, 0xbdb07f063a34e4e3, 0xbd90b9e2b6ab7b73, 0xbd90b9e2b6ab7b73, 0xbd90b9e2b6ab7b73, 0xbd90b9e2b6ab7b73, + 0xbd90b9e2b6ab7b73, 0x3da04429bdbe4e52, 0x3da04429bdbe4e52, 0x3da04429bdbe4e52, 0x3da04429bdbe4e52, 0x3da04429bdbe4e52, 0xbda71abb292da5a2, 0xbda71abb292da5a2, + 0xbda71abb292da5a2, 0xbda71abb292da5a2, 0xbda71abb292da5a2, 0x3d6865fefe6666a7, 0x3d6865fefe6666a7, 0x3d6865fefe6666a7, 0x3d6865fefe6666a7, 0x3d6865fefe6666a7, + 0x3daa277b08fa7276, 0x3daa277b08fa7276, 0x3daa277b08fa7276, 0x3daa277b08fa7276, 0x3daa277b08fa7276, 0xbd9a6ed3bbe302fb, 0xbd9a6ed3bbe302fb, 0xbd9a6ed3bbe302fb, + 0xbd9a6ed3bbe302fb, 0xbd9a6ed3bbe302fb, 0x3d96d3627645151d, 0x3d96d3627645151d, 0x3d96d3627645151d, 0x3d96d3627645151d, 0x3d96d3627645151d, 0xbdabf533abc96965, +] )) ), + +################ chunk 8192 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7c260e0c784e, 0x410f7c260e0c784e, 0x410f7c260e0c784e, 0x410f7c260e0c784e, + 0x410f7c260e0c784e, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f8fc89a664d91, 0x410f8fc89a664d91, + 0x410f8fc89a664d91, 0x410f8fc89a664d91, 0x410f8fc89a664d91, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, + 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d4, 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, + 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fc0def946e2b9, + 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, + 0x410fcab03f73cd5b, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fde52cbcda29e, 0x410fde52cbcda29e, + 0x410fde52cbcda29e, 0x410fde52cbcda29e, 0x410fde52cbcda29e, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, + 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ffbc69e546283, 0x410ffbc69e546283, 0x410ffbc69e546283, + 0x410ffbc69e546283, 0x410ffbc69e546283, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411007b495571be3, + 0x411007b495571be3, 0x411007b495571be3, 0x411007b495571be3, 0x411007b495571be3, 0x41100c9d386d9134, 0x41100c9d386d9134, 0x41100c9d386d9134, 0x41100c9d386d9134, + 0x41100c9d386d9134, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, + 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, + 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110252867dddbc8, 0x4110252867dddbc8, 0x4110252867dddbc8, + 0x4110252867dddbc8, 0x4110252867dddbc8, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102ef9ae0ac66a, + 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x411033e251213bba, 0x411033e251213bba, 0x411033e251213bba, 0x411033e251213bba, + 0x411033e251213bba, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x41103db3974e265c, 0x41103db3974e265c, + 0x41103db3974e265c, 0x41103db3974e265c, 0x41103db3974e265c, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, + 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104c6d8091864e, 0x41104c6d8091864e, 0x41104c6d8091864e, + 0x41104c6d8091864e, 0x41104c6d8091864e, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110563ec6be70f0, + 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x41105b2769d4e641, 0x41105b2769d4e641, 0x41105b2769d4e641, 0x41105b2769d4e641, + 0x41105b2769d4e641, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411064f8b001d0e2, 0x411064f8b001d0e2, + 0x411064f8b001d0e2, 0x411064f8b001d0e3, 0x411064f8b001d0e2, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, + 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x411073b2994530d5, 0x411073b2994530d5, 0x411073b2994530d5, + 0x411073b2994530d5, 0x411073b2994530d5, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x41107d83df721b77, + 0x41107d83df721b77, 0x41107d83df721b77, 0x41107d83df721b77, 0x41107d83df721b77, 0x4110826c828890c7, 0x4110826c828890c7, 0x4110826c828890c7, 0x4110826c828890c7, + 0x4110826c828890c7, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, + 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, + 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, + 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x4110a4c8f825c5fd, + 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, + 0x4110a9b19b3c3b4e, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110b382e16925ef, 0x4110b382e16925ef, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbdabf533abc96965, 0xbdabf533abc96965, 0xbdabf533abc96965, 0xbdabf533abc96965, 0xbd7aa0c495aaeaca, 0xbd7aa0c495aaeaca, 0xbd7aa0c495aaeaca, 0xbd7aa0c495aaeaca, + 0xbd7aa0c495aaeaca, 0x3da54d02865eaeb3, 0x3da54d02865eaeb3, 0x3da54d02865eaeb3, 0x3da54d02865eaeb3, 0x3da54d02865eaeb3, 0xbda211e2608d4541, 0xbda211e2608d4541, + 0xbda211e2608d4541, 0xbda211e2608d4541, 0xbda211e2608d4541, 0x3d8a3ce2e21b1b2b, 0x3d8a3ce2e21b1b2b, 0x3d8a3ce2e21b1b2b, 0x3d8a3ce2e21b1b2b, 0x3d8a3ce2e21b1b2b, + 0x3daf3053d19ad2d7, 0x3daf3053d19ad2d7, 0x3daf3053d19ad2d7, 0x3daf3053d19ad2d7, 0xbdb067d617329695, 0xbd905d222aa2423a, 0xbd905d222aa2423a, 0xbd905d222aa2423a, + 0xbd905d222aa2423a, 0xbd905d222aa2423a, 0x3da0728a03c2eaef, 0x3da0728a03c2eaef, 0x3da0728a03c2eaef, 0x3da0728a03c2eaef, 0x3da0728a03c2eaef, 0xbda6ec5ae3290905, + 0xbda6ec5ae3290905, 0xbda6ec5ae3290905, 0xbda6ec5ae3290905, 0xbda6ec5ae3290905, 0x3d6b4c035eb03072, 0x3d6b4c035eb03072, 0x3d6b4c035eb03072, 0x3d6b4c035eb03072, + 0x3d6b4c035eb03072, 0x3daa55db4eff0f13, 0x3daa55db4eff0f13, 0x3daa55db4eff0f13, 0x3daa55db4eff0f13, 0x3daa55db4eff0f13, 0xbd9a12132fd9c9c2, 0xbd9a12132fd9c9c2, + 0xbd9a12132fd9c9c2, 0xbd9a12132fd9c9c2, 0xbd9a12132fd9c9c2, 0x3d973023024e4e57, 0x3d973023024e4e57, 0x3d973023024e4e57, 0x3d973023024e4e57, 0x3d973023024e4e57, + 0xbdabc6d365c4ccc9, 0xbdabc6d365c4ccc9, 0xbdabc6d365c4ccc9, 0xbdabc6d365c4ccc9, 0xbdabc6d365c4ccc9, 0xbd792dc2658605e5, 0xbd792dc2658605e5, 0xbd792dc2658605e5, + 0xbd792dc2658605e5, 0xbd792dc2658605e5, 0xbdb5424e99ce5a58, 0xbdb5424e99ce5a58, 0xbdb5424e99ce5a58, 0xbdb5424e99ce5a58, 0xbdb5424e99ce5a58, 0xbda1e3821a88a8a5, + 0xbda1e3821a88a8a5, 0xbda1e3821a88a8a5, 0xbda1e3821a88a8a5, 0xbda1e3821a88a8a5, 0x3d8af663fa2d8d9e, 0x3d8af663fa2d8d9e, 0x3d8af663fa2d8d9e, 0x3d8af663fa2d8d9e, + 0x3d8af663fa2d8d9e, 0x3daf5eb4179f6f74, 0x3daf5eb4179f6f74, 0x3daf5eb4179f6f74, 0x3daf5eb4179f6f74, 0x3daf5eb4179f6f74, 0x3dbbffe79859bdc0, 0x3dbbffe79859bdc0, + 0x3dbbffe79859bdc0, 0x3dbbffe79859bdc0, 0x3dbbffe79859bdc0, 0xbdb7af8adb1c3c3a, 0xbdb7af8adb1c3c3a, 0xbdb7af8adb1c3c3a, 0xbdb7af8adb1c3c3a, 0xbdb7af8adb1c3c3a, + 0xbda6bdfa9d246c68, 0xbda6bdfa9d246c68, 0xbda6bdfa9d246c68, 0xbda6bdfa9d246c68, 0xbda6bdfa9d246c68, 0x3d6e3207bef9fa3d, 0x3d6e3207bef9fa3d, 0x3d6e3207bef9fa3d, + 0x3d6e3207bef9fa3d, 0x3d6e3207bef9fa3d, 0x3daa843b9503abb0, 0x3daa843b9503abb0, 0x3daa843b9503abb0, 0x3daa843b9503abb0, 0x3daa843b9503abb0, 0x3db992ab570bdbde, + 0x3db992ab570bdbde, 0x3db992ab570bdbde, 0x3db992ab570bdbde, 0x3db992ab570bdbde, 0xbdba1cc71c6a1e1c, 0xbdba1cc71c6a1e1c, 0xbdba1cc71c6a1e1c, 0xbdba1cc71c6a1e1c, + 0xbdba1cc71c6a1e1c, 0xbdab98731fc0302c, 0xbdab98731fc0302c, 0xbdab98731fc0302c, 0xbdab98731fc0302c, 0xbdab98731fc0302c, 0xbd77bac035612100, 0xbd77bac035612100, + 0xbd77bac035612100, 0xbd77bac035612100, 0xbd77bac035612100, 0x3da5a9c31267e7ec, 0x3da5a9c31267e7ec, 0x3da5a9c31267e7ec, 0x3da5a9c31267e7ec, 0x3da5a9c31267e7ec, + 0x3db7256f15bdf9fc, 0x3db7256f15bdf9fc, 0x3db7256f15bdf9fc, 0x3db7256f15bdf9fc, 0x3db7256f15bdf9fc, 0xbdbc8a035db7fffe, 0xbdbc8a035db7fffe, 0xbdbc8a035db7fffe, + 0xbdbc8a035db7fffe, 0xbdbc8a035db7fffe, 0xbdb03975d12df9f8, 0xbdb03975d12df9f8, 0xbdb03975d12df9f8, 0xbdb03975d12df9f8, 0xbdb03975d12df9f8, 0xbd8f4742251f9f8f, + 0xbd8f4742251f9f8f, 0xbd8f4742251f9f8f, 0xbd8f4742251f9f8f, 0xbd8f4742251f9f8f, 0x3da0cf4a8fcc2428, 0x3da0cf4a8fcc2428, 0x3da0cf4a8fcc2428, 0x3da0cf4a8fcc2428, + 0x3da0cf4a8fcc2428, 0x3db4b832d470181a, 0x3db4b832d470181a, 0x3db4b832d470181a, 0x3db4b832d470181a, 0x3db4b832d470181a, 0xbdbef73f9f05e1e0, 0xbdbef73f9f05e1e0, + 0xbdbef73f9f05e1e0, 0x3dc08460307d0f10, 0xbdbef73f9f05e1e0, 0xbdb2a6b2127bdbda, 0xbdb2a6b2127bdbda, 0xbdb2a6b2127bdbda, 0xbdb2a6b2127bdbda, 0xbdb2a6b2127bdbda, + 0xbd99589217c7574f, 0xbd99589217c7574f, 0xbd99589217c7574f, 0xbd99589217c7574f, 0xbd99589217c7574f, 0x3d97e9a41a60c0c9, 0x3d97e9a41a60c0c9, 0x3d97e9a41a60c0c9, + 0x3d97e9a41a60c0c9, 0x3d97e9a41a60c0c9, 0x3db24af693223638, 0x3db24af693223638, 0x3db24af693223638, 0x3db24af693223638, 0x3db24af693223638, 0x3dbe9b841fac3c3e, + 0x3dbe9b841fac3c3e, 0x3dbe9b841fac3c3e, 0x3dbe9b841fac3c3e, 0x3dbe9b841fac3c3e, 0xbdb513ee53c9bdbc, 0xbdb513ee53c9bdbc, 0xbdb513ee53c9bdbc, 0xbdb513ee53c9bdbc, + 0xbdb513ee53c9bdbc, 0xbda186c18e7f6f6b, 0xbda186c18e7f6f6b, 0xbda186c18e7f6f6b, 0xbda186c18e7f6f6b, 0xbda186c18e7f6f6b, 0x3d8c69662a527284, 0x3d8c69662a527284, + 0x3d8c69662a527284, 0x3d8c69662a527284, 0x3d8c69662a527284, 0x3dafbb74a3a8a8ad, 0x3dafbb74a3a8a8ad, 0x3dafbb74a3a8a8ad, 0x3dafbb74a3a8a8ad, 0x3dafbb74a3a8a8ad, + 0x3dbc2e47de5e5a5c, 0x3dbc2e47de5e5a5c, 0x3dbc2e47de5e5a5c, 0x3dbc2e47de5e5a5c, 0x3dbc2e47de5e5a5c, 0xbdb7812a95179f9d, 0xbdb7812a95179f9d, 0xbdb7812a95179f9d, + 0xbdb7812a95179f9d, 0xbdb7812a95179f9d, 0xbda6613a111b332f, 0xbda6613a111b332f, 0xbda6613a111b332f, 0xbda6613a111b332f, 0xbda6613a111b332f, 0x3d71ff083fc6c6e9, + 0x3d71ff083fc6c6e9, 0x3d71ff083fc6c6e9, 0x3d71ff083fc6c6e9, 0x3d71ff083fc6c6e9, 0x3daae0fc210ce4e9, 0x3daae0fc210ce4e9, 0x3daae0fc210ce4e9, 0x3daae0fc210ce4e9, + 0x3daae0fc210ce4e9, 0x3db9c10b9d10787b, 0x3db9c10b9d10787b, 0x3db9c10b9d10787b, 0x3db9c10b9d10787b, 0x3db9c10b9d10787b, 0xbdb9ee66d665817f, 0xbdb9ee66d665817f, +] )) ), + +################ chunk 8704 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4110b382e16925ef, 0x4110b382e16925ef, 0x4110b382e16925ef, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, + 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, + 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110cc0e10d97083, + 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, + 0x4110d0f6b3efe5d4, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, + 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, + 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e981e3603068, 0x4110e981e3603068, 0x4110e981e3603068, + 0x4110e981e3603068, 0x4110e981e3603068, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110f353298d1b0a, + 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f83bcca3905b, 0x4110f83bcca3905b, 0x4110f83bcca3905b, 0x4110f83bcca3905b, + 0x4110f83bcca3905b, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4111020d12d07afc, 0x4111020d12d07afc, + 0x4111020d12d07afc, 0x4111020d12d07afc, 0x4111020d12d07afc, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, + 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x411110c6fc13daef, 0x411110c6fc13daef, 0x411110c6fc13daef, + 0x411110c6fc13daef, 0x411110c6fc13daef, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x41111a984240c590, + 0x41111a984240c590, 0x41111a984240c590, 0x41111a984240c590, 0x41111a984240c590, 0x41111f80e5573ae1, 0x41111f80e5573ae1, 0x41111f80e5573ae1, 0x41111f80e5573ae1, + 0x41111f80e5573ae1, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x411129522b842583, 0x411129522b842583, + 0x411129522b842583, 0x411129522b842583, 0x411129522b842583, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, + 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111380c14c78575, 0x4111380c14c78575, 0x4111380c14c78575, + 0x4111380c14c78575, 0x4111380c14c78575, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x411141dd5af47017, + 0x411141dd5af47017, 0x411141dd5af47017, 0x411141dd5af47017, 0x411141dd5af47017, 0x411146c5fe0ae568, 0x411146c5fe0ae568, 0x411146c5fe0ae568, 0x411146c5fe0ae568, + 0x411146c5fe0ae568, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x411150974437d009, 0x411150974437d009, + 0x411150974437d009, 0x411150974437d009, 0x411150974437d009, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, + 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, + 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x4111692273a81a9d, + 0x4111692273a81a9d, 0x4111692273a81a9d, 0x4111692273a81a9d, 0x4111692273a81a9d, 0x41116e0b16be8fee, 0x41116e0b16be8fee, 0x41116e0b16be8fee, 0x41116e0b16be8fee, + 0x41116e0b16be8fee, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, + 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe0, + 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x41118696462eda82, 0x41118696462eda82, 0x41118696462eda82, + 0x41118696462eda82, 0x41118696462eda82, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x411190678c5bc524, + 0x411190678c5bc524, 0x411190678c5bc524, 0x411190678c5bc524, 0x411190678c5bc524, 0x411195502f723a75, 0x411195502f723a75, 0x411195502f723a75, 0x411195502f723a75, + 0x411195502f723a75, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119f21759f2516, 0x41119f21759f2516, + 0x41119f21759f2516, 0x41119f21759f2516, 0x41119f21759f2516, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, + 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111addb5ee28509, 0x4111addb5ee28509, 0x4111addb5ee28509, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbdb9ee66d665817f, 0xbdb9ee66d665817f, 0xbdb9ee66d665817f, 0xbdab3bb293b6f6f3, 0xbdab3bb293b6f6f3, 0xbdab3bb293b6f6f3, 0xbdab3bb293b6f6f3, 0xbdab3bb293b6f6f3, + 0xbd74d4bbd5175735, 0xbd74d4bbd5175735, 0xbd74d4bbd5175735, 0xbd74d4bbd5175735, 0xbd74d4bbd5175735, 0x3da606839e712125, 0x3da606839e712125, 0x3da606839e712125, + 0x3da606839e712125, 0x3da606839e712125, 0x3db753cf5bc29699, 0x3db753cf5bc29699, 0x3db753cf5bc29699, 0x3db753cf5bc29699, 0x3db753cf5bc29699, 0xbdbc5ba317b36361, + 0xbdbc5ba317b36361, 0xbdbc5ba317b36361, 0xbdbc5ba317b36361, 0xbdbc5ba317b36361, 0xbdb00b158b295d5b, 0xbdb00b158b295d5b, 0xbdb00b158b295d5b, 0xbdb00b158b295d5b, + 0xbdb00b158b295d5b, 0xbd8dd43ff4fabaa9, 0xbd8dd43ff4fabaa9, 0xbd8dd43ff4fabaa9, 0xbd8dd43ff4fabaa9, 0xbd8dd43ff4fabaa9, 0x3da12c0b1bd55d62, 0x3da12c0b1bd55d62, + 0x3da12c0b1bd55d62, 0x3da12c0b1bd55d62, 0x3da12c0b1bd55d62, 0x3db4e6931a74b4b7, 0x3db4e6931a74b4b7, 0x3db4e6931a74b4b7, 0x3db4e6931a74b4b7, 0x3db4e6931a74b4b7, + 0xbdbec8df59014543, 0xbdbec8df59014543, 0xbdbec8df59014543, 0xbdbec8df59014543, 0xbdbec8df59014543, 0xbdb27851cc773f3d, 0xbdb27851cc773f3d, 0xbdb27851cc773f3d, + 0xbdb27851cc773f3d, 0xbdb27851cc773f3d, 0xbd989f10ffb4e4dc, 0xbd989f10ffb4e4dc, 0xbd989f10ffb4e4dc, 0xbd989f10ffb4e4dc, 0xbd989f10ffb4e4dc, 0x3d98a3253273333c, + 0x3d98a3253273333c, 0x3d98a3253273333c, 0x3d98a3253273333c, 0x3d98a3253273333c, 0x3db27956d926d2d5, 0x3db27956d926d2d5, 0x3db27956d926d2d5, 0x3db27956d926d2d5, + 0x3db27956d926d2d5, 0x3dbec9e465b0d8db, 0x3dbec9e465b0d8db, 0x3dbec9e465b0d8db, 0x3dbec9e465b0d8db, 0x3dbec9e465b0d8db, 0xbdb4e58e0dc5211f, 0xbdb4e58e0dc5211f, + 0xbdb4e58e0dc5211f, 0xbdb4e58e0dc5211f, 0xbdb4e58e0dc5211f, 0xbda12a0102763632, 0xbda12a0102763632, 0xbda12a0102763632, 0xbda12a0102763632, 0xbda12a0102763632, + 0x3d8ddc685a775769, 0x3d8ddc685a775769, 0x3d8ddc685a775769, 0x3d8ddc685a775769, 0x3d8ddc685a775769, 0x3db00c1a97d8f0f3, 0x3db00c1a97d8f0f3, 0x3db00c1a97d8f0f3, + 0x3db00c1a97d8f0f3, 0x3db00c1a97d8f0f3, 0x3dbc5ca82462f6f9, 0x3dbc5ca82462f6f9, 0x3dbc5ca82462f6f9, 0x3dbc5ca82462f6f9, 0x3dbc5ca82462f6f9, 0xbdb752ca4f130301, + 0xbdb752ca4f130301, 0xbdb752ca4f130301, 0xbdb752ca4f130301, 0xbdb752ca4f130301, 0xbda604798511f9f6, 0xbda604798511f9f6, 0xbda604798511f9f6, 0xbda604798511f9f6, + 0xbda604798511f9f6, 0x3d74e50ca01090b4, 0x3d74e50ca01090b4, 0x3d74e50ca01090b4, 0x3d74e50ca01090b4, 0x3d74e50ca01090b4, 0x3dab3dbcad161e23, 0x3dab3dbcad161e23, + 0x3dab3dbcad161e23, 0x3dab3dbcad161e23, 0x3dab3dbcad161e23, 0x3db9ef6be3151517, 0x3db9ef6be3151517, 0x3db9ef6be3151517, 0x3db9ef6be3151517, 0x3db9ef6be3151517, + 0xbdb9c0069060e4e3, 0xbdb9c0069060e4e3, 0xbdb9c0069060e4e3, 0xbdb9c0069060e4e3, 0xbdb9c0069060e4e3, 0xbdaadef207adbdb9, 0xbdaadef207adbdb9, 0xbdaadef207adbdb9, + 0xbdaadef207adbdb9, 0xbdaadef207adbdb9, 0xbd71eeb774cd8d6a, 0xbd71eeb774cd8d6a, 0xbd71eeb774cd8d6a, 0xbd71eeb774cd8d6a, 0xbd71eeb774cd8d6a, 0x3da663442a7a5a5f, + 0x3da663442a7a5a5f, 0x3da663442a7a5a5f, 0x3da663442a7a5a5f, 0x3da663442a7a5a5f, 0x3db7822fa1c73335, 0x3db7822fa1c73335, 0x3db7822fa1c73335, 0x3db7822fa1c73335, + 0x3db7822fa1c73335, 0xbdbc2d42d1aec6c5, 0xbdbc2d42d1aec6c5, 0xbdbc2d42d1aec6c5, 0xbdbc2d42d1aec6c5, 0xbdbc2d42d1aec6c5, 0xbdafb96a8a49817d, 0xbdafb96a8a49817d, + 0xbdafb96a8a49817d, 0xbdafb96a8a49817d, 0xbdafb96a8a49817d, 0xbd8c613dc4d5d5c4, 0xbd8c613dc4d5d5c4, 0xbd8c613dc4d5d5c4, 0xbd8c613dc4d5d5c4, 0xbd8c613dc4d5d5c4, + 0x3da188cba7de969b, 0x3da188cba7de969b, 0x3da188cba7de969b, 0x3da188cba7de969b, 0x3da188cba7de969b, 0x3db514f360795154, 0x3db514f360795154, 0x3db514f360795154, + 0x3db514f360795154, 0x3db514f360795154, 0xbdbe9a7f12fca8a6, 0xbdbe9a7f12fca8a6, 0xbdbe9a7f12fca8a6, 0xbdbe9a7f12fca8a6, 0xbdbe9a7f12fca8a6, 0xbdb249f18672a2a0, + 0xbdb249f18672a2a0, 0xbdb249f18672a2a0, 0xbdb249f18672a2a0, 0xbdb249f18672a2a0, 0xbd97e58fe7a27269, 0xbd97e58fe7a27269, 0xbd97e58fe7a27269, 0xbd97e58fe7a27269, + 0xbd97e58fe7a27269, 0x3d995ca64a85a5af, 0x3d995ca64a85a5af, 0x3d995ca64a85a5af, 0x3d995ca64a85a5af, 0x3d995ca64a85a5af, 0x3db2a7b71f2b6f72, 0x3db2a7b71f2b6f72, + 0x3db2a7b71f2b6f72, 0x3db2a7b71f2b6f72, 0x3db2a7b71f2b6f72, 0x3dbef844abb57578, 0x3dbef844abb57578, 0x3dbef844abb57578, 0x3dbef844abb57578, 0xbdc083ddaa254544, + 0xbdb4b72dc7c08482, 0xbdb4b72dc7c08482, 0xbdb4b72dc7c08482, 0xbdb4b72dc7c08482, 0xbdb4b72dc7c08482, 0xbda0cd40766cfcf8, 0xbda0cd40766cfcf8, 0xbda0cd40766cfcf8, + 0xbda0cd40766cfcf8, 0xbda0cd40766cfcf8, 0x3d8f4f6a8a9c3c4e, 0x3d8f4f6a8a9c3c4e, 0x3d8f4f6a8a9c3c4e, 0x3d8f4f6a8a9c3c4e, 0x3d8f4f6a8a9c3c4e, 0x3db03a7adddd8d90, + 0x3db03a7adddd8d90, 0x3db03a7adddd8d90, 0x3db03a7adddd8d90, 0x3db03a7adddd8d90, 0x3dbc8b086a679396, 0x3dbc8b086a679396, 0x3dbc8b086a679396, 0x3dbc8b086a679396, + 0x3dbc8b086a679396, 0xbdb7246a090e6664, 0xbdb7246a090e6664, 0xbdb7246a090e6664, 0xbdb7246a090e6664, 0xbdb7246a090e6664, 0xbda5a7b8f908c0bc, 0xbda5a7b8f908c0bc, + 0xbda5a7b8f908c0bc, 0xbda5a7b8f908c0bc, 0xbda5a7b8f908c0bc, 0x3d77cb11005a5a7f, 0x3d77cb11005a5a7f, 0x3d77cb11005a5a7f, 0x3d77cb11005a5a7f, 0x3d77cb11005a5a7f, + 0x3dab9a7d391f575c, 0x3dab9a7d391f575c, 0x3dab9a7d391f575c, 0x3dab9a7d391f575c, 0x3dab9a7d391f575c, 0x3dba1dcc2919b1b4, 0x3dba1dcc2919b1b4, 0x3dba1dcc2919b1b4, +] )) ), + +################ chunk 9216 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4111addb5ee28509, 0x4111addb5ee28509, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b7aca50f6faa, + 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111bc954825e4fb, 0x4111bc954825e4fb, 0x4111bc954825e4fb, 0x4111bc954825e4fb, + 0x4111bc954825e4fb, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, + 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, + 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d52077962f8f, 0x4111d52077962f8f, 0x4111d52077962f8f, + 0x4111d52077962f8f, 0x4111d52077962f8f, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111def1bdc31a31, + 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111e3da60d98f81, 0x4111e3da60d98f81, 0x4111e3da60d98f81, 0x4111e3da60d98f81, + 0x4111e3da60d98f81, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111edaba7067a23, 0x4111edaba7067a23, + 0x4111edaba7067a23, 0x4111edaba7067a23, 0x4111edaba7067a23, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, + 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111fc659049da16, 0x4111fc659049da16, 0x4111fc659049da16, + 0x4111fc659049da16, 0x4111fc659049da15, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x41120636d676c4b7, + 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120b1f798d3a08, 0x41120b1f798d3a08, 0x41120b1f798d3a08, 0x41120b1f798d3a08, + 0x41120b1f798d3a08, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411214f0bfba24aa, 0x411214f0bfba24aa, + 0x411214f0bfba24aa, 0x411214f0bfba24aa, 0x411214f0bfba24aa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, + 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x411223aaa8fd849c, 0x411223aaa8fd849c, 0x411223aaa8fd849c, + 0x411223aaa8fd849c, 0x411223aaa8fd849c, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x41122d7bef2a6f3e, + 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x411232649240e48e, 0x411232649240e48e, 0x411232649240e48e, 0x411232649240e48e, + 0x411232649240e48e, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x41123c35d86dcf30, 0x41123c35d86dcf30, + 0x41123c35d86dcf30, 0x41123c35d86dcf30, 0x41123c35d86dcf30, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, + 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x41124aefc1b12f22, 0x41124aefc1b12f22, 0x41124aefc1b12f22, + 0x41124aefc1b12f22, 0x41124aefc1b12f22, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x411254c107de19c4, + 0x411254c107de19c4, 0x411254c107de19c4, 0x411254c107de19c4, 0x411254c107de19c4, 0x411259a9aaf48f15, 0x411259a9aaf48f15, 0x411259a9aaf48f15, 0x411259a9aaf48f15, + 0x411259a9aaf48f15, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x4112637af12179b6, 0x4112637af12179b6, + 0x4112637af12179b6, 0x4112637af12179b6, 0x4112637af12179b6, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, + 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41127234da64d9a9, 0x41127234da64d9a9, 0x41127234da64d9a9, + 0x41127234da64d9a9, 0x41127234da64d9a9, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x41127c062091c44b, + 0x41127c062091c44b, 0x41127c062091c44b, 0x41127c062091c44b, 0x41127c062091c44a, 0x411280eec3a8399b, 0x411280eec3a8399b, 0x411280eec3a8399b, 0x411280eec3a8399b, + 0x411280eec3a8399b, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x41128ac009d5243d, 0x41128ac009d5243d, + 0x41128ac009d5243d, 0x41128ac009d5243d, 0x41128ac009d5243d, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, + 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x41129979f318842f, 0x41129979f318842f, 0x41129979f318842f, + 0x41129979f318842f, 0x41129979f318842f, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x4112a34b39456ed1, + 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a833dc5be422, 0x4112a833dc5be422, 0x4112a833dc5be422, 0x4112a833dc5be422, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3dba1dcc2919b1b4, 0x3dba1dcc2919b1b4, 0xbdb991a64a5c4846, 0xbdb991a64a5c4846, 0xbdb991a64a5c4846, 0xbdb991a64a5c4846, 0xbdb991a64a5c4846, 0xbdaa82317ba48480, + 0xbdaa82317ba48480, 0xbdaa82317ba48480, 0xbdaa82317ba48480, 0xbdaa82317ba48480, 0xbd6e11662907873e, 0xbd6e11662907873e, 0xbd6e11662907873e, 0xbd6e11662907873e, + 0xbd6e11662907873e, 0x3da6c004b6839398, 0x3da6c004b6839398, 0x3da6c004b6839398, 0x3da6c004b6839398, 0x3da6c004b6839398, 0x3db7b08fe7cbcfd2, 0x3db7b08fe7cbcfd2, + 0x3db7b08fe7cbcfd2, 0x3db7b08fe7cbcfd2, 0x3db7b08fe7cbcfd2, 0xbdbbfee28baa2a28, 0xbdbbfee28baa2a28, 0xbdbbfee28baa2a28, 0xbdbbfee28baa2a28, 0xbdbbfee28baa2a28, + 0xbdaf5ca9fe404844, 0xbdaf5ca9fe404844, 0xbdaf5ca9fe404844, 0xbdaf5ca9fe404844, 0xbdaf5ca9fe404844, 0xbd8aee3b94b0f0df, 0xbd8aee3b94b0f0df, 0xbd8aee3b94b0f0df, + 0xbd8aee3b94b0f0df, 0xbd8aee3b94b0f0df, 0x3da1e58c33e7cfd4, 0x3da1e58c33e7cfd4, 0x3da1e58c33e7cfd4, 0x3da1e58c33e7cfd4, 0x3da1e58c33e7cfd4, 0x3db54353a67dedf0, + 0x3db54353a67dedf0, 0x3db54353a67dedf0, 0x3db54353a67dedf0, 0x3db54353a67dedf0, 0xbdbe6c1eccf80c0a, 0xbdbe6c1eccf80c0a, 0xbdbe6c1eccf80c0a, 0xbdbe6c1eccf80c0a, + 0xbdbe6c1eccf80c0a, 0xbdb21b91406e0604, 0xbdb21b91406e0604, 0xbdb21b91406e0604, 0xbdb21b91406e0604, 0xbdb21b91406e0604, 0xbd972c0ecf8ffff7, 0xbd972c0ecf8ffff7, + 0xbd972c0ecf8ffff7, 0xbd972c0ecf8ffff7, 0xbd972c0ecf8ffff7, 0x3d9a162762981821, 0x3d9a162762981821, 0x3d9a162762981821, 0x3d9a162762981821, 0x3d9a162762981821, + 0x3db2d61765300c0e, 0x3db2d61765300c0e, 0x3db2d61765300c0e, 0x3db2d61765300c0e, 0x3db2d61765300c0e, 0x3dbf26a4f1ba1214, 0x3dbf26a4f1ba1214, 0x3dbf26a4f1ba1214, + 0x3dbf26a4f1ba1214, 0xbdc06cad8722f6f6, 0xbdb488cd81bbe7e6, 0xbdb488cd81bbe7e6, 0xbdb488cd81bbe7e6, 0xbdb488cd81bbe7e6, 0xbdb488cd81bbe7e6, 0xbda0707fea63c3bf, + 0xbda0707fea63c3bf, 0xbda0707fea63c3bf, 0xbda0707fea63c3bf, 0xbda0707fea63c3bf, 0x3d9061365d60909a, 0x3d9061365d60909a, 0x3d9061365d60909a, 0x3d9061365d60909a, + 0x3d9061365d60909a, 0x3db068db23e22a2c, 0x3db068db23e22a2c, 0x3db068db23e22a2c, 0x3db068db23e22a2c, 0x3db068db23e22a2c, 0x3dbcb968b06c3033, 0x3dbcb968b06c3033, + 0x3dbcb968b06c3033, 0x3dbcb968b06c3033, 0x3dbcb968b06c3033, 0xbdb6f609c309c9c7, 0xbdb6f609c309c9c7, 0xbdb6f609c309c9c7, 0xbdb6f609c309c9c7, 0xbdb6f609c309c9c7, + 0xbda54af86cff8783, 0xbda54af86cff8783, 0xbda54af86cff8783, 0xbda54af86cff8783, 0xbda54af86cff8783, 0x3d7ab11560a4244a, 0x3d7ab11560a4244a, 0x3d7ab11560a4244a, + 0x3d7ab11560a4244a, 0x3d7ab11560a4244a, 0x3dabf73dc5289095, 0x3dabf73dc5289095, 0x3dabf73dc5289095, 0x3dabf73dc5289095, 0x3dabf73dc5289095, 0x3dba4c2c6f1e4e51, + 0x3dba4c2c6f1e4e51, 0x3dba4c2c6f1e4e51, 0x3dba4c2c6f1e4e51, 0x3dba4c2c6f1e4e51, 0xbdb963460457aba9, 0xbdb963460457aba9, 0xbdb963460457aba9, 0xbdb963460457aba9, + 0xbdb963460457aba9, 0xbdaa2570ef9b4b47, 0xbdaa2570ef9b4b47, 0xbdaa2570ef9b4b47, 0xbdaa2570ef9b4b47, 0xbdaa2570ef9b4b47, 0xbd68455d6873f3a9, 0xbd68455d6873f3a9, + 0xbd68455d6873f3a9, 0xbd68455d6873f3a9, 0xbd68455d6873f3a9, 0x3da71cc5428cccd2, 0x3da71cc5428cccd2, 0x3da71cc5428cccd2, 0x3da71cc5428cccd2, 0x3da71cc5428cccd2, + 0x3db7def02dd06c6f, 0x3db7def02dd06c6f, 0x3db7def02dd06c6f, 0x3db7def02dd06c6f, 0x3db7def02dd06c6f, 0xbdbbd08245a58d8b, 0xbdbbd08245a58d8b, 0xbdbbd08245a58d8b, + 0xbdbbd08245a58d8b, 0xbdbbd08245a58d8b, 0xbdaeffe972370f0a, 0xbdaeffe972370f0a, 0xbdaeffe972370f0a, 0xbdaeffe972370f0a, 0xbdaeffe972370f0a, 0xbd897b39648c0bf9, + 0xbd897b39648c0bf9, 0xbd897b39648c0bf9, 0xbd897b39648c0bf9, 0xbd897b39648c0bf9, 0x3da2424cbff1090e, 0x3da2424cbff1090e, 0x3da2424cbff1090e, 0x3da2424cbff1090e, + 0x3da2424cbff1090e, 0x3db571b3ec828a8d, 0x3db571b3ec828a8d, 0x3db571b3ec828a8d, 0x3db571b3ec828a8d, 0x3db571b3ec828a8d, 0xbdbe3dbe86f36f6d, 0xbdbe3dbe86f36f6d, + 0xbdbe3dbe86f36f6d, 0xbdbe3dbe86f36f6d, 0xbdbe3dbe86f36f6d, 0xbdb1ed30fa696967, 0xbdb1ed30fa696967, 0xbdb1ed30fa696967, 0xbdb1ed30fa696967, 0xbdb1ed30fa696967, + 0xbd96728db77d8d84, 0xbd96728db77d8d84, 0xbd96728db77d8d84, 0xbd96728db77d8d84, 0xbd96728db77d8d84, 0x3d9acfa87aaa8a94, 0x3d9acfa87aaa8a94, 0x3d9acfa87aaa8a94, + 0x3d9acfa87aaa8a94, 0x3d9acfa87aaa8a94, 0x3db30477ab34a8ab, 0x3db30477ab34a8ab, 0x3db30477ab34a8ab, 0x3db30477ab34a8ab, 0x3db30477ab34a8ab, 0x3dbf550537beaeb1, + 0x3dbf550537beaeb1, 0x3dbf550537beaeb1, 0x3dbf550537beaeb1, 0xbdc0557d6420a8a7, 0xbdb45a6d3bb74b49, 0xbdb45a6d3bb74b49, 0xbdb45a6d3bb74b49, 0xbdb45a6d3bb74b49, + 0xbdb45a6d3bb74b49, 0xbda013bf5e5a8a86, 0xbda013bf5e5a8a86, 0xbda013bf5e5a8a86, 0xbda013bf5e5a8a86, 0xbda013bf5e5a8a86, 0x3d911ab77573030d, 0x3d911ab77573030d, + 0x3d911ab77573030d, 0x3d911ab77573030d, 0x3d911ab77573030d, 0x3db0973b69e6c6c9, 0x3db0973b69e6c6c9, 0x3db0973b69e6c6c9, 0x3db0973b69e6c6c9, 0x3db0973b69e6c6c9, + 0x3dbce7c8f670cccf, 0x3dbce7c8f670cccf, 0x3dbce7c8f670cccf, 0x3dbce7c8f670cccf, 0x3dbce7c8f670cccf, 0xbdb6c7a97d052d2b, 0xbdb6c7a97d052d2b, 0xbdb6c7a97d052d2b, + 0xbdb6c7a97d052d2b, 0xbdb6c7a97d052d2b, 0xbda4ee37e0f64e4a, 0xbda4ee37e0f64e4a, 0xbda4ee37e0f64e4a, 0xbda4ee37e0f64e4a, 0xbda4ee37e0f64e4a, 0x3d7d9719c0edee14, + 0x3d7d9719c0edee14, 0x3d7d9719c0edee14, 0x3d7d9719c0edee14, 0x3d7d9719c0edee14, 0x3dac53fe5131c9cf, 0x3dac53fe5131c9cf, 0x3dac53fe5131c9cf, 0x3dac53fe5131c9cf, +] )) ), + +################ chunk 9728 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4112a833dc5be422, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112b2052288cec3, 0x4112b2052288cec3, + 0x4112b2052288cec3, 0x4112b2052288cec3, 0x4112b2052288cec3, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, + 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, + 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112ca9051f91957, + 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, + 0x4112cf78f50f8ea8, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, + 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, + 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e804247fd93c, 0x4112e804247fd93c, 0x4112e804247fd93c, + 0x4112e804247fd93c, 0x4112e804247fd93c, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112f1d56aacc3de, + 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, + 0x4112f6be0dc3392f, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae7f, 0x4113008f53f023d0, 0x4113008f53f023d0, + 0x4113008f53f023d0, 0x4113008f53f023d0, 0x4113008f53f023d0, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, + 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130f493d3383c3, 0x41130f493d3383c3, 0x41130f493d3383c3, + 0x41130f493d3383c3, 0x41130f493d3383c3, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x4113191a83606e64, + 0x4113191a83606e64, 0x4113191a83606e64, 0x4113191a83606e64, 0x4113191a83606e64, 0x41131e032676e3b5, 0x41131e032676e3b5, 0x41131e032676e3b5, 0x41131e032676e3b5, + 0x41131e032676e3b5, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411327d46ca3ce57, 0x411327d46ca3ce57, + 0x411327d46ca3ce57, 0x411327d46ca3ce57, 0x411327d46ca3ce57, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, + 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x40774475ad031dbf, 0x40774475ad031dbf, 0x40774475ad031dbf, + 0x40774475ad031dc0, 0x40774475ad031dbf, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x4089156a569a0b02, + 0x4089156a569a0b02, 0x4089156a569a0b02, 0x4089156a569a0b02, 0x4089156a569a0b02, 0x408fcf0216a64913, 0x408fcf0216a64913, 0x408fcf0216a64913, 0x408fcf0216a64913, + 0x408fcf0216a64913, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4096a118cb5f629a, 0x4096a118cb5f629a, + 0x4096a118cb5f629a, 0x4096a118cb5f629a, 0x4096a118cb5f629a, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, + 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, + 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a3b88a15befee2, + 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a566f005c20e67, 0x40a566f005c20e67, 0x40a566f005c20e67, 0x40a566f005c20e67, + 0x40a566f005c20e67, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, + 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, + 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, + 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40b095dccaebbd82, + 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, + 0x40b16d0fc2ed4544, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, + 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3dac53fe5131c9cf, 0x3dba7a8cb522eaed, 0x3dba7a8cb522eaed, 0x3dba7a8cb522eaed, 0x3dba7a8cb522eaed, 0x3dba7a8cb522eaed, 0xbdb934e5be530f0d, 0xbdb934e5be530f0d, + 0xbdb934e5be530f0d, 0xbdb934e5be530f0d, 0xbdb934e5be530f0d, 0xbda9c8b06392120d, 0xbda9c8b06392120d, 0xbda9c8b06392120d, 0xbda9c8b06392120d, 0xbda9c8b06392120d, + 0xbd627954a7e06013, 0xbd627954a7e06013, 0xbd627954a7e06013, 0xbd627954a7e06013, 0xbd627954a7e06013, 0x3da77985ce96060b, 0x3da77985ce96060b, 0x3da77985ce96060b, + 0x3da77985ce96060b, 0x3da77985ce96060b, 0x3db80d5073d5090b, 0x3db80d5073d5090b, 0x3db80d5073d5090b, 0x3db80d5073d5090b, 0x3db80d5073d5090b, 0xbdbba221ffa0f0ef, + 0xbdbba221ffa0f0ef, 0xbdbba221ffa0f0ef, 0xbdbba221ffa0f0ef, 0xbdbba221ffa0f0ef, 0xbdaea328e62dd5d1, 0xbdaea328e62dd5d1, 0xbdaea328e62dd5d1, 0xbdaea328e62dd5d1, + 0xbdaea328e62dd5d1, 0xbd88083734672714, 0xbd88083734672714, 0xbd88083734672714, 0xbd88083734672714, 0xbd88083734672714, 0x3da29f0d4bfa4247, 0x3da29f0d4bfa4247, + 0x3da29f0d4bfa4247, 0x3da29f0d4bfa4247, 0x3da29f0d4bfa4247, 0x3db5a0143287272a, 0x3db5a0143287272a, 0x3db5a0143287272a, 0x3db5a0143287272a, 0x3db5a0143287272a, + 0xbdbe0f5e40eed2d0, 0xbdbe0f5e40eed2d0, 0xbdbe0f5e40eed2d0, 0xbdbe0f5e40eed2d0, 0xbdbe0f5e40eed2d0, 0xbdb1bed0b464ccca, 0xbdb1bed0b464ccca, 0xbdb1bed0b464ccca, + 0xbdb1bed0b464ccca, 0xbdb1bed0b464ccca, 0xbd95b90c9f6b1b11, 0xbd95b90c9f6b1b11, 0xbd95b90c9f6b1b11, 0xbd95b90c9f6b1b11, 0xbd95b90c9f6b1b11, 0x3d9b892992bcfd07, + 0x3d9b892992bcfd07, 0x3d9b892992bcfd07, 0x3d9b892992bcfd07, 0x3d9b892992bcfd07, 0x3db332d7f1394548, 0x3db332d7f1394548, 0x3db332d7f1394548, 0x3db332d7f1394548, + 0x3db332d7f1394548, 0x3dbf83657dc34b4e, 0x3dbf83657dc34b4e, 0x3dbf83657dc34b4e, 0x3dbf83657dc34b4e, 0xbdc03e4d411e5a59, 0xbdb42c0cf5b2aeac, 0xbdb42c0cf5b2aeac, + 0xbdb42c0cf5b2aeac, 0xbdb42c0cf5b2aeac, 0xbdb42c0cf5b2aeac, 0xbd9f6dfda4a2a299, 0xbd9f6dfda4a2a299, 0xbd9f6dfda4a2a299, 0xbd9f6dfda4a2a299, 0xbd9f6dfda4a2a299, + 0x3d91d4388d85757f, 0x3d91d4388d85757f, 0x3d91d4388d85757f, 0x3d91d4388d85757f, 0x3d91d4388d85757f, 0x3db0c59bafeb6366, 0x3db0c59bafeb6366, 0x3db0c59bafeb6366, + 0x3db0c59bafeb6366, 0x3db0c59bafeb6366, 0x3dbd16293c75696c, 0x3dbd16293c75696c, 0x3dbd16293c75696c, 0x3dbd16293c75696c, 0x3dbd16293c75696c, 0xbdb699493700908e, + 0xbdb699493700908e, 0xbdb699493700908e, 0xbdb699493700908e, 0xbdb699493700908e, 0xbda4917754ed1510, 0xbda4917754ed1510, 0xbda4917754ed1510, 0xbda4917754ed1510, + 0xbda4917754ed1510, 0x3d803e8f109bdbf0, 0x3d803e8f109bdbf0, 0x3d803e8f109bdbf0, 0x3d803e8f109bdbf0, 0x3d803e8f109bdbf0, 0x3dacb0bedd3b0308, 0x3dacb0bedd3b0308, + 0x3dacb0bedd3b0308, 0x3dacb0bedd3b0308, 0x3dacb0bedd3b0308, 0x3dbaa8ecfb27878a, 0x3dbaa8ecfb27878a, 0x3dbaa8ecfb27878a, 0x3dbaa8ecfb27878a, 0x3dbaa8ecfb27878a, + 0x3cd1b19140c0c0d5, 0x3cd1b19140c0c0d5, 0x3cd1b19140c0c0d5, 0x3cd1b19140c0c0d5, 0x3cd1b19140c0c0d5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd211ba218b020c7, 0xbd211ba218b020c7, 0xbd211ba218b020c7, 0xbd211ba218b020c7, 0xbd211ba218b020c7, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d21a9b7a75a3b87, 0x3d21a9b7a75a3b87, 0x3d21a9b7a75a3b87, 0x3d21a9b7a75a3b87, + 0x3d21a9b7a75a3b87, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d36e41964fdd4dc, 0x3d36e41964fdd4dc, + 0x3d36e41964fdd4dc, 0x3d36e41964fdd4dc, 0x3d36e41964fdd4dc, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd369d0e9da8c77c, 0xbd369d0e9da8c77c, 0xbd369d0e9da8c77c, 0xbd369d0e9da8c77c, 0xbd369d0e9da8c77c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d365603d653ba1c, 0x3d365603d653ba1c, 0x3d365603d653ba1c, 0x3d365603d653ba1c, 0x3d365603d653ba1c, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d44f8837880a9a2, 0x3d44f8837880a9a2, 0x3d44f8837880a9a2, 0x3d44f8837880a9a2, + 0x3d44f8837880a9a2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d35c7ee47a99f5c, 0x3d35c7ee47a99f5c, + 0x3d35c7ee47a99f5c, 0x3d35c7ee47a99f5c, 0x3d35c7ee47a99f5c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d453f8e3fd5b702, 0x3d453f8e3fd5b702, 0x3d453f8e3fd5b702, 0x3d453f8e3fd5b702, 0x3d453f8e3fd5b702, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d3539d8b8ff849b, 0x3d3539d8b8ff849b, 0x3d3539d8b8ff849b, 0x3d3539d8b8ff849b, 0x3d3539d8b8ff849b, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd553cb37c6a9dcf, 0xbd553cb37c6a9dcf, 0xbd553cb37c6a9dcf, 0xbd553cb37c6a9dcf, + 0xbd553cb37c6a9dcf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5ad50f356aa589, 0xbd5ad50f356aa589, + 0xbd5ad50f356aa589, 0xbd5ad50f356aa589, 0xbd5ad50f356aa589, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, +] )) ), + +################ chunk 10240 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, + 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b74f748af7fb93, + 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b826a782f98355, 0x40b826a782f98355, 0x40b826a782f98355, 0x40b826a782f98355, + 0x40b826a782f98355, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, + 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, + 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, + 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40be090c4b0439a4, + 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40bee03f4305c166, 0x40bee03f4305c166, 0x40bee03f4305c166, 0x40bee03f4305c166, + 0x40bee03f4305c166, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40c0475299846875, 0x40c0475299846875, + 0x40c0475299846875, 0x40c0475299846875, 0x40c0475299846875, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, + 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, + 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c2615205883bdb, + 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, + 0x40c2cceb8188ffbc, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c3a41e798a877e, 0x40c3a41e798a877e, + 0x40c3a41e798a877e, 0x40c3a41e798a877e, 0x40c3a41e798a877e, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, + 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, + 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c5be1de58e5ae3, + 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, + 0x40c629b7618f1ec4, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c700ea5990a686, 0x40c700ea5990a686, + 0x40c700ea5990a686, 0x40c700ea5990a686, 0x40c700ea5990a686, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, + 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c843b6cd92f229, 0x40c843b6cd92f229, 0x40c843b6cd92f229, + 0x40c843b6cd92f229, 0x40c843b6cd92f229, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c91ae9c59479ec, + 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c9868341953dcd, 0x40c9868341953dcd, 0x40c9868341953dcd, 0x40c9868341953dcd, + 0x40c9868341953dcd, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40ca5db63996c58f, 0x40ca5db63996c58f, + 0x40ca5db63996c58f, 0x40ca5db63996c58f, 0x40ca5db63996c58f, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, + 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cba082ad991132, 0x40cba082ad991132, 0x40cba082ad991132, + 0x40cba082ad991132, 0x40cba082ad991132, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc77b5a59a98f4, + 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, + 0x40cce34f219b5cd5, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cdba82199ce497, 0x40cdba82199ce497, + 0x40cdba82199ce497, 0x40cdba82199ce497, 0x40cdba82199ce497, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, + 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, + 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cfd48185a0b7fd, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d45cda3ce7fd1c3, 0x3d45cda3ce7fd1c3, 0x3d45cda3ce7fd1c3, 0x3d45cda3ce7fd1c3, 0x3d45cda3ce7fd1c3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d341dad9bab4f1b, 0x3d341dad9bab4f1b, 0x3d341dad9bab4f1b, 0x3d341dad9bab4f1b, 0x3d341dad9bab4f1b, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd54f5a8b515906f, 0xbd54f5a8b515906f, 0xbd54f5a8b515906f, 0xbd54f5a8b515906f, + 0xbd54f5a8b515906f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5b1c19fcbfb2e9, 0xbd5b1c19fcbfb2e9, + 0xbd5b1c19fcbfb2e9, 0xbd5b1c19fcbfb2e9, 0xbd5b1c19fcbfb2e9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d465bb95d29ec83, 0x3d465bb95d29ec83, 0x3d465bb95d29ec83, 0x3d465bb95d29ec83, 0x3d465bb95d29ec83, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d3301827e57199a, 0x3d3301827e57199a, 0x3d3301827e57199a, 0x3d3301827e57199a, 0x3d3301827e57199a, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd54ae9dedc0830e, 0xbd54ae9dedc0830e, 0xbd54ae9dedc0830e, 0xbd54ae9dedc0830e, + 0xbd54ae9dedc0830e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d624e6d9df59fdb, 0x3d624e6d9df59fdb, + 0x3d624e6d9df59fdb, 0x3d624e6d9df59fdb, 0x3d624e6d9df59fdb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd6a458c450afe2f, 0xbd6a458c450afe2f, 0xbd6a458c450afe2f, 0xbd6a458c450afe2f, 0xbd6a458c450afe2f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6dc35513dfa37d, 0xbd6dc35513dfa37d, 0xbd6dc35513dfa37d, 0xbd6dc35513dfa37d, 0xbd6dc35513dfa37d, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d65cc366cca4529, 0x3d65cc366cca4529, 0x3d65cc366cca4529, 0x3d65cc366cca4529, + 0x3d65cc366cca4529, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5baa2f8b69cdaa, 0xbd5baa2f8b69cdaa, + 0xbd5baa2f8b69cdaa, 0xbd5baa2f8b69cdaa, 0xbd5baa2f8b69cdaa, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d4777e47a7e2204, 0x3d4777e47a7e2204, 0x3d4777e47a7e2204, 0x3d4777e47a7e2204, 0x3d4777e47a7e2204, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d30c92c43aeae99, 0x3d30c92c43aeae99, 0x3d30c92c43aeae99, 0x3d30c92c43aeae99, 0x3d30c92c43aeae99, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd5420885f16684e, 0xbd5420885f16684e, 0xbd5420885f16684e, 0xbd5420885f16684e, + 0xbd5420885f16684e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d620762d6a0927b, 0x3d620762d6a0927b, + 0x3d620762d6a0927b, 0x3d620762d6a0927b, 0x3d620762d6a0927b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd69fe817db5f0cf, 0xbd69fe817db5f0cf, 0xbd69fe817db5f0cf, 0xbd69fe817db5f0cf, 0xbd69fe817db5f0cf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6e0a5fdb34b0dd, 0xbd6e0a5fdb34b0dd, 0xbd6e0a5fdb34b0dd, 0xbd6e0a5fdb34b0dd, 0xbd6e0a5fdb34b0dd, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d661341341f5289, 0x3d661341341f5289, 0x3d661341341f5289, 0x3d661341341f5289, + 0x3d661341341f5289, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5c38451a13e86a, 0xbd5c38451a13e86a, + 0xbd5c38451a13e86a, 0xbd5c38451a13e86a, 0xbd5c38451a13e86a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d48940f97d25784, 0x3d48940f97d25784, 0x3d48940f97d25784, 0x3d48940f97d25784, 0x3d48940f97d25784, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d2d21ac120c872f, 0x3d2d21ac120c872f, 0x3d2d21ac120c872f, 0x3d2d21ac120c872f, 0x3d2d21ac120c872f, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd539272d06c4d8e, 0xbd539272d06c4d8e, 0xbd539272d06c4d8e, 0xbd539272d06c4d8e, + 0xbd539272d06c4d8e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d61c0580f4b851b, 0x3d61c0580f4b851b, + 0x3d61c0580f4b851b, 0x3d61c0580f4b851b, 0x3d61c0580f4b851b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd69b776b660e36f, 0xbd69b776b660e36f, 0xbd69b776b660e36f, 0xbd69b776b660e36f, 0xbd69b776b660e36f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6e516aa289be3d, 0xbd6e516aa289be3d, 0xbd6e516aa289be3d, 0xbd6e516aa289be3d, 0xbd6e516aa289be3d, 0xbff0000000000000, +] )) ), + +################ chunk 10752 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, + 0x40d0200d80d0bdef, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, + 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, + 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, + 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d198a6b2d36b83, + 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, + 0x40d1ce7370d3cd73, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d23a0cecd49154, 0x40d23a0cecd49154, + 0x40d23a0cecd49154, 0x40d23a0cecd49154, 0x40d23a0cecd49154, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, + 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2db7326d5b726, 0x40d2db7326d5b726, 0x40d2db7326d5b726, + 0x40d2db7326d5b726, 0x40d2db7326d5b726, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3470ca2d67b07, + 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, + 0x40d37cd960d6dcf7, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, + 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, + 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, + 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4f57292d98a8b, + 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, + 0x40d52b3f50d9ec7c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, + 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, + 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, + 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d6a3d882dc9a0f, + 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, + 0x40d6d9a540dcfc00, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, + 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, + 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, + 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d8523e72dfa994, + 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8880b30e00b84, 0x40d8880b30e00b84, 0x40d8880b30e00b84, 0x40d8880b30e00b84, + 0x40d8880b30e00b84, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, + 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, + 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, + 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40da00a462e2b918, + 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da367120e31b08, 0x40da367120e31b08, 0x40da367120e31b08, 0x40da367120e31b08, + 0x40da367120e31b08, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d665a4bfb745fe9, 0x3d665a4bfb745fe9, 0x3d665a4bfb745fe9, 0x3d665a4bfb745fe9, + 0x3d665a4bfb745fe9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5cc65aa8be032a, 0xbd5cc65aa8be032a, + 0xbd5cc65aa8be032a, 0xbd5cc65aa8be032a, 0xbd5cc65aa8be032a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d49b03ab5268d05, 0x3d49b03ab5268d05, 0x3d49b03ab5268d05, 0x3d49b03ab5268d05, 0x3d49b03ab5268d05, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d28b0ff9cbbb12c, 0x3d28b0ff9cbbb12c, 0x3d28b0ff9cbbb12c, 0x3d28b0ff9cbbb12c, 0x3d28b0ff9cbbb12c, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd53045d41c232cd, 0xbd53045d41c232cd, 0xbd53045d41c232cd, 0xbd53045d41c232cd, + 0xbd53045d41c232cd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d61794d47f677bb, 0x3d61794d47f677bb, + 0x3d61794d47f677bb, 0x3d61794d47f677bb, 0x3d61794d47f677bb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd69706bef0bd60f, 0xbd69706bef0bd60f, 0xbd69706bef0bd60f, 0xbd69706bef0bd60f, 0xbd69706bef0bd60f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d70b3c54b109a31, 0x3d70b3c54b109a31, 0x3d70b3c54b109a31, 0x3d70b3c54b109a31, 0x3d70b3c54b109a31, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd74af549e9b495b, 0xbd74af549e9b495b, 0xbd74af549e9b495b, 0xbd74af549e9b495b, + 0xbd74af549e9b495b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d78aae3f225f885, 0x3d78aae3f225f885, + 0x3d78aae3f225f885, 0x3d78aae3f225f885, 0x3d78aae3f225f885, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd7ca67345b0a7af, 0xbd7ca67345b0a7af, 0xbd7ca67345b0a7af, 0xbd7ca67345b0a7af, 0xbd7ca67345b0a7af, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7f5dfd66c4a927, 0xbd7f5dfd66c4a927, 0xbd7f5dfd66c4a927, 0xbd7f5dfd66c4a927, 0xbd7f5dfd66c4a927, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, + 0x3d7b626e1339f9fd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7766debfaf4ad3, 0xbd7766debfaf4ad3, + 0xbd7766debfaf4ad3, 0xbd7766debfaf4ad3, 0xbd7766debfaf4ad3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d736b4f6c249ba9, 0x3d736b4f6c249ba9, 0x3d736b4f6c249ba9, 0x3d736b4f6c249ba9, 0x3d736b4f6c249ba9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6edf803133d8fd, 0xbd6edf803133d8fd, 0xbd6edf803133d8fd, 0xbd6edf803133d8fd, 0xbd6edf803133d8fd, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d66e8618a1e7aa9, 0x3d66e8618a1e7aa9, 0x3d66e8618a1e7aa9, 0x3d66e8618a1e7aa9, + 0x3d66e8618a1e7aa9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5de285c61238ab, 0xbd5de285c61238ab, + 0xbd5de285c61238ab, 0xbd5de285c61238ab, 0xbd5de285c61238ab, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d4be890efcef806, 0x3d4be890efcef806, 0x3d4be890efcef806, 0x3d4be890efcef806, 0x3d4be890efcef806, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d1f9f4d64340a4e, 0x3d1f9f4d64340a4e, 0x3d1f9f4d64340a4e, 0x3d1f9f4d64340a4e, 0x3d1f9f4d64340a4e, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd51e832246dfd4d, 0xbd51e832246dfd4d, 0xbd51e832246dfd4d, 0xbd51e832246dfd4d, + 0xbd51e832246dfd4d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d60eb37b94c5cfa, 0x3d60eb37b94c5cfa, + 0x3d60eb37b94c5cfa, 0x3d60eb37b94c5cfa, 0x3d60eb37b94c5cfa, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd68e2566061bb4e, 0xbd68e2566061bb4e, 0xbd68e2566061bb4e, 0xbd68e2566061bb4e, 0xbd68e2566061bb4e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d706cba83bb8cd1, 0x3d706cba83bb8cd1, 0x3d706cba83bb8cd1, 0x3d706cba83bb8cd1, 0x3d706cba83bb8cd1, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd746849d7463bfb, 0xbd746849d7463bfb, 0xbd746849d7463bfb, 0xbd746849d7463bfb, + 0xbd746849d7463bfb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7863d92ad0eb25, 0x3d7863d92ad0eb25, +] )) ), + +################ chunk 11264 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, + 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db4370d6e504bb, 0x40db4370d6e504bb, 0x40db4370d6e504bb, + 0x40db4370d6e504bb, 0x40db4370d6e504bb, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40dbaf0a52e5c89c, + 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, + 0x40dbe4d710e62a8d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, + 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, + 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, + 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd5d7042e8d820, + 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd933d00e93a11, 0x40dd933d00e93a11, 0x40dd933d00e93a11, 0x40dd933d00e93a11, + 0x40dd933d00e93a11, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, + 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, + 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, + 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40df0bd632ebe7a5, + 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, + 0x40df41a2f0ec4995, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, + 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, + 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e02751537719a4, 0x40e02751537719a4, 0x40e02751537719a4, + 0x40e02751537719a4, 0x40e02751537719a4, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e05d1e11777b94, + 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e078047077ac8d, 0x40e078047077ac8d, 0x40e078047077ac8d, 0x40e078047077ac8d, + 0x40e078047077ac8d, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e0add12e780e7d, 0x40e0add12e780e7d, + 0x40e0add12e780e7d, 0x40e0add12e780e7d, 0x40e0add12e780e7d, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, + 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0fe844b78a166, 0x40e0fe844b78a166, 0x40e0fe844b78a166, + 0x40e0fe844b78a166, 0x40e0fe844b78a166, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1345109790357, + 0x40e1345109790357, 0x40e1345109790357, 0x40e1345109790357, 0x40e1345109790357, 0x40e14f376879344f, 0x40e14f376879344f, 0x40e14f376879344f, 0x40e14f376879344f, + 0x40e14f376879344f, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e185042679963f, 0x40e185042679963f, + 0x40e185042679963f, 0x40e185042679963f, 0x40e185042679963f, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, + 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, + 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e20b84017a8b19, + 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e2266a607abc11, 0x40e2266a607abc11, 0x40e2266a607abc11, 0x40e2266a607abc11, + 0x40e2266a607abc11, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, + 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, + 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d7863d92ad0eb25, 0x3d7863d92ad0eb25, 0x3d7863d92ad0eb25, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd7c5f687e5b9a4f, 0xbd7c5f687e5b9a4f, 0xbd7c5f687e5b9a4f, 0xbd7c5f687e5b9a4f, 0xbd7c5f687e5b9a4f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7fa5082e19b687, 0xbd7fa5082e19b687, 0xbd7fa5082e19b687, 0xbd7fa5082e19b687, 0xbd7fa5082e19b687, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7ba978da8f075d, 0x3d7ba978da8f075d, 0x3d7ba978da8f075d, 0x3d7ba978da8f075d, + 0x3d7ba978da8f075d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd77ade987045833, 0xbd77ade987045833, + 0xbd77ade987045833, 0xbd77ade987045833, 0xbd77ade987045833, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d73b25a3379a909, 0x3d73b25a3379a909, 0x3d73b25a3379a909, 0x3d73b25a3379a909, 0x3d73b25a3379a909, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6f6d95bfddf3be, 0xbd6f6d95bfddf3be, 0xbd6f6d95bfddf3be, 0xbd6f6d95bfddf3be, 0xbd6f6d95bfddf3be, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d67767718c8956a, 0x3d67767718c8956a, 0x3d67767718c8956a, 0x3d67767718c8956a, + 0x3d67767718c8956a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5efeb0e3666e2c, 0xbd5efeb0e3666e2c, + 0xbd5efeb0e3666e2c, 0xbd5efeb0e3666e2c, 0xbd5efeb0e3666e2c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d4e20e72a776307, 0x3d4e20e72a776307, 0x3d4e20e72a776307, 0x3d4e20e72a776307, 0x3d4e20e72a776307, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d0bb9371de16488, 0x3d0bb9371de16488, 0x3d0bb9371de16488, 0x3d0bb9371de16488, 0x3d0bb9371de16488, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd50cc070719c7cc, 0xbd50cc070719c7cc, 0xbd50cc070719c7cc, 0xbd50cc070719c7cc, + 0xbd50cc070719c7cc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d605d222aa2423a, 0x3d605d222aa2423a, + 0x3d605d222aa2423a, 0x3d605d222aa2423a, 0x3d605d222aa2423a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d89eaefcb9217dc, 0x3d89eaefcb9217dc, 0x3d89eaefcb9217dc, 0x3d89eaefcb9217dc, 0x3d89eaefcb9217dc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7025afbc667f71, 0x3d7025afbc667f71, 0x3d7025afbc667f71, 0x3d7025afbc667f71, 0x3d7025afbc667f71, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d85ef60780768b2, 0x3d85ef60780768b2, 0x3d85ef60780768b2, 0x3d85ef60780768b2, + 0x3d85ef60780768b2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d781cce637bddc5, 0x3d781cce637bddc5, + 0x3d781cce637bddc5, 0x3d781cce637bddc5, 0x3d781cce637bddc5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d81f3d1247cb989, 0x3d81f3d1247cb989, 0x3d81f3d1247cb989, 0x3d81f3d1247cb989, 0x3d81f3d1247cb989, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8009f685489e0c, 0x3d8009f685489e0c, 0x3d8009f685489e0c, 0x3d8009f685489e0c, 0x3d8009f685489e0c, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7bf083a1e414bd, 0x3d7bf083a1e414bd, 0x3d7bf083a1e414bd, 0x3d7bf083a1e414bd, + 0x3d7bf083a1e414bd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d840585d8d34d36, 0x3d840585d8d34d36, + 0x3d840585d8d34d36, 0x3d840585d8d34d36, 0x3d840585d8d34d36, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d73f964faceb669, 0x3d73f964faceb669, 0x3d73f964faceb669, 0x3d73f964faceb669, 0x3d73f964faceb669, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8801152c5dfc60, 0x3d8801152c5dfc60, 0x3d8801152c5dfc60, 0x3d8801152c5dfc60, 0x3d8801152c5dfc60, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d68048ca772b02a, 0x3d68048ca772b02a, 0x3d68048ca772b02a, 0x3d68048ca772b02a, + 0x3d68048ca772b02a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8bfca47fe8ab8a, 0x3d8bfca47fe8ab8a, + 0x3d8bfca47fe8ab8a, 0x3d8bfca47fe8ab8a, 0x3d8bfca47fe8ab8a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d502c9eb28fe704, 0x3d502c9eb28fe704, 0x3d502c9eb28fe704, 0x3d502c9eb28fe704, 0x3d502c9eb28fe704, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 11776 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e3, 0x40e2c7d09a7be1e2, 0x40e2e2b6f97c12db, + 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, + 0x40e2fd9d587c43d3, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, + 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, + 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e3841d337d38ac, 0x40e3841d337d38ac, 0x40e3841d337d38ac, + 0x40e3841d337d38ac, 0x40e3841d337d38ac, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e3b9e9f17d9a9d, + 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, + 0x40e3d4d0507dcb95, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, + 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, + 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, + 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e4911ce97f225f, + 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4ac03487f5357, 0x40e4ac03487f5357, 0x40e4ac03487f5357, 0x40e4ac03487f5357, + 0x40e4ac03487f5357, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, + 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, + 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5328323804831, 0x40e5328323804831, 0x40e5328323804831, + 0x40e5328323804831, 0x40e5328323804831, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e5684fe180aa21, + 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e583364080db19, 0x40e583364080db19, 0x40e583364080db19, 0x40e583364080db19, + 0x40e583364080db19, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, + 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, + 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e609b61b81cff3, 0x40e609b61b81cff3, 0x40e609b61b81cff3, + 0x40e609b61b81cff3, 0x40e609b61b81cff3, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e63f82d98231e3, + 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e65a69388262dc, 0x40e65a69388262dc, 0x40e65a69388262dc, 0x40e65a69388262dc, + 0x40e65a69388262dc, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e69035f682c4cc, 0x40e69035f682c4cc, + 0x40e69035f682c4cc, 0x40e69035f682c4cc, 0x40e69035f682c4cc, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, + 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, + 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e716b5d183b9a5, + 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, + 0x40e7319c3083ea9e, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e76768ee844c8e, 0x40e76768ee844c8e, + 0x40e76768ee844c8e, 0x40e76768ee844c8e, 0x40e76768ee844c8e, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, + 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, + 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7ede8c9854168, + 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e808cf28857260, 0x40e808cf28857260, 0x40e808cf28857260, 0x40e808cf28857260, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8ff833d3735ab4, 0x3d8ff833d3735ab4, 0x3d8ff833d3735ab4, 0xbd9003e6164652a6, 0x3d8ff833d3735ab4, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4f5fb7d38b2497, 0xbd4f5fb7d38b2497, 0xbd4f5fb7d38b2497, 0xbd4f5fb7d38b2497, + 0xbd4f5fb7d38b2497, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8c0c3cd901f622, 0xbd8c0c3cd901f622, + 0xbd8c0c3cd901f622, 0xbd8c0c3cd901f622, 0xbd8c0c3cd901f622, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd67c62b430d85ce, 0xbd67c62b430d85ce, 0xbd67c62b430d85ce, 0xbd67c62b430d85ce, 0xbd67c62b430d85ce, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8810ad857746f8, 0xbd8810ad857746f8, 0xbd8810ad857746f8, 0xbd8810ad857746f8, 0xbd8810ad857746f8, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd73da34489c213b, 0xbd73da34489c213b, 0xbd73da34489c213b, 0xbd73da34489c213b, + 0xbd73da34489c213b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd84151e31ec97ce, 0xbd84151e31ec97ce, + 0xbd84151e31ec97ce, 0xbd84151e31ec97ce, 0xbd84151e31ec97ce, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd7bd152efb17f8f, 0xbd7bd152efb17f8f, 0xbd7bd152efb17f8f, 0xbd7bd152efb17f8f, 0xbd7bd152efb17f8f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd80198ede61e8a4, 0xbd80198ede61e8a4, 0xbd80198ede61e8a4, 0xbd80198ede61e8a4, 0xbd80198ede61e8a4, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd81e438cb636ef1, 0xbd81e438cb636ef1, 0xbd81e438cb636ef1, 0xbd81e438cb636ef1, + 0xbd81e438cb636ef1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd783bff15ae72f3, 0xbd783bff15ae72f3, + 0xbd783bff15ae72f3, 0xbd783bff15ae72f3, 0xbd783bff15ae72f3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd85dfc81eee1e1b, 0xbd85dfc81eee1e1b, 0xbd85dfc81eee1e1b, 0xbd85dfc81eee1e1b, 0xbd85dfc81eee1e1b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7044e06e99149f, 0xbd7044e06e99149f, 0xbd7044e06e99149f, 0xbd7044e06e99149f, 0xbd7044e06e99149f, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd89db577278cd45, 0xbd89db577278cd45, 0xbd89db577278cd45, 0xbd89db577278cd45, + 0xbd89db577278cd45, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd609b838f076c96, 0xbd609b838f076c96, + 0xbd609b838f076c96, 0xbd609b838f076c96, 0xbd609b838f076c96, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd8dd6e6c6037c6f, 0xbd8dd6e6c6037c6f, 0xbd8dd6e6c6037c6f, 0xbd8dd6e6c6037c6f, 0xbd8dd6e6c6037c6f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd15a8c81b95fdd0, 0xbd15a8c81b95fdd0, 0xbd15a8c81b95fdd0, 0xbd15a8c81b95fdd0, 0xbd15a8c81b95fdd0, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8e2d89e671d467, 0x3d8e2d89e671d467, 0x3d8e2d89e671d467, 0x3d8e2d89e671d467, + 0x3d8e2d89e671d467, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d5e81ee1a9c1973, 0x3d5e81ee1a9c1973, + 0x3d5e81ee1a9c1973, 0x3d5e81ee1a9c1973, 0x3d5e81ee1a9c1973, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d8a31fa92e7253d, 0x3d8a31fa92e7253d, 0x3d8a31fa92e7253d, 0x3d8a31fa92e7253d, 0x3d8a31fa92e7253d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6f2f345b78c961, 0x3d6f2f345b78c961, 0x3d6f2f345b78c961, 0x3d6f2f345b78c961, 0x3d6f2f345b78c961, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d86366b3f5c7613, 0x3d86366b3f5c7613, 0x3d86366b3f5c7613, 0x3d86366b3f5c7613, + 0x3d86366b3f5c7613, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d778eb8d4d1c305, 0x3d778eb8d4d1c305, + 0x3d778eb8d4d1c305, 0x3d778eb8d4d1c305, 0x3d778eb8d4d1c305, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d823adbebd1c6e9, 0x3d823adbebd1c6e9, 0x3d823adbebd1c6e9, 0x3d823adbebd1c6e9, 0x3d823adbebd1c6e9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7f85d77be72159, 0x3d7f85d77be72159, 0x3d7f85d77be72159, 0x3d7f85d77be72159, 0x3d7f85d77be72159, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7c7e99308e2f7d, 0x3d7c7e99308e2f7d, 0x3d7c7e99308e2f7d, 0x3d7c7e99308e2f7d, +] )) ), + +################ chunk 12288 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40e808cf28857260, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e83e9be685d450, 0x40e83e9be685d450, + 0x40e83e9be685d450, 0x40e83e9be685d450, 0x40e83e9be685d450, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, + 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e88f4f03866739, 0x40e88f4f03866739, 0x40e88f4f03866739, + 0x40e88f4f03866739, 0x40e88f4f03866739, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8c51bc186c92a, + 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8e0022086fa22, 0x40e8e0022086fa22, 0x40e8e0022086fa22, 0x40e8e0022086fa22, + 0x40e8e0022086fa22, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e915cede875c12, 0x40e915cede875c12, + 0x40e915cede875c12, 0x40e915cede875c12, 0x40e915cede875c12, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, + 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e96681fb87eefb, 0x40e96681fb87eefb, 0x40e96681fb87eefb, + 0x40e96681fb87eefb, 0x40e96681fb87eefb, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e99c4eb98850ec, + 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e9b735188881e4, 0x40e9b735188881e4, 0x40e9b735188881e4, 0x40e9b735188881e4, + 0x40e9b735188881e4, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, + 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, + 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, + 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea7381b189d8ae, + 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, + 0x40ea8e68108a09a6, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, + 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, + 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, + 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb4ab4a98b6070, + 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb659b088b9168, 0x40eb659b088b9168, 0x40eb659b088b9168, 0x40eb659b088b9168, + 0x40eb659b088b9168, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, + 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, + 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, + 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec21e7a18ce832, + 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec3cce008d192a, 0x40ec3cce008d192a, 0x40ec3cce008d192a, 0x40ec3cce008d192a, + 0x40ec3cce008d192a, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, + 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, + 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, + 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecf91a998e6ff4, + 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, + 0x40ed1400f88ea0ed, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, + 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d7c7e99308e2f7d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d83be7b117e3fd6, 0x3d83be7b117e3fd6, + 0x3d83be7b117e3fd6, 0x3d83be7b117e3fd6, 0x3d83be7b117e3fd6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d74877a8978d129, 0x3d74877a8978d129, 0x3d74877a8978d129, 0x3d74877a8978d129, 0x3d74877a8978d129, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d87ba0a6508ef00, 0x3d87ba0a6508ef00, 0x3d87ba0a6508ef00, 0x3d87ba0a6508ef00, 0x3d87ba0a6508ef00, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6920b7c4c6e5ab, 0x3d6920b7c4c6e5ab, 0x3d6920b7c4c6e5ab, 0x3d6920b7c4c6e5ab, + 0x3d6920b7c4c6e5ab, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8bb599b8939e2a, 0x3d8bb599b8939e2a, + 0x3d8bb599b8939e2a, 0x3d8bb599b8939e2a, 0x3d8bb599b8939e2a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d5264f4ed385206, 0x3d5264f4ed385206, 0x3d5264f4ed385206, 0x3d5264f4ed385206, 0x3d5264f4ed385206, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8fb1290c1e4d54, 0x3d8fb1290c1e4d54, 0x3d8fb1290c1e4d54, 0x3d8fb1290c1e4d54, 0x3d8fb1290c1e4d54, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4aef0b5e3a4e95, 0xbd4aef0b5e3a4e95, 0xbd4aef0b5e3a4e95, 0xbd4aef0b5e3a4e95, + 0xbd4aef0b5e3a4e95, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8c5347a0570382, 0xbd8c5347a0570382, + 0xbd8c5347a0570382, 0xbd8c5347a0570382, 0xbd8c5347a0570382, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd66aa0025b9504d, 0xbd66aa0025b9504d, 0xbd66aa0025b9504d, 0xbd66aa0025b9504d, 0xbd66aa0025b9504d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8857b84ccc5458, 0xbd8857b84ccc5458, 0xbd8857b84ccc5458, 0xbd8857b84ccc5458, 0xbd8857b84ccc5458, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd734c1eb9f2067b, 0xbd734c1eb9f2067b, 0xbd734c1eb9f2067b, 0xbd734c1eb9f2067b, + 0xbd734c1eb9f2067b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd845c28f941a52e, 0xbd845c28f941a52e, + 0xbd845c28f941a52e, 0xbd845c28f941a52e, 0xbd845c28f941a52e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd7b433d610764cf, 0xbd7b433d610764cf, 0xbd7b433d610764cf, 0xbd7b433d610764cf, 0xbd7b433d610764cf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd806099a5b6f604, 0xbd806099a5b6f604, 0xbd806099a5b6f604, 0xbd806099a5b6f604, 0xbd806099a5b6f604, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd819d2e040e6191, 0xbd819d2e040e6191, 0xbd819d2e040e6191, 0xbd819d2e040e6191, + 0xbd819d2e040e6191, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd78ca14a4588db4, 0xbd78ca14a4588db4, + 0xbd78ca14a4588db4, 0xbd78ca14a4588db4, 0xbd78ca14a4588db4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd8598bd579910bb, 0xbd8598bd579910bb, 0xbd8598bd579910bb, 0xbd8598bd579910bb, 0xbd8598bd579910bb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd70d2f5fd432f60, 0xbd70d2f5fd432f60, 0xbd70d2f5fd432f60, 0xbd70d2f5fd432f60, 0xbd70d2f5fd432f60, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd89944cab23bfe5, 0xbd89944cab23bfe5, 0xbd89944cab23bfe5, 0xbd89944cab23bfe5, + 0xbd89944cab23bfe5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd61b7aeac5ba217, 0xbd61b7aeac5ba217, + 0xbd61b7aeac5ba217, 0xbd61b7aeac5ba217, 0xbd61b7aeac5ba217, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd8d8fdbfeae6f0f, 0xbd8d8fdbfeae6f0f, 0xbd8d8fdbfeae6f0f, 0xbd8d8fdbfeae6f0f, 0xbd8d8fdbfeae6f0f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd2c9715e30e56f2, 0xbd2c9715e30e56f2, 0xbd2c9715e30e56f2, 0xbd2c9715e30e56f2, 0xbd2c9715e30e56f2, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8e7494adc6e1c7, 0x3d8e7494adc6e1c7, 0x3d8e7494adc6e1c7, 0x3d8e7494adc6e1c7, + 0x3d8e7494adc6e1c7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d5c4997dff3ae72, 0x3d5c4997dff3ae72, + 0x3d5c4997dff3ae72, 0x3d5c4997dff3ae72, 0x3d5c4997dff3ae72, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, +] )) ), + +################ chunk 12800 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, + 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edd04d918ff7b6, + 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edeb33f09028af, 0x40edeb33f09028af, 0x40edeb33f09028af, 0x40edeb33f09028af, + 0x40edeb33f09028af, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, + 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, + 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, + 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40eea78089917f79, + 0x40eea78089917f79, 0x40eea78089917f79, 0x40eea78089917f79, 0x40eea78089917f79, 0x40eec266e891b071, 0x40eec266e891b071, 0x40eec266e891b071, 0x40eec266e891b071, + 0x40eec266e891b071, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eef833a6921261, 0x40eef833a6921261, + 0x40eef833a6921261, 0x40eef833a6921261, 0x40eef833a6921261, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, + 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, + 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef7eb38193073b, + 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, + 0x40ef9999e0933833, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efcf669e939a23, 0x40efcf669e939a23, + 0x40efcf669e939a23, 0x40efcf669e939a23, 0x40efcf669e939a23, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, + 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f0100cddca1686, 0x40f0100cddca1686, 0x40f0100cddca1686, + 0x40f0100cddca1686, 0x40f0100cddca1686, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f02af33cca477e, + 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, + 0x40f038666c4a5ffb, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, + 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, + 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f07ba659cada67, 0x40f07ba659cada67, 0x40f07ba659cada67, + 0x40f07ba659cada67, 0x40f07ba659cada67, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f0968cb8cb0b5f, + 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, + 0x40f0a3ffe84b23dc, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, + 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, + 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, + 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f1022634cbcf41, + 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f10f99644be7bd, 0x40f10f99644be7bd, 0x40f10f99644be7bd, 0x40f10f99644be7bd, + 0x40f10f99644be7bd, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, + 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, + 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f152d951cc6229, 0x40f152d951cc6229, 0x40f152d951cc6229, + 0x40f152d951cc6229, 0x40f152d951cc6229, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f16dbfb0cc9322, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d8a79055a3c329d, 0x3d8a79055a3c329d, 0x3d8a79055a3c329d, 0x3d8a79055a3c329d, 0x3d8a79055a3c329d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6e13093e2493e1, 0x3d6e13093e2493e1, 0x3d6e13093e2493e1, 0x3d6e13093e2493e1, 0x3d6e13093e2493e1, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d867d7606b18373, 0x3d867d7606b18373, 0x3d867d7606b18373, 0x3d867d7606b18373, + 0x3d867d7606b18373, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7700a34627a844, 0x3d7700a34627a844, + 0x3d7700a34627a844, 0x3d7700a34627a844, 0x3d7700a34627a844, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d8281e6b326d449, 0x3d8281e6b326d449, 0x3d8281e6b326d449, 0x3d8281e6b326d449, 0x3d8281e6b326d449, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7ef7c1ed3d0698, 0x3d7ef7c1ed3d0698, 0x3d7ef7c1ed3d0698, 0x3d7ef7c1ed3d0698, 0x3d7ef7c1ed3d0698, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7d0caebf384a3e, 0x3d7d0caebf384a3e, 0x3d7d0caebf384a3e, 0x3d7d0caebf384a3e, + 0x3d7d0caebf384a3e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8377704a293276, 0x3d8377704a293276, + 0x3d8377704a293276, 0x3d8377704a293276, 0x3d8377704a293276, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d7515901822ebea, 0x3d7515901822ebea, 0x3d7515901822ebea, 0x3d7515901822ebea, 0x3d7515901822ebea, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8772ff9db3e1a0, 0x3d8772ff9db3e1a0, 0x3d8772ff9db3e1a0, 0x3d8772ff9db3e1a0, 0x3d8772ff9db3e1a0, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, + 0x3d6a3ce2e21b1b2b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8b6e8ef13e90ca, 0x3d8b6e8ef13e90ca, + 0x3d8b6e8ef13e90ca, 0x3d8b6e8ef13e90ca, 0x3d8b6e8ef13e90ca, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d549d4b27e0bd07, 0x3d549d4b27e0bd07, 0x3d549d4b27e0bd07, 0x3d549d4b27e0bd07, 0x3d549d4b27e0bd07, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8f6a1e44c93ff4, 0x3d8f6a1e44c93ff4, 0x3d8f6a1e44c93ff4, 0x3d8f6a1e44c93ff4, 0x3d8f6a1e44c93ff4, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9f4c0d08b8b43b, 0x3d9f4c0d08b8b43b, 0x3d9f4c0d08b8b43b, 0x3d9f4c0d08b8b43b, + 0x3d9f4c0d08b8b43b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8c9a5267ac10e2, 0xbd8c9a5267ac10e2, + 0xbd8c9a5267ac10e2, 0xbd8c9a5267ac10e2, 0xbd8c9a5267ac10e2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd658dd508651acc, 0xbd658dd508651acc, 0xbd658dd508651acc, 0xbd658dd508651acc, 0xbd658dd508651acc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d93b09e75ef4f24, 0x3d93b09e75ef4f24, 0x3d93b09e75ef4f24, 0x3d93b09e75ef4f24, 0x3d93b09e75ef4f24, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9b507db52e0511, 0x3d9b507db52e0511, 0x3d9b507db52e0511, 0x3d9b507db52e0511, + 0x3d9b507db52e0511, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd84a333c096b28e, 0xbd84a333c096b28e, + 0xbd84a333c096b28e, 0xbd84a333c096b28e, 0xbd84a333c096b28e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd7ab527d25d4a0e, 0xbd7ab527d25d4a0e, 0xbd7ab527d25d4a0e, 0xbd7ab527d25d4a0e, 0xbd7ab527d25d4a0e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d97ac2dc979fe4e, 0x3d97ac2dc979fe4e, 0x3d97ac2dc979fe4e, 0x3d97ac2dc979fe4e, 0x3d97ac2dc979fe4e, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9754ee61a355e7, 0x3d9754ee61a355e7, 0x3d9754ee61a355e7, 0x3d9754ee61a355e7, + 0x3d9754ee61a355e7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd79582a3302a874, 0xbd79582a3302a874, + 0xbd79582a3302a874, 0xbd79582a3302a874, 0xbd79582a3302a874, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd8551b29044035b, 0xbd8551b29044035b, 0xbd8551b29044035b, 0xbd8551b29044035b, 0xbd8551b29044035b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9ba7bd1d04ad78, 0x3d9ba7bd1d04ad78, 0x3d9ba7bd1d04ad78, 0x3d9ba7bd1d04ad78, 0x3d9ba7bd1d04ad78, 0xbff0000000000000, +] )) ), + +################ chunk 13312 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, + 0x40f17b32e04cab9e, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f196193f4cdc96, 0x40f196193f4cdc96, + 0x40f196193f4cdc96, 0x40f196193f4cdc96, 0x40f196193f4cdc96, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, + 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, + 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1d9592ccd5703, + 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, + 0x40f1e6cc5c4d6f7f, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f201b2bb4da077, 0x40f201b2bb4da077, + 0x40f201b2bb4da077, 0x40f201b2bb4da077, 0x40f201b2bb4da077, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, + 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, + 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f244f2a8ce1ae4, + 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f25265d84e3360, 0x40f25265d84e3360, 0x40f25265d84e3360, 0x40f25265d84e3360, + 0x40f25265d84e3360, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f26d4c374e6458, 0x40f26d4c374e6458, + 0x40f26d4c374e6458, 0x40f26d4c374e6458, 0x40f26d4c374e6458, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, + 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, + 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2b08c24cedec5, + 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2bdff544ef741, 0x40f2bdff544ef741, 0x40f2bdff544ef741, 0x40f2bdff544ef741, + 0x40f2bdff544ef741, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, + 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, + 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, + 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f31c25a0cfa2a6, + 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f32998d04fbb22, 0x40f32998d04fbb22, 0x40f32998d04fbb22, 0x40f32998d04fbb22, + 0x40f32998d04fbb22, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, + 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, + 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, + 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f387bf1cd06687, + 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f395324c507f03, 0x40f395324c507f03, 0x40f395324c507f03, 0x40f395324c507f03, + 0x40f395324c507f03, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3b018ab50affb, 0x40f3b018ab50affb, + 0x40f3b018ab50affb, 0x40f3b018ab50affb, 0x40f3b018ab50affb, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, + 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3d87239d0f970, 0x40f3d87239d0f970, 0x40f3d87239d0f970, + 0x40f3d87239d0f970, 0x40f3d87239d0f970, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3f35898d12a68, + 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f400cbc85142e4, 0x40f400cbc85142e4, 0x40f400cbc85142e4, 0x40f400cbc85142e4, + 0x40f400cbc85142e4, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f41bb2275173dc, 0x40f41bb2275173dc, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d93595f0e18a6bd, 0x3d93595f0e18a6bd, 0x3d93595f0e18a6bd, 0x3d93595f0e18a6bd, + 0x3d93595f0e18a6bd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd62d3d9c9afd798, 0xbd62d3d9c9afd798, + 0xbd62d3d9c9afd798, 0xbd62d3d9c9afd798, 0xbd62d3d9c9afd798, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd8d48d1375961af, 0xbd8d48d1375961af, 0xbd8d48d1375961af, 0xbd8d48d1375961af, 0xbd8d48d1375961af, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9fa34c708f5ca2, 0x3d9fa34c708f5ca2, 0x3d9fa34c708f5ca2, 0x3d9fa34c708f5ca2, 0x3d9fa34c708f5ca2, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8ebb9f751bef27, 0x3d8ebb9f751bef27, 0x3d8ebb9f751bef27, 0x3d8ebb9f751bef27, + 0x3d8ebb9f751bef27, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d5a1141a54b4370, 0x3d5a1141a54b4370, + 0x3d5a1141a54b4370, 0x3d5a1141a54b4370, 0x3d5a1141a54b4370, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd929ff7ef376002, 0xbd929ff7ef376002, 0xbd929ff7ef376002, 0xbd929ff7ef376002, 0xbd929ff7ef376002, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9c61243be5f434, 0xbd9c61243be5f434, 0xbd9c61243be5f434, 0xbd9c61243be5f434, 0xbd9c61243be5f434, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d86c480ce0690d3, 0x3d86c480ce0690d3, 0x3d86c480ce0690d3, 0x3d86c480ce0690d3, + 0x3d86c480ce0690d3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d76728db77d8d84, 0x3d76728db77d8d84, + 0x3d76728db77d8d84, 0x3d76728db77d8d84, 0x3d76728db77d8d84, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd969b8742c20f2c, 0xbd969b8742c20f2c, 0xbd969b8742c20f2c, 0xbd969b8742c20f2c, 0xbd969b8742c20f2c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd986594e85b450a, 0xbd986594e85b450a, 0xbd986594e85b450a, 0xbd986594e85b450a, 0xbd986594e85b450a, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7d9ac44de264fe, 0x3d7d9ac44de264fe, 0x3d7d9ac44de264fe, 0x3d7d9ac44de264fe, + 0x3d7d9ac44de264fe, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d83306582d42516, 0x3d83306582d42516, + 0x3d83306582d42516, 0x3d83306582d42516, 0x3d83306582d42516, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd9a9716964cbe55, 0xbd9a9716964cbe55, 0xbd9a9716964cbe55, 0xbd9a9716964cbe55, 0xbd9a9716964cbe55, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd946a0594d095e0, 0xbd946a0594d095e0, 0xbd946a0594d095e0, 0xbd946a0594d095e0, 0xbd946a0594d095e0, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6b590dff6f50ac, 0x3d6b590dff6f50ac, 0x3d6b590dff6f50ac, 0x3d6b590dff6f50ac, + 0x3d6b590dff6f50ac, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8b278429e9836a, 0x3d8b278429e9836a, + 0x3d8b278429e9836a, 0x3d8b278429e9836a, 0x3d8b278429e9836a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd9e92a5e9d76d7f, 0xbd9e92a5e9d76d7f, 0xbd9e92a5e9d76d7f, 0xbd9e92a5e9d76d7f, 0xbd9e92a5e9d76d7f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd906e764145e6b6, 0xbd906e764145e6b6, 0xbd906e764145e6b6, 0xbd906e764145e6b6, 0xbd906e764145e6b6, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd420db27398a290, 0xbd420db27398a290, 0xbd420db27398a290, 0xbd420db27398a290, + 0xbd420db27398a290, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d918f51687f70df, 0x3d918f51687f70df, + 0x3d918f51687f70df, 0x3d918f51687f70df, 0x3d918f51687f70df, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d9d71cac29de357, 0x3d9d71cac29de357, 0x3d9d71cac29de357, 0x3d9d71cac29de357, 0x3d9d71cac29de357, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd88e5cddb766f18, 0xbd88e5cddb766f18, 0xbd88e5cddb766f18, 0xbd88e5cddb766f18, 0xbd88e5cddb766f18, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd722ff39c9dd0fa, 0xbd722ff39c9dd0fa, 0xbd722ff39c9dd0fa, 0xbd722ff39c9dd0fa, + 0xbd722ff39c9dd0fa, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d958ae0bc0a2009, 0x3d958ae0bc0a2009, +] )) ), + +################ chunk 13824 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f41bb2275173dc, 0x40f41bb2275173dc, 0x40f41bb2275173dc, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, + 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, + 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f45ef214d1ee49, + 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f46c65445206c5, 0x40f46c65445206c5, 0x40f46c65445206c5, 0x40f46c65445206c5, + 0x40f46c65445206c5, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f4874ba35237bd, 0x40f4874ba35237bd, + 0x40f4874ba35237bd, 0x40f4874ba35237bd, 0x40f4874ba35237bd, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, + 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4afa531d28132, 0x40f4afa531d28132, 0x40f4afa531d28132, + 0x40f4afa531d28132, 0x40f4afa531d28132, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4ca8b90d2b22a, + 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, + 0x40f4d7fec052caa6, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, + 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, + 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f51b3eadd34513, 0x40f51b3eadd34513, 0x40f51b3eadd34513, + 0x40f51b3eadd34513, 0x40f51b3eadd34513, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f536250cd3760b, + 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f543983c538e87, 0x40f543983c538e87, 0x40f543983c538e87, 0x40f543983c538e87, + 0x40f543983c538e87, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, + 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, + 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f586d829d408f4, 0x40f586d829d408f4, 0x40f586d829d408f4, + 0x40f586d829d408f4, 0x40f586d829d408f4, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5a1be88d439ec, + 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5af31b8545268, 0x40f5af31b8545268, 0x40f5af31b8545268, 0x40f5af31b8545268, + 0x40f5af31b8545268, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5ca1817548361, 0x40f5ca1817548361, + 0x40f5ca1817548361, 0x40f5ca1817548361, 0x40f5ca1817548361, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, + 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, + 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f60d5804d4fdcd, + 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f61acb34551649, 0x40f61acb34551649, 0x40f61acb34551649, 0x40f61acb34551649, + 0x40f61acb34551649, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f635b193554742, 0x40f635b193554742, + 0x40f635b193554742, 0x40f635b193554742, 0x40f635b193554742, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, + 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, + 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f678f180d5c1ae, + 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f68664b055da2a, 0x40f68664b055da2a, 0x40f68664b055da2a, 0x40f68664b055da2a, + 0x40f68664b055da2a, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, + 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, + 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d958ae0bc0a2009, 0x3d958ae0bc0a2009, 0x3d958ae0bc0a2009, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d99763b6f13342d, 0x3d99763b6f13342d, 0x3d99763b6f13342d, 0x3d99763b6f13342d, 0x3d99763b6f13342d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd80eeaf346110c4, 0xbd80eeaf346110c4, 0xbd80eeaf346110c4, 0xbd80eeaf346110c4, 0xbd80eeaf346110c4, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd810f18756446d1, 0xbd810f18756446d1, 0xbd810f18756446d1, 0xbd810f18756446d1, + 0xbd810f18756446d1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9986700f94cf33, 0x3d9986700f94cf33, + 0x3d9986700f94cf33, 0x3d9986700f94cf33, 0x3d9986700f94cf33, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d957aac1b888503, 0x3d957aac1b888503, 0x3d957aac1b888503, 0x3d957aac1b888503, 0x3d957aac1b888503, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd71ef211a9764e0, 0xbd71ef211a9764e0, 0xbd71ef211a9764e0, 0xbd71ef211a9764e0, 0xbd71ef211a9764e0, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8906371c79a525, 0xbd8906371c79a525, 0xbd8906371c79a525, 0xbd8906371c79a525, + 0xbd8906371c79a525, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9d81ff631f7e5d, 0x3d9d81ff631f7e5d, + 0x3d9d81ff631f7e5d, 0x3d9d81ff631f7e5d, 0x3d9d81ff631f7e5d, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d917f1cc7fdd5d9, 0x3d917f1cc7fdd5d9, 0x3d917f1cc7fdd5d9, 0x3d917f1cc7fdd5d9, 0x3d917f1cc7fdd5d9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd40071e636541c2, 0xbd40071e636541c2, 0xbd40071e636541c2, 0xbd40071e636541c2, 0xbd40071e636541c2, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd907eaae1c781bc, 0xbd907eaae1c781bc, 0xbd907eaae1c781bc, 0xbd907eaae1c781bc, + 0xbd907eaae1c781bc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9e82714955d279, 0xbd9e82714955d279, + 0xbd9e82714955d279, 0xbd9e82714955d279, 0xbd9e82714955d279, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d8b071ae8e64d5d, 0x3d8b071ae8e64d5d, 0x3d8b071ae8e64d5d, 0x3d8b071ae8e64d5d, 0x3d8b071ae8e64d5d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6bdab3037c28df, 0x3d6bdab3037c28df, 0x3d6bdab3037c28df, 0x3d6bdab3037c28df, 0x3d6bdab3037c28df, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd947a3a355230e6, 0xbd947a3a355230e6, 0xbd947a3a355230e6, 0xbd947a3a355230e6, + 0xbd947a3a355230e6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9a86e1f5cb234f, 0xbd9a86e1f5cb234f, + 0xbd9a86e1f5cb234f, 0xbd9a86e1f5cb234f, 0xbd9a86e1f5cb234f, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d830ffc41d0ef09, 0x3d830ffc41d0ef09, 0x3d830ffc41d0ef09, 0x3d830ffc41d0ef09, 0x3d830ffc41d0ef09, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7ddb96cfe8d118, 0x3d7ddb96cfe8d118, 0x3d7ddb96cfe8d118, 0x3d7ddb96cfe8d118, 0x3d7ddb96cfe8d118, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9875c988dce010, 0xbd9875c988dce010, 0xbd9875c988dce010, 0xbd9875c988dce010, + 0xbd9875c988dce010, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd968b52a2407425, 0xbd968b52a2407425, + 0xbd968b52a2407425, 0xbd968b52a2407425, 0xbd968b52a2407425, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d7631bb3577216a, 0x3d7631bb3577216a, 0x3d7631bb3577216a, 0x3d7631bb3577216a, 0x3d7631bb3577216a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d86e4ea0f09c6e0, 0x3d86e4ea0f09c6e0, 0x3d86e4ea0f09c6e0, 0x3d86e4ea0f09c6e0, 0x3d86e4ea0f09c6e0, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9c7158dc678f3a, 0xbd9c7158dc678f3a, 0xbd9c7158dc678f3a, 0xbd9c7158dc678f3a, + 0xbd9c7158dc678f3a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd928fc34eb5c4fb, 0xbd928fc34eb5c4fb, + 0xbd928fc34eb5c4fb, 0xbd928fc34eb5c4fb, 0xbd928fc34eb5c4fb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d590df79d319309, 0x3d590df79d319309, 0x3d590df79d319309, 0x3d590df79d319309, 0x3d590df79d319309, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 14336 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6e48afcd6858f, + 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, + 0x40f6f1fe2c569e0c, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, + 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, + 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f7353e19d71878, 0x40f7353e19d71878, 0x40f7353e19d71878, + 0x40f7353e19d71878, 0x40f7353e19d71878, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f7502478d74970, + 0x40f7502478d74970, 0x40f7502478d74970, 0x40f7502478d74970, 0x40f7502478d74970, 0x40f75d97a85761ed, 0x40f75d97a85761ed, 0x40f75d97a85761ed, 0x40f75d97a85761ed, + 0x40f75d97a85761ed, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f7787e075792e5, 0x40f7787e075792e5, + 0x40f7787e075792e5, 0x40f7787e075792e5, 0x40f7787e075792e5, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, + 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, + 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7bbbdf4d80d51, + 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7c931245825ce, 0x40f7c931245825ce, 0x40f7c931245825ce, 0x40f7c931245825ce, + 0x40f7c931245825ce, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7e417835856c6, 0x40f7e417835856c6, + 0x40f7e417835856c6, 0x40f7e417835856c6, 0x40f7e417835856c6, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, + 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, + 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f8275770d8d133, + 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f834caa058e9af, 0x40f834caa058e9af, 0x40f834caa058e9af, 0x40f834caa058e9af, + 0x40f834caa058e9af, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, + 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, + 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, + 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f892f0ecd99514, + 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, + 0x40f8a0641c59ad90, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, + 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, + 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, + 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8fe8a68da58f5, + 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f90bfd985a7171, 0x40f90bfd985a7171, 0x40f90bfd985a7171, 0x40f90bfd985a7171, + 0x40f90bfd985a7171, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f926e3f75aa269, 0x40f926e3f75aa269, + 0x40f926e3f75aa269, 0x40f926e3f75aa269, 0x40f926e3f75aa269, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, + 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, + 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f96a23e4db1cd6, + 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f97797145b3552, 0x40f97797145b3552, 0x40f97797145b3552, 0x40f97797145b3552, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8edc08b61f2534, 0x3d8edc08b61f2534, 0x3d8edc08b61f2534, 0x3d8edc08b61f2534, 0x3d8edc08b61f2534, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9f9317d00dc19c, 0x3d9f9317d00dc19c, 0x3d9f9317d00dc19c, 0x3d9f9317d00dc19c, + 0x3d9f9317d00dc19c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8d2867f6562ba2, 0xbd8d2867f6562ba2, + 0xbd8d2867f6562ba2, 0xbd8d2867f6562ba2, 0xbd8d2867f6562ba2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd63557ecdbcafcb, 0xbd63557ecdbcafcb, 0xbd63557ecdbcafcb, 0xbd63557ecdbcafcb, 0xbd63557ecdbcafcb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d936993ae9a41c4, 0x3d936993ae9a41c4, 0x3d936993ae9a41c4, 0x3d936993ae9a41c4, 0x3d936993ae9a41c4, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9b97887c831272, 0x3d9b97887c831272, 0x3d9b97887c831272, 0x3d9b97887c831272, + 0x3d9b97887c831272, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8531494f40cd4e, 0xbd8531494f40cd4e, + 0xbd8531494f40cd4e, 0xbd8531494f40cd4e, 0xbd8531494f40cd4e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd7998fcb509148e, 0xbd7998fcb509148e, 0xbd7998fcb509148e, 0xbd7998fcb509148e, 0xbd7998fcb509148e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9765230224f0ee, 0x3d9765230224f0ee, 0x3d9765230224f0ee, 0x3d9765230224f0ee, 0x3d9765230224f0ee, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d979bf928f86348, 0x3d979bf928f86348, 0x3d979bf928f86348, 0x3d979bf928f86348, + 0x3d979bf928f86348, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7a74555056ddf4, 0xbd7a74555056ddf4, + 0xbd7a74555056ddf4, 0xbd7a74555056ddf4, 0xbd7a74555056ddf4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd84c39d0199e89b, 0xbd84c39d0199e89b, 0xbd84c39d0199e89b, 0xbd84c39d0199e89b, 0xbd84c39d0199e89b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9b60b255afa018, 0x3d9b60b255afa018, 0x3d9b60b255afa018, 0x3d9b60b255afa018, 0x3d9b60b255afa018, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d93a069d56db41e, 0x3d93a069d56db41e, 0x3d93a069d56db41e, 0x3d93a069d56db41e, + 0x3d93a069d56db41e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd650c3004584299, 0xbd650c3004584299, + 0xbd650c3004584299, 0xbd650c3004584299, 0xbd650c3004584299, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd8cbabba8af46ef, 0xbd8cbabba8af46ef, 0xbd8cbabba8af46ef, 0xbd8cbabba8af46ef, 0xbd8cbabba8af46ef, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9f5c41a93a4f42, 0x3d9f5c41a93a4f42, 0x3d9f5c41a93a4f42, 0x3d9f5c41a93a4f42, 0x3d9f5c41a93a4f42, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8f49b503c609e7, 0x3d8f49b503c609e7, 0x3d8f49b503c609e7, 0x3d8f49b503c609e7, + 0x3d8f49b503c609e7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d55a0952ffa6d6e, 0x3d55a0952ffa6d6e, + 0x3d55a0952ffa6d6e, 0x3d55a0952ffa6d6e, 0x3d55a0952ffa6d6e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd9258ed27e252a1, 0xbd9258ed27e252a1, 0xbd9258ed27e252a1, 0xbd9258ed27e252a1, 0xbd9258ed27e252a1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9ca82f033b0194, 0xbd9ca82f033b0194, 0xbd9ca82f033b0194, 0xbd9ca82f033b0194, 0xbd9ca82f033b0194, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8752965cb0ab93, 0x3d8752965cb0ab93, 0x3d8752965cb0ab93, 0x3d8752965cb0ab93, + 0x3d8752965cb0ab93, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7556629a295803, 0x3d7556629a295803, + 0x3d7556629a295803, 0x3d7556629a295803, 0x3d7556629a295803, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd96547c7b6d01cb, 0xbd96547c7b6d01cb, 0xbd96547c7b6d01cb, 0xbd96547c7b6d01cb, 0xbd96547c7b6d01cb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd98ac9fafb0526a, 0xbd98ac9fafb0526a, 0xbd98ac9fafb0526a, 0xbd98ac9fafb0526a, 0xbd98ac9fafb0526a, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7eb6ef6b369a7f, 0x3d7eb6ef6b369a7f, 0x3d7eb6ef6b369a7f, 0x3d7eb6ef6b369a7f, +] )) ), + +################ chunk 14848 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f97797145b3552, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9927d735b664a, 0x40f9927d735b664a, + 0x40f9927d735b664a, 0x40f9927d735b664a, 0x40f9927d735b664a, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, + 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, + 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9d5bd60dbe0b7, + 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9e330905bf933, 0x40f9e330905bf933, 0x40f9e330905bf933, 0x40f9e330905bf933, + 0x40f9e330905bf933, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, + 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, + 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, + 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa4156dcdca498, + 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, + 0x40fa4eca0c5cbd14, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, + 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, + 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, + 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40faacf058dd6879, + 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faba63885d80f5, 0x40faba63885d80f5, 0x40faba63885d80f5, 0x40faba63885d80f5, + 0x40faba63885d80f5, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fad549e75db1ed, 0x40fad549e75db1ed, + 0x40fad549e75db1ed, 0x40fad549e75db1ed, 0x40fad549e75db1ed, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, + 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40fafda375ddfb62, 0x40fafda375ddfb62, 0x40fafda375ddfb62, + 0x40fafda375ddfb62, 0x40fafda375ddfb62, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb1889d4de2c5a, + 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, + 0x40fb25fd045e44d6, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, + 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, + 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb693cf1debf43, 0x40fb693cf1debf43, 0x40fb693cf1debf43, + 0x40fb693cf1debf43, 0x40fb693cf1debf43, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb842350def03b, + 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb9196805f08b7, 0x40fb9196805f08b7, 0x40fb9196805f08b7, 0x40fb9196805f08b7, + 0x40fb9196805f08b7, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, + 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, + 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, + 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbefbcccdfb41c, + 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, + 0x40fbfd2ffc5fcc98, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, + 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d7eb6ef6b369a7f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d82a24ff42a0a56, 0x3d82a24ff42a0a56, + 0x3d82a24ff42a0a56, 0x3d82a24ff42a0a56, 0x3d82a24ff42a0a56, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd9a500bcef7b0f5, 0xbd9a500bcef7b0f5, 0xbd9a500bcef7b0f5, 0xbd9a500bcef7b0f5, 0xbd9a500bcef7b0f5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd94b1105c25a340, 0xbd94b1105c25a340, 0xbd94b1105c25a340, 0xbd94b1105c25a340, 0xbd94b1105c25a340, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6d91643a17bbad, 0x3d6d91643a17bbad, 0x3d6d91643a17bbad, 0x3d6d91643a17bbad, + 0x3d6d91643a17bbad, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8a996e9b3f68aa, 0x3d8a996e9b3f68aa, + 0x3d8a996e9b3f68aa, 0x3d8a996e9b3f68aa, 0x3d8a996e9b3f68aa, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd9e4b9b2282601f, 0xbd9e4b9b2282601f, 0xbd9e4b9b2282601f, 0xbd9e4b9b2282601f, 0xbd9e4b9b2282601f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd90b581089af416, 0xbd90b581089af416, 0xbd90b581089af416, 0xbd90b581089af416, 0xbd90b581089af416, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd3258b311eded15, 0xbd3258b311eded15, 0xbd3258b311eded15, 0xbd3258b311eded15, + 0xbd3258b311eded15, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d914846a12a637f, 0x3d914846a12a637f, + 0x3d914846a12a637f, 0x3d914846a12a637f, 0x3d914846a12a637f, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d9db8d589f2f0b7, 0x3d9db8d589f2f0b7, 0x3d9db8d589f2f0b7, 0x3d9db8d589f2f0b7, 0x3d9db8d589f2f0b7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8973e36a2089d8, 0xbd8973e36a2089d8, 0xbd8973e36a2089d8, 0xbd8973e36a2089d8, 0xbd8973e36a2089d8, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7113c87f499b79, 0xbd7113c87f499b79, 0xbd7113c87f499b79, 0xbd7113c87f499b79, + 0xbd7113c87f499b79, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9543d5f4b512a9, 0x3d9543d5f4b512a9, + 0x3d9543d5f4b512a9, 0x3d9543d5f4b512a9, 0x3d9543d5f4b512a9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d99bd463668418d, 0x3d99bd463668418d, 0x3d99bd463668418d, 0x3d99bd463668418d, 0x3d99bd463668418d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd817cc4c30b2b84, 0xbd817cc4c30b2b84, 0xbd817cc4c30b2b84, 0xbd817cc4c30b2b84, 0xbd817cc4c30b2b84, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd808102e6ba2c11, 0xbd808102e6ba2c11, 0xbd808102e6ba2c11, 0xbd808102e6ba2c11, + 0xbd808102e6ba2c11, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d993f65483fc1d3, 0x3d993f65483fc1d3, + 0x3d993f65483fc1d3, 0x3d993f65483fc1d3, 0x3d993f65483fc1d3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d95c1b6e2dd9263, 0x3d95c1b6e2dd9263, 0x3d95c1b6e2dd9263, 0x3d95c1b6e2dd9263, 0x3d95c1b6e2dd9263, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd730b4c37eb9a61, 0xbd730b4c37eb9a61, 0xbd730b4c37eb9a61, 0xbd730b4c37eb9a61, 0xbd730b4c37eb9a61, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8878218dcf8a65, 0xbd8878218dcf8a65, 0xbd8878218dcf8a65, 0xbd8878218dcf8a65, + 0xbd8878218dcf8a65, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9d3af49bca70fd, 0x3d9d3af49bca70fd, + 0x3d9d3af49bca70fd, 0x3d9d3af49bca70fd, 0x3d9d3af49bca70fd, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d91c6278f52e339, 0x3d91c6278f52e339, 0x3d91c6278f52e339, 0x3d91c6278f52e339, 0x3d91c6278f52e339, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd48e8774e06edc7, 0xbd48e8774e06edc7, 0xbd48e8774e06edc7, 0xbd48e8774e06edc7, 0xbd48e8774e06edc7, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9037a01a72745c, 0xbd9037a01a72745c, 0xbd9037a01a72745c, 0xbd9037a01a72745c, + 0xbd9037a01a72745c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9ec97c10aadfd9, 0xbd9ec97c10aadfd9, + 0xbd9ec97c10aadfd9, 0xbd9ec97c10aadfd9, 0xbd9ec97c10aadfd9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, +] )) ), + +################ chunk 15360 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc406fe9e04705, 0x40fc406fe9e04705, 0x40fc406fe9e04705, + 0x40fc406fe9e04705, 0x40fc406fe9e04705, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc5b5648e077fd, + 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc68c978609079, 0x40fc68c978609079, 0x40fc68c978609079, 0x40fc68c978609079, + 0x40fc68c978609079, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc83afd760c172, 0x40fc83afd760c172, + 0x40fc83afd760c172, 0x40fc83afd760c172, 0x40fc83afd760c172, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, + 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, + 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcc6efc4e13bde, + 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcd462f461545a, 0x40fcd462f461545a, 0x40fcd462f461545a, 0x40fcd462f461545a, + 0x40fcd462f461545a, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fcef4953618553, 0x40fcef4953618553, + 0x40fcef4953618553, 0x40fcef4953618553, 0x40fcef4953618553, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, + 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, + 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd328940e1ffbf, + 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, + 0x40fd3ffc7062183b, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, + 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, + 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd833c5de292a8, 0x40fd833c5de292a8, 0x40fd833c5de292a8, + 0x40fd833c5de292a8, 0x40fd833c5de292a8, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd9e22bce2c3a0, + 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, + 0x40fdab95ec62dc1d, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, + 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, + 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, + 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fe09bc38e38781, + 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe172f68639ffe, 0x40fe172f68639ffe, 0x40fe172f68639ffe, 0x40fe172f68639ffe, + 0x40fe172f68639ffe, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, + 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, + 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, + 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe7555b4e44b62, + 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe82c8e46463df, 0x40fe82c8e46463df, 0x40fe82c8e46463df, 0x40fe82c8e46463df, + 0x40fe82c8e46463df, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe9daf436494d7, 0x40fe9daf436494d7, + 0x40fe9daf436494d7, 0x40fe9daf436494d7, 0x40fe9daf436494d7, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, + 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, + 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fee0ef30e50f44, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d8b95307790681d, 0x3d8b95307790681d, 0x3d8b95307790681d, 0x3d8b95307790681d, 0x3d8b95307790681d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d69a25cc8d3bdde, 0x3d69a25cc8d3bdde, 0x3d69a25cc8d3bdde, 0x3d69a25cc8d3bdde, 0x3d69a25cc8d3bdde, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd94332f6dfd2386, 0xbd94332f6dfd2386, 0xbd94332f6dfd2386, 0xbd94332f6dfd2386, + 0xbd94332f6dfd2386, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9acdecbd2030af, 0xbd9acdecbd2030af, + 0xbd9acdecbd2030af, 0xbd9acdecbd2030af, 0xbd9acdecbd2030af, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d839e11d07b09c9, 0x3d839e11d07b09c9, 0x3d839e11d07b09c9, 0x3d839e11d07b09c9, 0x3d839e11d07b09c9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7cbf6bb2949b97, 0x3d7cbf6bb2949b97, 0x3d7cbf6bb2949b97, 0x3d7cbf6bb2949b97, 0x3d7cbf6bb2949b97, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd982ebec187d2b0, 0xbd982ebec187d2b0, 0xbd982ebec187d2b0, 0xbd982ebec187d2b0, + 0xbd982ebec187d2b0, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd96d25d69958185, 0xbd96d25d69958185, + 0xbd96d25d69958185, 0xbd96d25d69958185, 0xbd96d25d69958185, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d774de652cb56eb, 0x3d774de652cb56eb, 0x3d774de652cb56eb, 0x3d774de652cb56eb, 0x3d774de652cb56eb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8656d4805fac20, 0x3d8656d4805fac20, 0x3d8656d4805fac20, 0x3d8656d4805fac20, 0x3d8656d4805fac20, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9c2a4e151281da, 0xbd9c2a4e151281da, 0xbd9c2a4e151281da, 0xbd9c2a4e151281da, + 0xbd9c2a4e151281da, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd92d6ce160ad25b, 0xbd92d6ce160ad25b, + 0xbd92d6ce160ad25b, 0xbd92d6ce160ad25b, 0xbd92d6ce160ad25b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d5d7ea41282690c, 0x3d5d7ea41282690c, 0x3d5d7ea41282690c, 0x3d5d7ea41282690c, 0x3d5d7ea41282690c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8e4df327750a73, 0x3d8e4df327750a73, 0x3d8e4df327750a73, 0x3d8e4df327750a73, 0x3d8e4df327750a73, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9fda229762cefc, 0x3d9fda229762cefc, 0x3d9fda229762cefc, 0x3d9fda229762cefc, + 0x3d9fda229762cefc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8db67d85004663, 0xbd8db67d85004663, + 0xbd8db67d85004663, 0xbd8db67d85004663, 0xbd8db67d85004663, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd611d28931444ca, 0xbd611d28931444ca, 0xbd611d28931444ca, 0xbd611d28931444ca, 0xbd611d28931444ca, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d932288e7453464, 0x3d932288e7453464, 0x3d932288e7453464, 0x3d932288e7453464, 0x3d932288e7453464, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9bde9343d81fd2, 0x3d9bde9343d81fd2, 0x3d9bde9343d81fd2, 0x3d9bde9343d81fd2, + 0x3d9bde9343d81fd2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd85bf5eddeae80f, 0xbd85bf5eddeae80f, + 0xbd85bf5eddeae80f, 0xbd85bf5eddeae80f, 0xbd85bf5eddeae80f, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd787cd197b4df0d, 0xbd787cd197b4df0d, 0xbd787cd197b4df0d, 0xbd787cd197b4df0d, 0xbd787cd197b4df0d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d971e183acfe38e, 0x3d971e183acfe38e, 0x3d971e183acfe38e, 0x3d971e183acfe38e, 0x3d971e183acfe38e, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d97e303f04d70a8, 0x3d97e303f04d70a8, 0x3d97e303f04d70a8, 0x3d97e303f04d70a8, + 0x3d97e303f04d70a8, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7b90806dab1375, 0xbd7b90806dab1375, + 0xbd7b90806dab1375, 0xbd7b90806dab1375, 0xbd7b90806dab1375, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd84358772efcdda, 0xbd84358772efcdda, 0xbd84358772efcdda, 0xbd84358772efcdda, 0xbd84358772efcdda, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9b19a78e5a92b8, 0x3d9b19a78e5a92b8, 0x3d9b19a78e5a92b8, 0x3d9b19a78e5a92b8, 0x3d9b19a78e5a92b8, 0xbff0000000000000, +] )) ), + +################ chunk 15872 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40feee62606527c0, 0x40feee62606527c0, 0x40feee62606527c0, 0x40feee62606527c0, + 0x40feee62606527c0, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, + 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, + 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, + 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff4c88ace5d325, + 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, + 0x40ff59fbdc65eba1, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff74e23b661c99, 0x40ff74e23b661c99, + 0x40ff74e23b661c99, 0x40ff74e23b661c99, 0x40ff74e23b661c99, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, + 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, + 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffb82228e69706, + 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffc5955866af82, 0x40ffc5955866af82, 0x40ffc5955866af82, 0x40ffc5955866af82, + 0x40ffc5955866af82, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, + 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, + 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x4100046aa2f394f7, 0x4100046aa2f394f7, 0x4100046aa2f394f7, + 0x4100046aa2f394f7, 0x4100046aa2f394f7, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x410011ddd273ad73, + 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410018976a33b9b1, 0x410018976a33b9b1, 0x410018976a33b9b1, 0x410018976a33b9b1, + 0x410018976a33b9b1, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x4100260a99b3d22e, 0x4100260a99b3d22e, + 0x4100260a99b3d22e, 0x4100260a99b3d22e, 0x4100260a99b3d22e, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, + 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, + 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410047aa90740f64, + 0x410047aa90740f64, 0x410047aa90740f64, 0x410047aa90740f64, 0x410047aa90740f64, 0x41004e6428341ba2, 0x41004e6428341ba2, 0x41004e6428341ba2, 0x41004e6428341ba2, + 0x41004e6428341ba2, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x41005bd757b4341e, 0x41005bd757b4341e, + 0x41005bd757b4341e, 0x41005bd757b4341e, 0x41005bd757b4341e, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, + 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x410070041ef458d8, 0x410070041ef458d8, 0x410070041ef458d8, + 0x410070041ef458d8, 0x410070041ef458d8, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x41007d774e747154, + 0x41007d774e747154, 0x41007d774e747154, 0x41007d774e747154, 0x41007d774e747154, 0x41008430e6347d93, 0x41008430e6347d93, 0x41008430e6347d93, 0x41008430e6347d93, + 0x41008430e6347d92, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x410091a415b4960f, 0x410091a415b4960f, + 0x410091a415b4960f, 0x410091a415b4960f, 0x410091a415b4960f, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, + 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, + 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100b3440c74d345, + 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b9fda434df83, 0x4100b9fda434df83, 0x4100b9fda434df83, 0x4100b9fda434df83, + 0x4100b9fda434df83, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d93e7749cc2c17e, 0x3d93e7749cc2c17e, 0x3d93e7749cc2c17e, 0x3d93e7749cc2c17e, + 0x3d93e7749cc2c17e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6744863f00ad9a, 0xbd6744863f00ad9a, + 0xbd6744863f00ad9a, 0xbd6744863f00ad9a, 0xbd6744863f00ad9a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd8c2ca61a052c2e, 0xbd8c2ca61a052c2e, 0xbd8c2ca61a052c2e, 0xbd8c2ca61a052c2e, 0xbd8c2ca61a052c2e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9f1536e1e541e2, 0x3d9f1536e1e541e2, 0x3d9f1536e1e541e2, 0x3d9f1536e1e541e2, 0x3d9f1536e1e541e2, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8fd7ca927024a8, 0x3d8fd7ca927024a8, 0x3d8fd7ca927024a8, 0x3d8fd7ca927024a8, + 0x3d8fd7ca927024a8, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d512fe8baa9976b, 0x3d512fe8baa9976b, + 0x3d512fe8baa9976b, 0x3d512fe8baa9976b, 0x3d512fe8baa9976b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd9211e2608d4541, 0xbd9211e2608d4541, 0xbd9211e2608d4541, 0xbd9211e2608d4541, 0xbd9211e2608d4541, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9cef39ca900ef4, 0xbd9cef39ca900ef4, 0xbd9cef39ca900ef4, 0xbd9cef39ca900ef4, 0xbd9cef39ca900ef4, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d87e0abeb5ac654, 0x3d87e0abeb5ac654, 0x3d87e0abeb5ac654, 0x3d87e0abeb5ac654, + 0x3d87e0abeb5ac654, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d743a377cd52283, 0x3d743a377cd52283, + 0x3d743a377cd52283, 0x3d743a377cd52283, 0x3d743a377cd52283, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd960d71b417f46b, 0xbd960d71b417f46b, 0xbd960d71b417f46b, 0xbd960d71b417f46b, 0xbd960d71b417f46b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3da3862ac47d501b, 0x3da3862ac47d501b, 0x3da3862ac47d501b, 0x3da3862ac47d501b, 0x3da3862ac47d501b, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdac059caeeea600, 0xbdac059caeeea600, 0xbdac059caeeea600, 0xbdac059caeeea600, + 0xbdac059caeeea600, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbdab7af166a0041b, 0xbdab7af166a0041b, + 0xbdab7af166a0041b, 0xbdab7af166a0041b, 0xbdab7af166a0041b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3da2fb7f7c2eae35, 0x3da2fb7f7c2eae35, 0x3da2fb7f7c2eae35, 0x3da2fb7f7c2eae35, 0x3da2fb7f7c2eae35, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd94f81b237ab0a0, 0xbd94f81b237ab0a0, 0xbd94f81b237ab0a0, 0xbd94f81b237ab0a0, 0xbd94f81b237ab0a0, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6fc9ba74c026af, 0x3d6fc9ba74c026af, 0x3d6fc9ba74c026af, 0x3d6fc9ba74c026af, + 0x3d6fc9ba74c026af, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8a0b590c954de9, 0x3d8a0b590c954de9, + 0x3d8a0b590c954de9, 0x3d8a0b590c954de9, 0x3d8a0b590c954de9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd9e04905b2d52bf, 0xbd9e04905b2d52bf, 0xbd9e04905b2d52bf, 0xbd9e04905b2d52bf, 0xbd9e04905b2d52bf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3da781ba1807ff45, 0x3da781ba1807ff45, 0x3da781ba1807ff45, 0x3da781ba1807ff45, 0x3da781ba1807ff45, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3daffed3fd86aad6, 0x3daffed3fd86aad6, 0x3daffed3fd86aad6, 0x3daffed3fd86aad6, + 0xbdb00096013caa95, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbda77f62131554f1, 0xbda77f62131554f1, + 0xbda77f62131554f1, 0xbda77f62131554f1, 0xbda77f62131554f1, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d9dffe05147fe17, 0x3d9dffe05147fe17, 0x3d9dffe05147fe17, 0x3d9dffe05147fe17, 0x3d9dffe05147fe17, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8a01f8f8caa499, 0xbd8a01f8f8caa499, 0xbd8a01f8f8caa499, 0xbd8a01f8f8caa499, 0xbd8a01f8f8caa499, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6fef3ac3eacbf1, 0xbd6fef3ac3eacbf1, 0xbd6fef3ac3eacbf1, 0xbd6fef3ac3eacbf1, + 0xbd6fef3ac3eacbf1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d94fccb2d600549, 0x3d94fccb2d600549, +] )) ), + +################ chunk 16384 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, + 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, + 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e910ca753535, + 0x4100e910ca753535, 0x4100e910ca753535, 0x4100e910ca753535, 0x4100e910ca753535, 0x4100efca62354174, 0x4100efca62354174, 0x4100efca62354174, 0x4100efca62354174, + 0x4100efca62354174, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, + 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, + 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x4101116a58f57eaa, 0x4101116a58f57eaa, 0x4101116a58f57eaa, + 0x4101116a58f57eaa, 0x4101116a58f57eaa, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011edd88759726, + 0x41011edd88759726, 0x41011edd88759726, 0x41011edd88759726, 0x41011edd88759726, 0x410125972035a364, 0x410125972035a364, 0x410125972035a364, 0x410125972035a364, + 0x410125972035a364, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, + 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, + 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101473716f5e09a, 0x4101473716f5e09a, 0x4101473716f5e09a, + 0x4101473716f5e09a, 0x4101473716f5e09a, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x410154aa4675f917, + 0x410154aa4675f917, 0x410154aa4675f917, 0x410154aa4675f917, 0x410154aa4675f917, 0x41015b63de360555, 0x41015b63de360555, 0x41015b63de360555, 0x41015b63de360555, + 0x41015b63de360555, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x410168d70db61dd1, 0x410168d70db61dd1, + 0x410168d70db61dd1, 0x410168d70db61dd1, 0x410168d70db61dd1, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, + 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x41017d03d4f6428b, 0x41017d03d4f6428b, 0x41017d03d4f6428b, + 0x41017d03d4f6428b, 0x41017d03d4f6428b, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x41018a7704765b07, + 0x41018a7704765b07, 0x41018a7704765b07, 0x41018a7704765b07, 0x41018a7704765b07, 0x410191309c366745, 0x410191309c366745, 0x410191309c366745, 0x410191309c366745, + 0x410191309c366745, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, + 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, + 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, + 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101c043c276bcf8, + 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, + 0x4101c6fd5a36c936, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, + 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, + 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e89d50f7066c, 0x4101e89d50f7066c, 0x4101e89d50f7066c, + 0x4101e89d50f7066c, 0x4101e89d50f7066c, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101f61080771ee8, + 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101fcca18372b26, 0x4101fcca18372b26, 0x4101fcca18372b26, 0x4101fcca18372b26, + 0x4101fcca18372b26, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020a3d47b743a2, 0x41020a3d47b743a2, + 0x41020a3d47b743a2, 0x41020a3d47b743a2, 0x41020a3d47b743a2, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, + 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d94fccb2d600549, 0x3d94fccb2d600549, 0x3d94fccb2d600549, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbda2fdd78121588a, 0xbda2fdd78121588a, 0xbda2fdd78121588a, 0xbda2fdd78121588a, 0xbda2fdd78121588a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3dab7d496b92ae6f, 0x3dab7d496b92ae6f, 0x3dab7d496b92ae6f, 0x3dab7d496b92ae6f, 0x3dab7d496b92ae6f, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3dac0344a9fbfbac, 0x3dac0344a9fbfbac, 0x3dac0344a9fbfbac, 0x3dac0344a9fbfbac, + 0x3dac0344a9fbfbac, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbda383d2bf8aa5c7, 0xbda383d2bf8aa5c7, + 0xbda383d2bf8aa5c7, 0xbda383d2bf8aa5c7, 0xbda383d2bf8aa5c7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d9608c1aa329fc3, 0x3d9608c1aa329fc3, 0x3d9608c1aa329fc3, 0x3d9608c1aa329fc3, 0x3d9608c1aa329fc3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbd742777553fcfe1, 0xbd742777553fcfe1, 0xbd742777553fcfe1, 0xbd742777553fcfe1, 0xbd742777553fcfe1, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd87ea0bff256fa4, 0xbd87ea0bff256fa4, 0xbd87ea0bff256fa4, 0xbd87ea0bff256fa4, + 0xbd87ea0bff256fa4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9cf3e9d475639d, 0x3d9cf3e9d475639d, + 0x3d9cf3e9d475639d, 0x3d9cf3e9d475639d, 0x3d9cf3e9d475639d, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbda6f966d4ac07b4, 0xbda6f966d4ac07b4, 0xbda6f966d4ac07b4, 0xbda6f966d4ac07b4, 0xbda6f966d4ac07b4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3daf78d8bf1d5d99, 0x3daf78d8bf1d5d99, 0x3daf78d8bf1d5d99, 0x3daf78d8bf1d5d99, 0x3daf78d8bf1d5d99, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da807b556714c82, 0x3da807b556714c82, 0x3da807b556714c82, 0x3da807b556714c82, + 0x3da807b556714c82, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9f1086d7ffed39, 0xbd9f1086d7ffed39, + 0xbd9f1086d7ffed39, 0xbd9f1086d7ffed39, 0xbd9f1086d7ffed39, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d8c2346063a82de, 0x3d8c2346063a82de, 0x3d8c2346063a82de, 0x3d8c2346063a82de, 0x3d8c2346063a82de, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d676a068e2b52dd, 0x3d676a068e2b52dd, 0x3d676a068e2b52dd, 0x3d676a068e2b52dd, 0x3d676a068e2b52dd, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd93ec24a6a81626, 0xbd93ec24a6a81626, 0xbd93ec24a6a81626, 0xbd93ec24a6a81626, + 0xbd93ec24a6a81626, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3da275843dc560f8, 0x3da275843dc560f8, + 0x3da275843dc560f8, 0x3da275843dc560f8, 0x3da275843dc560f8, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbdaaf4f62836b6de, 0xbdaaf4f62836b6de, 0xbdaaf4f62836b6de, 0xbdaaf4f62836b6de, 0xbdaaf4f62836b6de, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbdac8b97ed57f33d, 0xbdac8b97ed57f33d, 0xbdac8b97ed57f33d, 0xbdac8b97ed57f33d, 0xbdac8b97ed57f33d, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da40c2602e69d58, 0x3da40c2602e69d58, 0x3da40c2602e69d58, 0x3da40c2602e69d58, + 0x3da40c2602e69d58, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd97196830ea8ee5, 0xbd97196830ea8ee5, + 0xbd97196830ea8ee5, 0xbd97196830ea8ee5, 0xbd97196830ea8ee5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3d786a11701f8c6c, 0x3d786a11701f8c6c, 0x3d786a11701f8c6c, 0x3d786a11701f8c6c, 0x3d786a11701f8c6c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d85c8bef1b5915f, 0x3d85c8bef1b5915f, 0x3d85c8bef1b5915f, 0x3d85c8bef1b5915f, 0x3d85c8bef1b5915f, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9be3434dbd747a, 0xbd9be3434dbd747a, 0xbd9be3434dbd747a, 0xbd9be3434dbd747a, + 0xbd9be3434dbd747a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3da6711391501022, 0x3da6711391501022, + 0x3da6711391501022, 0x3da6711391501022, 0x3da6711391501022, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbdaef0857bc16608, 0xbdaef0857bc16608, 0xbdaef0857bc16608, 0xbdaef0857bc16608, 0xbdaef0857bc16608, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 16896 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022bdd3e7780d9, + 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41023296d6378d17, 0x41023296d6378d17, 0x41023296d6378d17, 0x41023296d6378d17, + 0x41023296d6378d17, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x4102400a05b7a593, 0x4102400a05b7a593, + 0x4102400a05b7a593, 0x4102400a05b7a593, 0x4102400a05b7a593, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, + 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, + 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x410261a9fc77e2c9, + 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, + 0x410268639437ef07, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x410275d6c3b80783, 0x410275d6c3b80783, + 0x410275d6c3b80783, 0x410275d6c3b80783, 0x410275d6c3b80783, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, + 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028a038af82c3e, 0x41028a038af82c3e, 0x41028a038af82c3e, + 0x41028a038af82c3e, 0x41028a038af82c3e, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x41029776ba7844ba, + 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029e30523850f8, 0x41029e30523850f8, 0x41029e30523850f8, 0x41029e30523850f8, + 0x41029e30523850f8, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102aba381b86974, 0x4102aba381b86974, + 0x4102aba381b86974, 0x4102aba381b86974, 0x4102aba381b86974, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, + 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, + 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102cd437878a6aa, + 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, + 0x4102d3fd1038b2e8, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, + 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, + 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, + 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x410303103679089b, + 0x410303103679089b, 0x410303103679089b, 0x410303103679089b, 0x410303103679089b, 0x410309c9ce3914d9, 0x410309c9ce3914d9, 0x410309c9ce3914d9, 0x410309c9ce3914d9, + 0x410309c9ce3914d9, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103173cfdb92d55, 0x4103173cfdb92d55, + 0x4103173cfdb92d55, 0x4103173cfdb92d55, 0x4103173cfdb92d55, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, + 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x41032b69c4f9520f, 0x41032b69c4f9520f, 0x41032b69c4f9520f, + 0x41032b69c4f9520f, 0x41032b69c4f9520f, 0x4090000000000000, 0x4090040000000000, 0x408ff80000000000, 0x4090020000000000, 0x408ffc0000000000, 0x40a0000000000000, + 0x40a0020000000000, 0x409ffc0000000000, 0x40a0010000000000, 0x409ffe0000000000, 0x40b0000000000000, 0x40b0010000000000, 0x40affe0000000000, 0x40b0008000000000, + 0x40afff0000000000, 0x40c0000000000000, 0x40c0008000000000, 0x40bfff0000000000, 0x40c0004000000000, 0x40bfff8000000000, 0x40d0000000000000, 0x40d0004000000000, + 0x40cfff8000000000, 0x40d0002000000000, 0x40cfffc000000000, 0x40e0000000000000, 0x40e0002000000000, 0x40dfffc000000000, 0x40e0001000000000, 0x40dfffe000000000, + 0x40f0000000000000, 0x40f0001000000000, 0x40efffe000000000, 0x40f0000800000000, 0x40effff000000000, 0x4100000000000000, 0x4100000800000000, 0x40fffff000000000, + 0x4100000400000000, 0x40fffff800000000, 0x4110000000000000, 0x4110000400000000, 0x410ffff800000000, 0x4110000200000000, 0x410ffffc00000000, 0x4120000000000000, + 0x4120000200000000, 0x411ffffc00000000, 0x4120000100000000, 0x411ffffe00000000, 0x4130000000000000, 0x4130000100000000, 0x412ffffe00000000, 0x4130000080000000, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0xbda8900899cd4413, 0xbda8900899cd4413, 0xbda8900899cd4413, 0xbda8900899cd4413, 0xbda8900899cd4413, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da01096af5bee2e, 0x3da01096af5bee2e, 0x3da01096af5bee2e, 0x3da01096af5bee2e, + 0x3da01096af5bee2e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8e449313aa6123, 0xbd8e449313aa6123, + 0xbd8e449313aa6123, 0xbd8e449313aa6123, 0xbd8e449313aa6123, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd5dc9a4b0d7b391, 0xbd5dc9a4b0d7b391, 0xbd5dc9a4b0d7b391, 0xbd5dc9a4b0d7b391, 0xbd5dc9a4b0d7b391, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d92db7e1ff02704, 0x3d92db7e1ff02704, 0x3d92db7e1ff02704, 0x3d92db7e1ff02704, 0x3d92db7e1ff02704, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, + 0xbda1ed30fa696967, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3daa6ca2e4dabf4c, 0x3daa6ca2e4dabf4c, + 0x3daa6ca2e4dabf4c, 0x3daa6ca2e4dabf4c, 0x3daa6ca2e4dabf4c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3dad13eb30b3eace, 0x3dad13eb30b3eace, 0x3dad13eb30b3eace, 0x3dad13eb30b3eace, 0x3dad13eb30b3eace, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbda49479464294e9, 0xbda49479464294e9, 0xbda49479464294e9, 0xbda49479464294e9, 0xbda49479464294e9, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d982a0eb7a27e08, 0x3d982a0eb7a27e08, 0x3d982a0eb7a27e08, 0x3d982a0eb7a27e08, + 0x3d982a0eb7a27e08, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7cacab8aff48f6, 0xbd7cacab8aff48f6, + 0xbd7cacab8aff48f6, 0xbd7cacab8aff48f6, 0xbd7cacab8aff48f6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd83a771e445b31a, 0xbd83a771e445b31a, 0xbd83a771e445b31a, 0xbd83a771e445b31a, 0xbd83a771e445b31a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9ad29cc7058558, 0x3d9ad29cc7058558, 0x3d9ad29cc7058558, 0x3d9ad29cc7058558, 0x3d9ad29cc7058558, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda5e8c04df41891, 0xbda5e8c04df41891, 0xbda5e8c04df41891, 0xbda5e8c04df41891, + 0xbda5e8c04df41891, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3dae683238656e76, 0x3dae683238656e76, + 0x3dae683238656e76, 0x3dae683238656e76, 0x3dae683238656e76, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0x3da9185bdd293ba4, 0x3da9185bdd293ba4, 0x3da9185bdd293ba4, 0x3da9185bdd293ba4, 0x3da9185bdd293ba4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbda098e9f2b7e5bf, 0xbda098e9f2b7e5bf, 0xbda098e9f2b7e5bf, 0xbda098e9f2b7e5bf, 0xbda098e9f2b7e5bf, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9032f0108d1fb4, 0x3d9032f0108d1fb4, 0x3d9032f0108d1fb4, 0x3d9032f0108d1fb4, + 0x3d9032f0108d1fb4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d497e788ab182d1, 0x3d497e788ab182d1, + 0x3d497e788ab182d1, 0x3d497e788ab182d1, 0x3d497e788ab182d1, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, + 0xbd91cad7993837e1, 0xbd91cad7993837e1, 0xbd91cad7993837e1, 0xbd91cad7993837e1, 0xbd91cad7993837e1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0xbfc44ad2614e80ab, 0x3fe7d87608cdaac9, 0xbfed53d921a57389, 0x3fd564211cf43f56, 0xbfe39981d6dbe861, 0xbfd4092047ede3e2, + 0x3fe4293171fcc2ef, 0xbfeefc78c81772e1, 0x3fc71db03e7e77dd, 0xbfe75ca75b2251da, 0xbfe3074ea233620d, 0x3fd6bc638485c160, 0xbfefee26bf3a602e, 0xbfc1755a2c0d1b82, + 0xbfed089c41dfa9bc, 0xbfee98f87098c8e4, 0xbfd14b95b48a4f3c, 0xbfe86a8d36dca1db, 0xbfe65c1cd5a1c02d, 0xbfef580b4012d43a, 0xbfe1eb0412ba4ffd, 0xbfeffdbc337f08ca, + 0x3fd941f81f42730a, 0xbfec6f83df75b0b8, 0xbfb81ba44a8da908, 0x3fedb0ffc3ecc6e4, 0x3fea159ef81c29f6, 0x3fc80036fa7b61fa, 0x3fefc7334ee4fa4a, 0x3fe455ceddf6197d, + 0x3fe62566735b8513, 0xbfcde29f1835c200, 0x3fef67090db1f5c3, 0x3fd0b8c9b549bc53, 0x3fee8256ebff7bd0, 0xbfeff8bd7b10d6b0, 0xbfe024168cf6f781, 0xbfe268613f60babc, + 0xbfeb6979ba1ad0dc, 0xbfecb4185081f8c6, 0xbfb58809c5ce39b6, 0xbfec492d1cc46dbf, 0x3fe960a26db13c6e, 0xbfe1a632508b1f3d, 0x3fd9d9c2402d796d, 0x3fc57481ec90fde3, + 0x3fed71b50aeb5e24, 0xbfe7a5e663c6210f, 0x3fe3d4ebb04eb632, 0xbfd4d5b66675b7b0, 0x3fd526ccb2fc8656, 0x3fef20cc1ff62d21, 0xbfe3b32b2ca06654, 0x3fe7c2bb1d7c0924, +] )) ), + +################ chunk 17408 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x412fffff00000000, 0x4140000000000000, 0x4140000080000000, 0x413fffff00000000, 0x4140000040000000, 0x413fffff80000000, 0x4150000000000000, 0x4150000040000000, + 0x414fffff80000000, 0x4150000020000000, 0x414fffffc0000000, 0x4160000000000000, 0x4160000020000000, 0x415fffffc0000000, 0x4160000010000000, 0x415fffffe0000000, + 0x4170000000000000, 0x4170000010000000, 0x416fffffe0000000, 0x4170000008000000, 0x416ffffff0000000, 0x4180000000000000, 0x4180000008000000, 0x417ffffff0000000, + 0x4180000004000000, 0x417ffffff8000000, 0x4190000000000000, 0x4190000004000000, 0x418ffffff8000000, 0x4190000002000000, 0x418ffffffc000000, 0x41a0000000000000, + 0x41a0000002000000, 0x419ffffffc000000, 0x41a0000001000000, 0x419ffffffe000000, 0x41b0000000000000, 0x41b0000001000000, 0x41affffffe000000, 0x41b0000000800000, + 0x41afffffff000000, 0x41c0000000000000, 0x41c0000000800000, 0x41bfffffff000000, 0x41c0000000400000, 0x41bfffffff800000, 0x41d0000000000000, 0x41d0000000400000, + 0x41cfffffff800000, 0x41d0000000200000, 0x41cfffffffc00000, 0x41e0000000000000, 0x41e0000000200000, 0x41dfffffffc00000, 0x41e0000000100000, 0x41dfffffffe00000, + 0x41f0000000000000, 0x41f0000000100000, 0x41efffffffe00000, 0x41f0000000080000, 0x41effffffff00000, 0x4200000000000000, 0x4200000000080000, 0x41fffffffff00000, + 0x4200000000040000, 0x41fffffffff80000, 0x4210000000000000, 0x4210000000040000, 0x420ffffffff80000, 0x4210000000020000, 0x420ffffffffc0000, 0x4220000000000000, + 0x4220000000020000, 0x421ffffffffc0000, 0x4220000000010000, 0x421ffffffffe0000, 0x4230000000000000, 0x4230000000010000, 0x422ffffffffe0000, 0x4230000000008000, + 0x422fffffffff0000, 0x4240000000000000, 0x4240000000008000, 0x423fffffffff0000, 0x4240000000004000, 0x423fffffffff8000, 0x4250000000000000, 0x4250000000004000, + 0x424fffffffff8000, 0x4250000000002000, 0x424fffffffffc000, 0x4260000000000000, 0x4260000000002000, 0x425fffffffffc000, 0x4260000000001000, 0x425fffffffffe000, + 0x4270000000000000, 0x4270000000001000, 0x426fffffffffe000, 0x4270000000000800, 0x426ffffffffff000, 0x4280000000000000, 0x4280000000000800, 0x427ffffffffff000, + 0x4280000000000400, 0x427ffffffffff800, 0x4290000000000000, 0x4290000000000400, 0x428ffffffffff800, 0x4290000000000200, 0x428ffffffffffc00, 0x42a0000000000000, + 0x42a0000000000200, 0x429ffffffffffc00, 0x42a0000000000100, 0x429ffffffffffe00, 0x42b0000000000000, 0x42b0000000000100, 0x42affffffffffe00, 0x42b0000000000080, + 0x42afffffffffff00, 0x42c0000000000000, 0x42c0000000000080, 0x42bfffffffffff00, 0x42c0000000000040, 0x42bfffffffffff80, 0x42d0000000000000, 0x42d0000000000040, + 0x42cfffffffffff80, 0x42d0000000000020, 0x42cfffffffffffc0, 0x42e0000000000000, 0x42e0000000000020, 0x42dfffffffffffc0, 0x42e0000000000010, 0x42dfffffffffffe0, + 0x42f0000000000000, 0x42f0000000000010, 0x42efffffffffffe0, 0x42f0000000000008, 0x42effffffffffff0, 0x4300000000000000, 0x4300000000000008, 0x42fffffffffffff0, + 0x4300000000000004, 0x42fffffffffffff8, 0x4310000000000000, 0x4310000000000004, 0x430ffffffffffff8, 0x4310000000000002, 0x430ffffffffffffc, 0x408f400000000000, + 0x4091300000000000, 0x408c200000000000, 0x408f480000000000, 0x408f380000000000, 0x40c3880000000000, 0x40c57c0000000000, 0x40c1940000000000, 0x40c3888000000000, + 0x40c3878000000000, 0x40f86a0000000000, 0x40fadb0000000000, 0x40f5f90000000000, 0x40f86a1000000000, 0x40f869f000000000, 0x412e848000000000, 0x4130c8e000000000, + 0x412b774000000000, 0x412e848200000000, 0x412e847e00000000, 0x416312d000000000, 0x4164fb1800000000, 0x41612a8800000000, 0x416312d020000000, 0x416312cfe0000000, + 0x4197d78400000000, 0x419a39de00000000, 0x4195752a00000000, 0x4197d78404000000, 0x4197d783fc000000, 0x41cdcd6500000000, 0x41d0642ac0000000, 0x41cad27480000000, + 0x41cdcd6500800000, 0x41cdcd64ff800000, 0x4202a05f20000000, 0x42047d3570000000, 0x4200c388d0000000, 0x4202a05f20080000, 0x4202a05f1ff80000, 0x42374876e8000000, + 0x42399c82cc000000, 0x4234f46b04000000, 0x42374876e8010000, 0x42374876e7ff0000, 0x426d1a94a2000000, 0x427001d1bf800000, 0x426a3185c5000000, 0x426d1a94a2002000, + 0x426d1a94a1ffe000, 0x42a2309ce5400000, 0x42a402462f600000, 0x42a05ef39b200000, 0x42a2309ce5400200, 0x42a2309ce53ffe00, 0x42d6bcc41e900000, 0x42d902d7bb380000, + 0x42d476b081e80000, 0x42d6bcc41e900040, 0x42d6bcc41e8fffc0, 0x430c6bf526340000, 0x430f438daa060000, 0x4309945ca2620000, 0x430c6bf526340008, 0x430c6bf52633fff8, + 0x4341c37937e08000, 0x43438a388a43c000, 0x433ff973cafa8000, 0x4341c37937e08000, 0x4341c37937e08000, 0x4376345785d8a000, 0x43786cc6acd4b000, 0x4373fbe85edc9000, + 0x4376345785d8a000, 0x4376345785d8a000, 0x43abc16d674ec800, 0x43ae87f85809dc00, 0x43a8fae27693b400, 0x43abc16d674ec800, 0x43abc16d674ec800, 0x409f400000000000, + 0x40d3880000000000, 0x40a7700000000000, 0x40dd4c0000000000, 0x40b3880000000000, 0x40e86a0000000000, 0x40bf400000000000, 0x40f3880000000000, 0x40c9640000000000, + 0x40ffbd0000000000, 0x40d4820000000000, 0x4109a28000000000, 0x40e09a0000000000, 0x4114c08000000000, 0x40eadb0000000000, 0x4120c8e000000000, 0x40f5ba8000000000, + 0x412b292000000000, 0x4101940000000000, 0x4135f90000000000, 0x410c714000000000, 0x4141c6c800000000, 0x411702a000000000, 0x414cc34800000000, 0x41229da000000000, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbfc4cb305757fa66, 0x3fe3f68887a137ef, 0x3fefd4b493511761, 0xbfd4847a9fa86457, 0x3fed826936582d64, 0x3fc61dace9df937b, 0x3fef34428f9492a2, 0x3fe6d3e342a8da7f, + 0x3fd5c886960b0385, 0x3feec8d2fd2832e5, 0x3fe7fbe42484ae3f, 0x3fdba9f45d1ca7c5, 0xbfe0cee506ee9ba3, 0x3fefc14a7f82c4ee, 0xbfab219a0777ecea, 0x3fe9f919943e1642, + 0xbfe8f22f8433d6ee, 0x3fbb17d7d79c02c7, 0xbfee57ec09221973, 0xbfd89119d0101972, 0xbfef804285107093, 0xbfef3fa130939baf, 0xbfe6af4f91aff747, 0xbfd62a40725b6bf4, + 0xbfeeba76604d7d1c, 0xbfe81e3563c21998, 0x3fdaedbaec15d29d, 0xbfe127165d2723d5, 0x3fefb3c921361b15, 0xbfb0cfbe00d6ada7, 0x3fe9bbc8ffdc13f7, 0xbfe86dcc9babb0a4, + 0x3fc0c673c05e481d, 0xbfee977f5248d0df, 0xbfd70eca6d554d52, 0xbfef590e12828184, 0xbfef8eef8d66d4ea, 0xbfe58263a7d63adc, 0xbfd92f7ded4de5d5, 0xbfee3c329b9ac56a, + 0xbfe927ab2823b59a, 0x3fd4e67c0e2622de, 0xbfe3cdf4af50b48c, 0x3fef18d5c013070d, 0xbfc55185e2d58276, 0x3fe7abdf6ac21262, 0xbfe3c12353728caf, 0x3fd5054c2710443f, + 0xbfefdb6a55d0ac16, 0xbfc51133452478d7, 0xbfed67cfe9ce9163, 0xbfef14f913e9af98, 0xbfd4c7a68801a084, 0xbfe7328434159860, 0xbfe7a0e377dc0a48, 0xbfeeece9b2af55a0, + 0xbfdd9130288cfb14, 0xbfefde6de9d02bc9, 0x3fdfc98f21cff7b4, 0xbfea948056c27030, 0x3f943d3e0a1072f3, 0x3fea39038f075705, 0x3fed99e0cfab06b1, 0xbfa43c3aef6afaea, + 0x3fefce313ed33418, 0x3fdc7082d2332cbf, 0x3fee0ef35be1984d, 0x3fcc03f72f708c75, 0x3fe97a352e2f015c, 0x3fe51db9e52b9c0e, 0x3fefa42ecc59a7fa, 0xbfe49f2c66463c18, + 0xbfefbb6c9ee315ad, 0x3fd2e5734563cd31, 0xbfedd416e09afdee, 0xbfc976ed4b1b0a3d, 0x3fef8993cb9a6586, 0x3fe59a08acba61b8, 0x3fd8f49f3c1d3a16, 0x3fee469dbe20bae5, + 0x3fe913d85ca21b52, 0x3fd55f4563b24793, 0xbfe39b8b4fa69e9d, 0x3fef27af3ea82d4e, 0xbfc45500060eba5e, 0x3fe7d6bdf99ece77, 0xbfe4253076d8fcd2, 0x3fd412ea7328d96f, + 0xbfefce5728c09868, 0xbfc709688f854575, 0xbfed995de0b0b273, 0xbfef4df2000a12ae, 0xbfd6a91c74874834, 0xbfe67f59c69f7fdf, 0xbfe84a80f5385c3d, 0xbfeea74b27c68d03, + 0xbfd9f7122716d5d9, 0xbfefa03eef64f6d7, 0x3fe198d16f110c40, 0xbfe96a62be7156b6, 0x3fb50841f2a3a079, 0x3fe7bb732b2dad26, 0x3feee2ac4b52abe3, 0xbfc4f60e33791a08, + 0x3fef1e45a64f3b02, 0x3fd5124a94ee9629, 0x3fefd6e8410105ec, 0x3fdd04be050796e6, 0x3fe3e5896d4047fd, 0x3fea6834d1d1e374, 0x3fed79fb56b08182, 0xbfc97b16c2c7f89e, + 0xbfedd47947d27ef4, 0x3fe6f240f69503e8, 0xbfe49ffc39e4939f, 0x3fd2e36be37df8e8, 0x3fd8f888558cee10, 0x3fef89efd2bec663, 0xbfe20c096719e44d, 0x3fe91529fb2b0291, + 0xbfb95982d9b925ca, 0x3fe6fde1730cde37, 0x3fef26b6c690d836, 0xbfc9399de16530b7, 0x3feed9081dc974e1, 0x3fd303524e94ba25, 0x3feffbaee934d6b7, 0x3fe06811fd510f22, + 0x3fe22793f808c0a1, 0x3feb91e28c4ae147, 0x3fec90d9e34e365f, 0xbfb09c493c272925, 0xbfebfdfe938da733, 0x3fe9bf9d4c58fbde, 0xbfe121a4fb359a9d, 0x3fdaf96c40be2b2b, + 0x3fc0935354934b3e, 0x3fecf0752c36971a, 0xbfe8761e51402e11, 0x3fe2d95a0b9a29b5, 0xbfd726d5c310c3b5, 0x3fd06f98b1c26e7a, 0x3fee76d368c145ca, 0xbfe59573a5a6c11f, + 0x3fe609fd6f94f5c5, 0xbfce75e8244d93da, 0x3fdfc4f5e3aaeddb, 0x3feff53351c90edb, 0xbfdd95e2e4d8b9a5, 0x3feb421432e72efb, 0x3f93e87e45dd1094, 0x3fea75cc150a206b, + 0x3fdb68af0cc5c275, 0x3fefee0121ef7d8e, 0x3fed70901f28580e, 0xbf9b18870e886e35, 0xbfd38f2fa75d9289, 0xbfeeb1acfc3e865e, 0x3fe3b1bd2f54d581, 0xbfeeec37f4165d6a, + 0x3fe45ad3086449bd, 0x3fa24daa9c527e96, 0x3fd15e4cdf6372ca, 0xbfd5b9abc00c4d18, 0xbfea4ab1c2190342, 0x3feb8727670dd450, 0xbfd6664b2568d867, 0x3fd8874aae64b2ca, + 0x3fd43df6f7e4dd85, 0x3fe32c3740018a1e, 0xbfef4677c48458b4, 0x3fdaea414a8a3352, 0x3fe6c4820542653f, 0x3fb38fa01c1d0e61, 0xbfe128b4404d1668, 0x3fefb38658ea8f8c, + 0x3fedcffca623a20b, 0xbfeff02f05e37abe, 0xbfe6285e2422bcfc, 0x3fc94a963242eec7, 0x3fe9e48379b16e88, 0x3fe1778cae83c69b, 0x3fe2a1d97d8b7f0a, 0xbfef53a3700fd412, + 0x3fefffd25631c5bb, 0xbfda3fb06c32730b, 0xbfdf334c7896a4e3, 0x3fb16fc2a542bfb8, 0xbfec526cdd1b5da5, 0x3fde29d91695253f, 0xbfeff07adba199b5, 0x3fedb7dbc47abb83, + 0x3fe42988d2d410b6, 0x3fefbb9b4791d423, 0x3fea0aeb77d9ffdf, 0x3fc848ab289c9124, 0xbfe38f4477984352, 0x3fe0444701b85824, 0xbfeec6254143f8a0, 0x3fd57c867773a0a3, + 0xbfefe12390d37ff4, 0xbfd27d18bf625778, 0xbfea0ac5a8b1ef51, 0x3fd6d18f7cd6b5e3, 0x3fe4c8c5d664a7c3, 0xbfeec6136abda3d6, 0xbfcacde4341a9ee7, 0x3fb4fdf8b49bdc84, + 0xbfdee8d199afee96, 0xbfedf35e082ce4d4, 0x3fe6b59e9336e0c3, 0x3feb76f88136ceba, 0xbfe76ab64e9bd2a1, 0xbfee4b73b59e9766, 0x3fa053c59eb80c2c, 0x3feca876b117e178, + 0x3fe8f334432ebba5, 0xbfee00718543d9ee, 0x3fc192c9d38ecf36, 0x3fe8f334432ebba5, 0x3fe8f334432ebba5, 0xbfddbadc7a119fc8, 0xbfd992caa7729851, 0x3fef671338313e14, + 0xbfddbadc7a119fc8, 0xbfddbadc7a119fc8, 0xbfefc66798d05d2e, 0x3fea610678789f8e, 0x3fede5f02534c3db, 0xbfefc66798d05d2e, 0xbfefc66798d05d2e, 0x3fedc2e234ee9247, + 0x3fe29f9e81f1259b, 0x3fcc0e6ac593f0c1, 0xbfe9af6f6fce6470, 0xbfef9d6bcb019088, 0xbfeffeb0da2bbf4d, 0x3fefee5482d13679, 0x3fe38ab87c8733f8, 0x3fb6e822b8885eb0, + 0x3fe8fc90c249a140, 0x3feffda8b771cac7, 0xbfce4f75ee8bf91d, 0x3fefcb48ed51bfcd, 0xbfed028db65d479a, 0xbfc1889c9b40edb6, 0x3fef621893002b55, 0xbfeeff765c3dfcaf, + 0xbfe2ea16e3a56e06, 0x3fed9e08ba91b14a, 0x3fe59e5002ff92a3, 0x3fe317522b8eb58a, 0x3fbbf04d68ee66a0, 0x3fe08a53763de013, 0x3fe8106be83248b7, 0xbfb88cbd88643c0a, +] )) ), + +################ chunk 17920 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4157450800000000, 0x412e1ef000000000, 0x4162d35600000000, 0x41385e4800000000, 0x416e75da00000000, 0x4143b6e000000000, 0x4178a49800000000, 0x414fe60400000000, + 0x4183efc280000000, 0x4159ce7200000000, 0x4190210740000000, 0x4164e0ba00000000, 0x419a18e880000000, 0x40f8a88000000000, 0x412ed2a000000000, 0x416343a400000000, + 0x4073d4d0507dcb95, 0x4063d4d0507dcb95, 0x40f9258000000000, 0x412f6ee000000000, 0x4163a54c00000000, 0x407439583dcedc4a, 0x406439583dcedc4a, 0x40fa1f8000000000, + 0x413053b000000000, 0x4164689c00000000, 0x407502681870fdb2, 0x406502681870fdb2, 0x40fa9c8000000000, 0x4130a1d000000000, 0x4164ca4400000000, 0x407566f005c20e67, + 0x406566f005c20e67, 0x40fb968000000000, 0x41313e1000000000, 0x41658d9400000000, 0x40762fffe0642fcf, 0x40662fffe0642fcf, 0x40ff018000000000, 0x413360f000000000, + 0x4168392c00000000, 0x4078efb75d9ba4be, 0x4068efb75d9ba4be, 0x40fffb8000000000, 0x4133fd3000000000, 0x4168fc7c00000000, 0x4079b8c7383dc627, 0x4069b8c7383dc627, + 0x4100b94000000000, 0x4134e79000000000, 0x416a217400000000, 0x407ae65f0030f844, 0x406ae65f0030f844, 0x4100f7c000000000, 0x413535b000000000, 0x416a831c00000000, + 0x407b4ae6ed8208f8, 0x406b4ae6ed8208f8, 0x4102304000000000, 0x4136bc5000000000, 0x416c6b6400000000, 0x407d418e90175c7e, 0x406d418e90175c7e, 0x41026ec000000000, + 0x41370a7000000000, 0x416ccd0c00000000, 0x407da6167d686d33, 0x406da6167d686d33, 0x41032a4000000000, 0x4137f4d000000000, 0x416df20400000000, 0x407ed3ae455b9f50, + 0x406ed3ae455b9f50, 0x4103e5c000000000, 0x4138df3000000000, 0x416f16fc00000000, 0x408000a306a768b6, 0x407000a306a768b6, 0x410462c000000000, 0x41397b7000000000, + 0x416fda4c00000000, 0x4080652af3f8796b, 0x4070652af3f8796b, 0x41051e4000000000, 0x413a65d000000000, 0x41707fa200000000, 0x4080fbf6d7f21279, 0x4070fbf6d7f21279, + 0x4105d9c000000000, 0x413b503000000000, 0x4171121e00000000, 0x408192c2bbebab88, 0x407192c2bbebab88, 0x4106184000000000, 0x413b9e5000000000, 0x417142f200000000, + 0x4081c506b29433e2, 0x4071c506b29433e2, 0x410750c000000000, 0x413d24f000000000, 0x4172371600000000, 0x4082c05a83dedda5, 0x4072c05a83dedda5, 0x41078f4000000000, + 0x413d731000000000, 0x417267ea00000000, 0x4082f29e7a8765ff, 0x4072f29e7a8765ff, 0x41080c4000000000, 0x413e0f5000000000, 0x4172c99200000000, 0x4083572667d876b4, + 0x4073572667d876b4, 0x41084ac000000000, 0x413e5d7000000000, 0x4172fa6600000000, 0x4083896a5e80ff0e, 0x4073896a5e80ff0e, 0x4109c1c000000000, 0x4140191800000000, + 0x41741f5e00000000, 0x4084b7022674312b, 0x4074b7022674312b, 0x410b38c000000000, 0x4141037800000000, 0x4175445600000000, 0x4085e499ee676348, 0x4075e499ee676348, + 0x410bb5c000000000, 0x4141519800000000, 0x4175a5fe00000000, 0x40864921dbb873fd, 0x40764921dbb873fd, 0x410bf44000000000, 0x414178a800000000, 0x4175d6d200000000, + 0x40867b65d260fc57, 0x40767b65d260fc57, 0x410c714000000000, 0x4141c6c800000000, 0x4176387a00000000, 0x4086dfedbfb20d0b, 0x4076dfedbfb20d0b, 0x410d2cc000000000, + 0x41423bf800000000, 0x4176caf600000000, 0x408776b9a3aba61a, 0x407776b9a3aba61a, 0x410d6b4000000000, 0x4142630800000000, 0x4176fbca00000000, 0x4087a8fd9a542e74, + 0x4077a8fd9a542e74, 0x410ea3c000000000, 0x4143265800000000, 0x4177efee00000000, 0x4088a4516b9ed837, 0x4078a4516b9ed837, 0x410f5f4000000000, 0x41439b8800000000, + 0x4178826a00000000, 0x40893b1d4f987145, 0x40793b1d4f987145, 0x41100d6000000000, 0x414410b800000000, 0x417914e600000000, 0x4089d1e933920a54, 0x4079d1e933920a54, + 0x41106b2000000000, 0x414485e800000000, 0x4179a76200000000, 0x408a68b5178ba363, 0x407a68b5178ba363, 0x41108a6000000000, 0x4144acf800000000, 0x4179d83600000000, + 0x408a9af90e342bbd, 0x407a9af90e342bbd, 0x4110e82000000000, 0x4145222800000000, 0x417a6ab200000000, 0x408b31c4f22dc4cb, 0x407b31c4f22dc4cb, 0x411126a000000000, + 0x4145704800000000, 0x417acc5a00000000, 0x408b964cdf7ed580, 0x407b964cdf7ed580, 0x411145e000000000, 0x4145975800000000, 0x417afd2e00000000, 0x408bc890d6275dda, + 0x407bc890d6275dda, 0x4111e22000000000, 0x41465aa800000000, 0x417bf15200000000, 0x408cc3e4a772079d, 0x407cc3e4a772079d, 0x4112bce000000000, 0x41476c1800000000, + 0x417d471e00000000, 0x408e23c0660dc214, 0x407e23c0660dc214, 0x4112fb6000000000, 0x4147ba3800000000, 0x417da8c600000000, 0x408e8848535ed2c8, 0x407e8848535ed2c8, + 0x41131aa000000000, 0x4147e14800000000, 0x417dd99a00000000, 0x408eba8c4a075b23, 0x407eba8c4a075b23, 0x4113592000000000, 0x41482f6800000000, 0x417e3b4200000000, + 0x408f1f1437586bd7, 0x407f1f1437586bd7, 0x411433e000000000, 0x414940d800000000, 0x417f910e00000000, 0x40903f77fafa1327, 0x40803f77fafa1327, 0x411491a000000000, + 0x4149b60800000000, 0x418011c500000000, 0x40908addecf6dfae, 0x40808addecf6dfae, 0x41152de000000000, 0x414a795800000000, 0x41808bd700000000, 0x40910887d59c3490, + 0x40810887d59c3490, 0x41154d2000000000, 0x414aa06800000000, 0x4180a44100000000, 0x409121a9d0f078bd, 0x408121a9d0f078bd, 0x41158ba000000000, 0x414aee8800000000, + 0x4180d51500000000, 0x409153edc7990117, 0x408153edc7990117, 0x4115e96000000000, 0x414b63b800000000, 0x41811e5300000000, 0x40919f53b995cd9f, 0x40819f53b995cd9f, + 0x4116666000000000, 0x414bfff800000000, 0x41817ffb00000000, 0x409203dba6e6de53, 0x408203dba6e6de53, 0x7fdfffffffffffff, 0x7fe1ccf385ebc8a0, 0x7fac7b1f3cac7433, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3fea38efc974a4e1, 0xbfdbac9a08357b9f, 0x3fef13bb808eecfd, 0x3fd6033f9bbb89a4, 0x3fd71e7a62925fd3, 0x3fe6eac4855ed218, 0xbfefbc1a22eaf6f4, 0xbfed335ae38cbc2e, + 0x3fec1b4ea7a22e8d, 0x3fedc10b7a145b56, 0xbfe2c83111f32d3c, 0x3fa6c80193e16f32, 0x3fdb8e01f4aacb59, 0xbfe9ccc5bb2b1247, 0x3fa80b919cfcd695, 0xbfdcf93f241d585d, + 0x3d03da34489c213b, 0x3ff0000000000000, 0xbfd04060d3e63c1e, 0xbfe1618082d1affe, 0xbfe07d0f9cf4b767, 0xbd1dcc4d42e59df2, 0xbff0000000000000, 0xbfde729d3484aea4, + 0xbfef09ec2bbbad1b, 0xbfe43ab1afb29456, 0x3d12c0e3eeb304ee, 0xbff0000000000000, 0xbfe4955674dd38ce, 0xbfe4b5da68de5d47, 0xbfe5f2fe83279015, 0xbd14f8837880a9a2, + 0x3ff0000000000000, 0xbfab8de76d5dd0c4, 0x3fe068c47b7729b6, 0xbfe90b51b30a31d4, 0x3d1b94adb917f93e, 0x3ff0000000000000, 0xbfecc2ce3b0fbf34, 0xbfef84004c79b4de, + 0xbfef881179df3c35, 0x3cf60b679ab8cd3b, 0xbff0000000000000, 0x3fee952ca6abda83, 0xbfc3aa70079d955e, 0xbfeffcb85b826be2, 0xbd03dfe9cf7253a2, 0xbff0000000000000, + 0x3fefac1c2b8aca4d, 0x3fefb19aee8f23f2, 0xbfef7256bff69eaa, 0xbcd1c2b1d543580a, 0x3ff0000000000000, 0xbfcd8f62b209e496, 0x3fe733fc0cc60000, 0xbfeef16107a4572a, + 0x3d172a6d7b781bef, 0xbff0000000000000, 0x3fe08d3fa6f0021e, 0xbfe7f9dc78830c89, 0xbfea21824a00fc5d, 0x3d108b687775b320, 0x3ff0000000000000, 0x3fe363853d00c597, + 0xbfcca71b656d0d46, 0xbfe8be8bbf276711, 0xbd172dfeefbdfb70, 0xbff0000000000000, 0x3fec6a10c1c7d6b1, 0x3fefeda6bb72f8c4, 0xbfe3db7159e2f695, 0xbd0cb46a4ab20e3f, + 0x3ff0000000000000, 0x3feffab3d8ab843a, 0xbfd686442e3e672f, 0xbfdc1e85c60822a8, 0x3d2d3cca5285f698, 0xbff0000000000000, 0xbfe68e86897d86bc, 0xbfeffc043f9421c0, + 0xbfd3a326d1c3cf91, 0xbd14f93a295b6fef, 0xbff0000000000000, 0xbfee18fdab171543, 0x3fd45e58716cd55a, 0xbfb8e03da0c4e666, 0x3d29ed47d084c231, 0x3ff0000000000000, + 0xbfefdabbffe1000b, 0x3fea1b73513475fa, 0x3fbdf01cb30636ce, 0xbcea8d34a48c3a73, 0xbff0000000000000, 0x3fd1bd49fd9c50a1, 0x3fd4ec17290ea1e1, 0x3fc80388279e6ea4, + 0x3d14f4f2043aca22, 0x3ff0000000000000, 0xbfe1d781421b3058, 0xbfd712319b43f87d, 0x3fe09fea8995cfbc, 0x3d0cabda0070c2a5, 0xbff0000000000000, 0xbfe2265b98838e3a, + 0x3fcff670a9ba0ab0, 0x3fe2892e69e66547, 0x3d234e42cc825961, 0x3ff0000000000000, 0xbfc30fa8dab692af, 0x3fefe84d22c17c1c, 0x3fe61090516d9823, 0xbd246b249ab1552f, + 0x3ff0000000000000, 0xbfebada9ca1f6dda, 0x3feb5cd82cfa7249, 0x3fe7aa1022fac760, 0xbd108fb09c9658ed, 0xbff0000000000000, 0xbfedf81450c3d424, 0xbfdb470e3d562c7f, + 0x3fee7b11fa4c6874, 0x3cd17e2f8338fb35, 0xbff0000000000000, 0xbfd4a881479c33e8, 0xbfc28248f25987d3, 0x3fefc562042cb1ac, 0x3d12bf768cfd7854, 0xbff0000000000000, + 0x3fec3db64af224c9, 0xbfef76af9d2f9658, 0x3feee6e606d64fff, 0xbd2e59ac20b4f266, 0xbff0000000000000, 0x3fbcf13b012cf2c7, 0xbfecfb54e56ce174, 0x3fee3aa8eba29a09, + 0xbd22365fd44ec9ae, 0x3ff0000000000000, 0x3fe317522b8eb58a, 0x3fbbf04d68ee66a0, 0x3fec6c9654f886a9, 0x3d0840e311f61f09, 0x3ff0000000000000, 0x3fc916cc12ea7353, + 0x3fed72bf88d153be, 0x3fe8a4a40903c908, 0xbd2585e2564ffe16, 0xbff0000000000000, 0x3feae1109e04df38, 0x3fe0a8df7a7b1416, 0x3fe71f1dd2f357ff, 0xbd12c52c13d3aabb, + 0x3ff0000000000000, 0xbfe4495359816e28, 0xbfe1a02ef3727ccc, 0x3fdbd54196c5b536, 0xbd19643117d6138b, 0xbff0000000000000, 0xbfecec1cda9f333d, 0x3feea87a0a595c64, + 0x3fcdd9df3365cce6, 0x3d27b7cc59477063, 0x3ff0000000000000, 0xbfeffffff4575ea5, 0xbf611289d7a9b5db, 0x3f9556c81450dc26, 0xbcfef2760c30aba7, 0xbff0000000000000, + 0xbfeced92ba281bb3, 0xbfee9e9fdbc1ff8d, 0xbfc8a37c42ef0549, 0xbd2f7469dc539b4d, 0x3ff0000000000000, 0xbfb0c07d916f1ad7, 0xbfe37d30c964fea9, 0xbfd0c6750a02b9de, + 0xbd23511d8fed7295, 0xbff0000000000000, 0xbfdf19d73784b692, 0x3fedecb0bab73482, 0xbfdd8a261ea2f692, 0x3d2118c755450793, 0x3ff0000000000000, 0xbfcf0f40f7a53449, + 0x3fe462470a98b7a0, 0xbfe2aa5306481984, 0xbd26a0a011eea6fc, 0x3ff0000000000000, 0xbfea04bcf62fb0bc, 0x3fb1c26e55fdd894, 0xbfe4798e6065b0b3, 0xbd14faa78b10fc89, + 0xbff0000000000000, 0x3fe314948db94ddd, 0xbfbae0b6bb8cde28, 0xbfebc977e6964a96, 0xbd1b99ac8f136558, 0x3ff0000000000000, 0xbfda58fdec7bd106, 0xbfec89f075e39fb9, + 0xbfeffe9ec3579e10, 0x3d0ca8ff3d05a971, 0xbff0000000000000, 0x3fed8c81c297d4d4, 0xbfe6e862512d6024, 0xbfefc06b2668bf4c, 0x3d2f70d8680dbbcc, 0xbff0000000000000, + 0x3f9217cad0b8c45f, 0xbfc67ff57e8e2937, 0xbfef62db74569927, 0xbd246bdb4b8c1b7c, 0x3ff0000000000000, 0x3fe574bbe1ac632a, 0x3fec00cba8f0add3, 0xbfee2d33da734b79, + 0x3cfed5ea6a01afa4, 0x3ff0000000000000, 0x3fef2d6efa1f627b, 0xbfe87218b10b5208, 0xbfe55d13db051020, 0x3d28d1d3640b52fd, 0xbff0000000000000, 0x3fef43d52c97dfc6, + 0x3fead3339e63378f, 0xbfdf9a7974cef390, 0x3d3e9ddc249ee693, 0x3ff0000000000000, 0xbfefda688990a945, 0xbfea2f2314657fd1, 0xbfc440c2017d7a47, 0xbd084f28e30d9d0b, + 0xbff0000000000000, 0x3fdd1aef026cafcb, 0xbfefffafefd19019, 0xbfb6575413fff6c9, 0x3d083e084e8b05d6, 0x3ff0000000000000, 0xbfee1a26641236d4, 0xbfd41d8fbb6310af, + 0x3fac79abaa9c7b7a, 0x3d2e561aac6f12e5, 0x3ff0000000000000, 0xbfe690f26bd072e4, 0x3feffd0299235712, 0x3fd1150465f07ffd, 0xbd3ea000372f3979, 0xbff0000000000000, + 0xbfe81ef2cf53896c, 0xbfe8cd855c477457, 0x3fe0e54f5d66f889, 0xbd19659e798ba024, 0xbff0000000000000, 0x3feffff98bb3443c, 0x3fdd0472b6b4d936, 0xbfed79f508e080c1, +] )) ), + +################ chunk 18432 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x7f76c8e5ca239029, 0x40b0000000000001, 0x40affffffffffffe, 0x40b0000000000002, 0x40affffffffffffc, 0x40c0000000000001, 0x40bffffffffffffe, 0x40c0000000000002, + 0x40bffffffffffffc, 0x40d0000000000001, 0x40cffffffffffffe, 0x40d0000000000002, 0x40cffffffffffffc, 0x40e0000000000001, 0x40dffffffffffffe, 0x40e0000000000002, + 0x40dffffffffffffc, 0x40f0000000000001, 0x40effffffffffffe, 0x40f0000000000002, 0x40effffffffffffc, 0x4100000000000001, 0x40fffffffffffffe, 0x4100000000000002, + 0x40fffffffffffffc, 0x4110000000000001, 0x410ffffffffffffe, 0x4110000000000002, 0x410ffffffffffffc, 0x4120000000000001, 0x411ffffffffffffe, 0x4120000000000002, + 0x411ffffffffffffc, 0x4130000000000001, 0x412ffffffffffffe, 0x4130000000000002, 0x412ffffffffffffc, 0x4144bd24ea0af22d, 0x4179ec6e248daeb8, 0x41b033c4d6d88d33, + 0x413594458ff7aee3, 0x416af956f3f59a9c, 0x419086a2783956a1, 0x4175f58baee1093f, 0x40a88b2f6c200000, 0x40a8d54d48547b05, 0x40b88b2f6c200000, 0x40b8d54d48547b05, + 0x40c2686391180000, 0x40c29ff9f63f5c44, 0x40c88b2f6c200000, 0x40c8d54d48547b05, 0x40ceadfb47280000, 0x40cf0aa09a6999c6, 0x40d2686391180000, 0x40d29ff9f63f5c44, + 0x40d579c97e9c0000, 0x40d5baa39f49eba4, 0x40d88b2f6c200000, 0x40d8d54d48547b05, 0x40db9c9559a40000, 0x40dbeff6f15f0a66, 0x40deadfb47280000, 0x40df0aa09a6999c6, + 0x40e0dfb09a560000, 0x40e112a521ba1493, 0x40e2686391180000, 0x40e29ff9f63f5c44, 0x40e3f11687da0000, 0x40e42d4ecac4a3f4, 0x40e579c97e9c0000, 0x40e5baa39f49eba4, + 0x40e7027c755e0000, 0x40e747f873cf3355, 0x40e88b2f6c200000, 0x40e8d54d48547b05, 0x40ea13e262e20000, 0x40ea62a21cd9c2b5, 0x40eb9c9559a40000, 0x40ebeff6f15f0a66, + 0x40ed254850660000, 0x40ed7d4bc5e45216, 0x40eeadfb47280000, 0x40ef0aa09a6999c6, 0x40f01b571ef50000, 0x40f04bfab77770bb, 0x40f0dfb09a560000, 0x40f112a521ba1493, + 0x40f1a40a15b70000, 0x40f1d94f8bfcb86c, 0x40f2686391180000, 0x40f29ff9f63f5c44, 0x40f32cbd0c790000, 0x40f366a46082001c, 0x40f3f11687da0000, 0x40f42d4ecac4a3f4, + 0x40f4b570033b0000, 0x40f4f3f9350747cc, 0x40f579c97e9c0000, 0x40f5baa39f49eba4, 0x40f63e22f9fd0000, 0x40f6814e098c8f7d, 0x40f7027c755e0000, 0x40f747f873cf3355, + 0x40f7c6d5f0bf0000, 0x40f80ea2de11d72d, 0x40f88b2f6c200000, 0x40f8d54d48547b05, 0x40f94f88e7810000, 0x40f99bf7b2971edd, 0x40fa13e262e20000, 0x40fa62a21cd9c2b5, + 0x40fad83bde430000, 0x40fb294c871c668d, 0x40fb9c9559a40000, 0x40fbeff6f15f0a66, 0x40fc60eed5050000, 0x40fcb6a15ba1ae3e, 0x40fd254850660000, 0x40fd7d4bc5e45216, + 0x40fde9a1cbc70000, 0x40fe43f63026f5ee, 0x40feadfb47280000, 0x40ff0aa09a6999c6, 0x40ff7254c2890000, 0x40ffd14b04ac3d9e, 0x41001b571ef50000, 0x41004bfab77770bb, + 0x41007d83dca58000, 0x4100af4fec98c2a7, 0x4100dfb09a560000, 0x410112a521ba1493, 0x410141dd58068000, 0x410175fa56db6680, 0x4101a40a15b70000, 0x4101d94f8bfcb86c, + 0x41020636d3678000, 0x41023ca4c11e0a58, 0x4102686391180000, 0x41029ff9f63f5c44, 0x4102ca904ec88000, 0x4103034f2b60ae30, 0x41032cbd0c790000, 0x410366a46082001c, + 0x41038ee9ca298000, 0x4103c9f995a35208, 0x4103f11687da0000, 0x41042d4ecac4a3f4, 0x41045343458a8000, 0x410490a3ffe5f5e0, 0x4104b570033b0000, 0x4104f3f9350747cc, + 0x4105179cc0eb8000, 0x4105574e6a2899b8, 0x410579c97e9c0000, 0x4105baa39f49eba4, 0x4105dbf63c4c8000, 0x41061df8d46b3d90, 0x41063e22f9fd0000, 0x4106814e098c8f7d, + 0x4106a04fb7ad8000, 0x4106e4a33eade169, 0x4107027c755e0000, 0x410747f873cf3355, 0x410764a9330e8000, 0x4107ab4da8f08541, 0x4107c6d5f0bf0000, 0x41080ea2de11d72d, + 0x41082902ae6f8000, 0x410871f813332919, 0x41088b2f6c200000, 0x4108d54d48547b05, 0x4108ed5c29d08000, 0x410938a27d75ccf1, 0x41094f88e7810000, 0x41099bf7b2971edd, + 0x4109b1b5a5318000, 0x4109ff4ce7b870c9, 0x410a13e262e20000, 0x410a62a21cd9c2b5, 0x410a760f20928000, 0x410ac5f751fb14a1, 0x410ad83bde430000, 0x410b294c871c668d, + 0x410b3a689bf38000, 0x410b8ca1bc3db87a, 0x410b9c9559a40000, 0x410beff6f15f0a66, 0x410bfec217548000, 0x410c534c26805c52, 0x410c60eed5050000, 0x410cb6a15ba1ae3e, + 0x410cc31b92b58000, 0x410d19f690c3002a, 0x410d254850660000, 0x410d7d4bc5e45216, 0x410d87750e168000, 0x410de0a0fb05a402, 0x410de9a1cbc70000, 0x410e43f63026f5ee, + 0x410e4bce89778000, 0x410ea74b654847da, 0x410eadfb47280000, 0x410f0aa09a6999c6, 0x410f102804d88000, 0x410f6df5cf8aebb2, 0x410f7254c2890000, 0x410fd14b04ac3d9e, + 0x410fd48180398000, 0x41101a501ce6c7c5, 0x41101b571ef50000, 0x41104bfab77770bb, 0x41104c6d7dcd4000, 0x41107da5520819b1, 0x41107d83dca58000, 0x4110af4fec98c2a7, + 0x4110ae9a3b7dc000, 0x4110e0fa87296b9d, 0x4110dfb09a560000, 0x411112a521ba1493, 0x411110c6f92e4000, 0x4111444fbc4abd89, 0x411141dd58068000, 0x411175fa56db6680, + 0x411172f3b6dec000, 0x4111a7a4f16c0f76, 0x4111a40a15b70000, 0x4111d94f8bfcb86c, 0x4111d520748f4000, 0x41120afa268d6162, 0x41120636d3678000, 0x41123ca4c11e0a58, + 0x4112374d323fc000, 0x41126e4f5baeb34e, 0x4112686391180000, 0x41129ff9f63f5c44, 0x41129979eff04000, 0x4112d1a490d0053a, 0x4112ca904ec88000, 0x4113034f2b60ae30, + 0x4112fba6ada0c000, 0x411334f9c5f15726, 0x41132cbd0c790000, 0x411366a46082001c, 0x41135dd36b514000, 0x4113984efb12a912, 0x41138ee9ca298000, 0x4113c9f995a35208, + 0x4113c0002901c000, 0x4113fba43033fafe, 0x4113f11687da0000, 0x41142d4ecac4a3f4, 0x4114222ce6b24000, 0x41145ef965554cea, 0x41145343458a8000, 0x411490a3ffe5f5e0, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3feffef7ac4de5a8, 0xbfe3074ea2334853, 0xbfe3074ea2337bc8, 0xbfe3074ea2332e99, 0xbfe3074ea2339582, 0xbfee98f87098b627, 0xbfee98f87098dba1, 0xbfee98f87098a369, + 0xbfee98f87098ee5e, 0xbfe1eb0412baba0b, 0xbfe1eb0412b9e5f0, 0xbfe1eb0412bb2418, 0xbfe1eb0412b97be2, 0x3fedb0ffc3ed265d, 0x3fedb0ffc3ec676b, 0x3fedb0ffc3ed85d5, + 0x3fedb0ffc3ec07f2, 0x3fe62566735a137f, 0x3fe62566735cf6a8, 0x3fe625667358a1eb, 0x3fe62566735e683c, 0xbfeff8bd7b10ab96, 0xbfeff8bd7b1101ca, 0xbfeff8bd7b10807c, + 0xbfeff8bd7b112ce3, 0xbfb58809c60dffa8, 0xbfb58809c58e73c3, 0xbfb58809c64dc59a, 0xbfb58809c54eadd1, 0x3fc57481ecd01616, 0x3fc57481ec51e5b0, 0x3fc57481ed0f2e49, + 0x3fc57481ec12cd7d, 0x3fd526ccb338edb1, 0x3fd526ccb2c01efa, 0x3fd526ccb375550c, 0x3fd526ccb283b79f, 0xbfb087b112a0b303, 0xbfe3449254ac655f, 0xbfc6b5890f176ab6, + 0x3fde7e3de6d6080a, 0xbfeef994dd12e39b, 0x3fa88b66094d5bf6, 0xbfa20548049c4960, 0xbf00aa5026c7b66e, 0xbfe321a18722a2b7, 0xbf10aa5026a38d79, 0xbfeeabebd6f4c8a7, + 0xbf18ff78399aedd0, 0xbfee0aa1d4bd2106, 0xbf20aa502612e9a4, 0xbfe17dc30bd17dec, 0xbf24d4e42f100a76, 0x3faffd92e4e6cd85, 0xbf28ff7837b2c4e3, 0x3fe4b25c7e2046a3, + 0xbf2d2a0c3fe90471, 0x3fef2e86e74f02a4, 0xbf30aa5023d05a52, 0x3fed4b4a3a906fe3, 0xbf32bf9a2763e082, 0x3fdf90ca281869d3, 0xbf34d4e42aa60a8a, 0xbfbfed9287cc9793, + 0xbf36ea2e2d8dce2e, 0xbfe62e630e53386f, 0xbf38ff783012212f, 0xbfef91f05ddb4f8c, 0xbf3b14c23229f952, 0xbfec6ea472e59ddd, 0xbf3d2a0c33cc4c57, 0xbfdc067a51ce2dc9, + 0xbf3f3f5634f01004, 0x3fc7de35726f2c1c, 0xbf40aa501ac61d0c, 0x3fe794390bb3bd43, 0xbf41b4f51acbe02d, 0x3fefd5c4c756a9f5, 0xbf42bf9a1a84cc45, 0x3feb758d3944d6c1, + 0xbf43ca3f19ec5c36, 0x3fd860213df54e5f, 0xbf44d4e418fe0ae1, 0xbfcfadc11134baa4, 0xbf45df8917b55327, 0xbfe8e2787cff870c, 0xbf46ea2e160dafea, 0xbfeff9c048a79dc1, + 0xbf47f4d314029c0c, 0xbfea60fdbd7590a0, 0xbf48ff78118f926e, 0xbfd4a165a1bb093f, 0xbf4a0a1d0eb00df1, 0x3fd3aecde7ba01e6, 0xbf4b14c20b5f8977, 0x3fea17d301d0ee8f, + 0xbf4c1f6707997fe1, 0x3feffdbee2c0d304, 0xbf4d2a0c03596c11, 0x3fe9320aaa35a175, 0xbf4e34b0fe9ac8e7, 0x3fd0ce06973e1af2, 0xbf4f3f55f9591147, 0xbfd7730a883b0b39, + 0xbf5024fd79c7e008, 0xbfeb33132124fca6, 0xbf50aa4ff69d2813, 0xbfefe1bc96a37c30, 0xbf512fa2732a1e34, 0xbfe7e9e31077dc9b, 0xbf51b4f4ef6c7fdc, 0xbfc9d3afbc20d7f7, + 0xbf523a476b620a7d, 0x3fdb1fd1ce732fa2, 0xbf52bf99e7087b86, 0x3fec331d7ef046e7, 0xbf5344ec625d9069, 0x3fefa5d5695e8baf, 0xbf53ca3edd5f0697, 0x3fe689cf382e2760, + 0xbf544f91580a9b7f, 0x3fc1f17c0e4d0ded, 0xbf54d4e3d25e0c94, 0xbfdeb1769657753b, 0xbf555a364c571745, 0xbfed16f1f7986c48, 0xbf55df88c5f37904, 0xbfef4a454806908c, + 0xbf5664db3f30ef42, 0xbfe5132f57e44a87, 0xbf56ea2db80d376e, 0xbfb3faaa3f24538a, 0xbf576f8030860efb, 0x3fe112337087d50e, 0xbf57f4d2a8993358, 0x3fedddaca02cc58e, + 0xbf587a25204461f7, 0x3feecf67cbc4d168, 0xbf58ff7797855849, 0x3fe3877a346d1123, 0xbf5984ca0e59d3be, 0x3f8ff2fdfaef93a5, 0xbf5a0a1c84bf91c7, 0xbfe2ba97b3a8b9b6, + 0xbf5a8f6efab44fd5, 0xbfee8686aa70ba37, 0xbf5b14c17035cb59, 0xbfee35b7de304397, 0xbf5b9a13e541c1c4, 0xbfe1e83ba9e7d389, 0xbf5c1f6659d5f087, 0x3fa803d30a2091ef, + 0xbf5ca4b8cdf01513, 0x3fe4503f8671d78a, 0xbf5d2a0b418decd8, 0x3fef10d72bb33942, 0xbf5daf5db4ad3547, 0x3fed7dcf3e5dc3b4, 0xbf5e34b0274babd2, 0x3fe037131fd4a25c, + 0xbf5eba0299670de9, 0xbfbbf62fb0d489e6, 0xbf5f3f550afd18fd, 0xbfe5d19519105d79, 0xbf5fc4a77c0b8a7f, 0xbfef7c13c5cfc9c4, 0xbf6024fcf6480ff0, 0xbfeca865e7100857, + 0xbf6067a62e444b49, 0xbfdceb63d2d3eed2, 0xbf60aa4f65f95602, 0x3fc5e73e75b22239, 0xbf60ecf89d660ed5, 0x3fe73d16effb6a26, 0xbf612fa1d4895479, 0x3fefc7d1319bc339, + 0xbf61724b0b6205a6, 0x3febb65156a4aea3, 0xbf61b4f441ef0117, 0x3fd94bb3285c2984, 0xbf61f79d782f2582, 0xbfcdbd7babc426bf, 0xbf623a46ae2151a1, 0xbfe89159658387ef, + 0xbf627cefe3c4642c, 0xbfeff3c3aa32cd8d, 0xbf62bf9919173bdb, 0xbfeaa883b98d069a, 0xbf6302424e18b768, 0xbfd592b44c6719be, 0xbf6344eb82c7b58a, 0x3fd2bafc3bcacc25, + 0xbf638794b72314fb, 0x3fe9cd0815a60a66, 0xbf63ca3deb29b472, 0x3fefffbf38c7f501, 0xbf640ce71eda72a9, 0x3fe9800af7faaf01, 0xbf644f9052342e57, 0x3fd1c4209bb39398, + 0xbf6492398535c636, 0xbfd6847dccd17af3, 0xbf64d4e2b7de18fe, 0xbfeaeee732993128, 0xbf65178bea2c0567, 0xbfefebb7e09dc7fd, 0xbf655a351c1e6a2b, 0xbfe83e0fa7eaf942, + 0xbf659cde4db42601, 0xbfcbc78e14180948, 0xbf65df877eec17a2, 0x3fda3778a7cae7bf, 0xbf662230afc51dc8, 0x3febf5d4c0aa49a1, 0xbf6664d9e03e172a, 0x3fefb7c1ab05e219, + 0xbf66a7831055e281, 0x3fe6e3d3e46b78f2, 0xbf66ea2c400b5e86, 0x3fc3eb10a5a9f38b, 0xbf672cd56f5d69f1, 0xbfddd03974822827, 0xbf676f7e9e4ae37c, 0xbfece0c9b85c9397, + 0xbf67b227ccd2a9de, 0xbfef64109356b6de, 0xbf67f4d0faf39bd0, 0xbfe572b20b672581, 0xbf68377a28ac980b, 0xbfb7f54c601c957f, 0xbf687a2355fc7d48, 0x3fe0a5938bac62b8, + 0xbf68bccc82e22a40, 0x3fedaedb0d96568b, 0xbf68ff75af5c7daa, 0x3feef0f852e56309, 0xbf69421edb6a5640, 0x3fe3ec1b630ee38b, 0xbf6984c8070a92ba, 0x3f9ff1ff2ea931ff, + 0xbf69c771323c11d1, 0xbfe25263257a276a, 0xbf6a0a1a5cfdb23e, 0xbfee5f3a9aae23fd, 0xbf6a4cc3874e52b9, 0xbfee5eec0d4bedd1, 0xbf6a8f6cb12cd1fc, 0xbfe25196a891821c, + 0xbf6ad215da980ebe, 0x3fa00894243d1412, 0xbf6b14bf038ee7b9, 0x3fe3ecde8dc40c2d, 0xbf6b57682c103ba6, 0x3feef137eeb3f1a8, 0xbf6b9a11541ae93c, 0x3fedae7ddd359960, +] )) ), + +################ chunk 18944 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x41148459a462c000, 0x4114c24e9a769ed6, 0x4114b570033b0000, 0x4114f3f9350747cc, 0x4114e68662134000, 0x411525a3cf97f0c2, 0x4115179cc0eb8000, 0x4115574e6a2899b8, + 0x411548b31fc3c000, 0x411588f904b942ae, 0x411579c97e9c0000, 0x4115baa39f49eba4, 0x4115aadfdd744000, 0x4115ec4e39da949a, 0x4115dbf63c4c8000, 0x41161df8d46b3d90, + 0x41160d0c9b24c000, 0x41164fa36efbe687, 0x41163e22f9fd0000, 0x4116814e098c8f7d, 0x41166f3958d54000, 0x4116b2f8a41d3873, 0x4116a04fb7ad8000, 0x4116e4a33eade169, + 0x4116d1661685c000, 0x4117164dd93e8a5f, 0x4117027c755e0000, 0x411747f873cf3355, 0x41173392d4364000, 0x411779a30e5fdc4b, 0x411764a9330e8000, 0x4117ab4da8f08541, + 0x411795bf91e6c000, 0x4117dcf843812e37, 0x4117c6d5f0bf0000, 0x41180ea2de11d72d, 0x4117f7ec4f974000, 0x4118404d78a28023, 0x41182902ae6f8000, 0x411871f813332919, + 0x41185a190d47c000, 0x4118a3a2adc3d20f, 0x41188b2f6c200000, 0x4118d54d48547b05, 0x4118bc45caf84000, 0x411906f7e2e523fb, 0x4118ed5c29d08000, 0x411938a27d75ccf1, + 0x41191e7288a8c000, 0x41196a4d180675e7, 0x41194f88e7810000, 0x41199bf7b2971edd, 0x4119809f46594000, 0x4119cda24d27c7d3, 0x4119b1b5a5318000, 0x4119ff4ce7b870c9, + 0x4119e2cc0409c000, 0x411a30f7824919bf, 0x411a13e262e20000, 0x411a62a21cd9c2b5, 0x411a44f8c1ba4000, 0x411a944cb76a6bab, 0x411a760f20928000, 0x411ac5f751fb14a1, + 0x411aa7257f6ac000, 0x411af7a1ec8bbd97, 0x411ad83bde430000, 0x411b294c871c668d, 0x411b09523d1b4000, 0x411b5af721ad0f84, 0x411b3a689bf38000, 0x411b8ca1bc3db87a, + 0x411b6b7efacbc000, 0x411bbe4c56ce6170, 0x411b9c9559a40000, 0x411beff6f15f0a66, 0x411bcdabb87c4000, 0x411c21a18befb35c, 0x411bfec217548000, 0x411c534c26805c52, + 0x411c2fd8762cc000, 0x411c84f6c1110548, 0x411c60eed5050000, 0x411cb6a15ba1ae3e, 0x411c920533dd4000, 0x411ce84bf6325734, 0x411cc31b92b58000, 0x411d19f690c3002a, + 0x411cf431f18dc000, 0x411d4ba12b53a920, 0x411d254850660000, 0x411d7d4bc5e45216, 0x411d565eaf3e4000, 0x411daef66074fb0c, 0x411d87750e168000, 0x411de0a0fb05a402, + 0x411db88b6ceec000, 0x411e124b95964cf8, 0x411de9a1cbc70000, 0x411e43f63026f5ee, 0x411e1ab82a9f4000, 0x411e75a0cab79ee4, 0x411e4bce89778000, 0x411ea74b654847da, + 0x411e7ce4e84fc000, 0x411ed8f5ffd8f0d0, 0x411eadfb47280000, 0x411f0aa09a6999c6, 0x411edf11a6004000, 0x411f3c4b34fa42bc, 0x411f102804d88000, 0x411f6df5cf8aebb2, + 0x411f413e63b0c000, 0x411f9fa06a1b94a8, 0x411f7254c2890000, 0x411fd14b04ac3d9e, 0x411fa36b21614000, 0x4120017acf9e734a, 0x411fd48180398000, 0x41201a501ce6c7c5, + 0x412002cbef88e000, 0x412033256a2f1c40, 0x41201b571ef50000, 0x41204bfab77770bb, 0x412033e24e612000, 0x412064d004bfc536, 0x41204c6d7dcd4000, 0x41207da5520819b1, + 0x412064f8ad396000, 0x4120967a9f506e2c, 0x41207d83dca58000, 0x4120af4fec98c2a7, 0x4120960f0c11a000, 0x4120c82539e11722, 0x4120ae9a3b7dc000, 0x4120e0fa87296b9d, + 0x4120c7256ae9e000, 0x4120f9cfd471c018, 0x4120dfb09a560000, 0x412112a521ba1493, 0x4120f83bc9c22000, 0x41212b7a6f02690e, 0x412110c6f92e4000, 0x4121444fbc4abd89, + 0x41212952289a6000, 0x41215d2509931205, 0x412141dd58068000, 0x412175fa56db6680, 0x41215a688772a000, 0x41218ecfa423bafb, 0x412172f3b6dec000, 0x4121a7a4f16c0f76, + 0x41218b7ee64ae000, 0x4121c07a3eb463f1, 0x4121a40a15b70000, 0x4121d94f8bfcb86c, 0x4121bc9545232000, 0x4121f224d9450ce7, 0x4121d520748f4000, 0x41220afa268d6162, + 0x4121edaba3fb6000, 0x412223cf73d5b5dd, 0x41220636d3678000, 0x41223ca4c11e0a58, 0x41221ec202d3a000, 0x4122557a0e665ed3, 0x4122374d323fc000, 0x41226e4f5baeb34e, + 0x41224fd861abe000, 0x41228724a8f707c9, 0x4122686391180000, 0x41229ff9f63f5c44, 0x412280eec0842000, 0x4122b8cf4387b0bf, 0x41229979eff04000, 0x4122d1a490d0053a, + 0x4122b2051f5c6000, 0x4122ea79de1859b5, 0x4122ca904ec88000, 0x4123034f2b60ae30, 0x4122e31b7e34a000, 0x41231c2478a902ab, 0x4122fba6ada0c000, 0x412334f9c5f15726, + 0x41231431dd0ce000, 0x41234dcf1339aba1, 0x41232cbd0c790000, 0x412366a46082001c, 0x412345483be52000, 0x41237f79adca5497, 0x41235dd36b514000, 0x4123984efb12a912, + 0x4123765e9abd6000, 0x4123b124485afd8d, 0x41238ee9ca298000, 0x4123c9f995a35208, 0x4123a774f995a000, 0x4123e2cee2eba683, 0x4123c0002901c000, 0x4123fba43033fafe, + 0x4123d88b586de000, 0x412414797d7c4f79, 0x4123f11687da0000, 0x41242d4ecac4a3f4, 0x412409a1b7462000, 0x41244624180cf86f, 0x4124222ce6b24000, 0x41245ef965554cea, + 0x41243ab8161e6000, 0x412477ceb29da165, 0x41245343458a8000, 0x412490a3ffe5f5e0, 0x41246bce74f6a000, 0x4124a9794d2e4a5b, 0x41248459a462c000, 0x4124c24e9a769ed6, + 0x41249ce4d3cee000, 0x4124db23e7bef351, 0x4124b570033b0000, 0x4124f3f9350747cc, 0x4124cdfb32a72000, 0x41250cce824f9c47, 0x4124e68662134000, 0x412525a3cf97f0c2, + 0x4124ff11917f6000, 0x41253e791ce0453d, 0x4125179cc0eb8000, 0x4125574e6a2899b8, 0x41253027f057a000, 0x41257023b770ee33, 0x412548b31fc3c000, 0x412588f904b942ae, + 0x4125613e4f2fe000, 0x4125a1ce52019729, 0x412579c97e9c0000, 0x4125baa39f49eba4, 0x41259254ae082000, 0x4125d378ec92401f, 0x4125aadfdd744000, 0x4125ec4e39da949a, + 0x4125c36b0ce06000, 0x412605238722e915, 0x4125dbf63c4c8000, 0x41261df8d46b3d90, 0x4125f4816bb8a000, 0x412636ce21b3920b, 0x41260d0c9b24c000, 0x41264fa36efbe687, + 0x41262597ca90e000, 0x41266878bc443b02, 0x41263e22f9fd0000, 0x4126814e098c8f7d, 0x412656ae29692000, 0x41269a2356d4e3f8, 0x41266f3958d54000, 0x4126b2f8a41d3873, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbf6bdcba7badcf36, 0x3fe0a4be892151d6, 0xbf6c1f63a2c7cc4b, 0xbfb7fd0edb85c75b, 0xbf6c620cc967bf34, 0xbfe5736b20aadf15, 0xbf6ca4b5ef8c86ab, 0xbfef6440fdef8a28, + 0xbf6ce75f15350167, 0xbfece05e4236dfdf, 0xbf6d2a083a600e23, 0xbfddce800e481bf1, 0xbf6d6cb15f0c8b95, 0x3fc3eeea1c5904dc, 0xbf6daf5a83395879, 0x3fe6e4822b1bd827, + 0xbf6df203a6e55385, 0x3fefb7e2b3f99ba2, 0xbf6e34acca0f5b74, 0x3febf55b70405d2d, 0xbf6e7755ecb64efd, 0x3fda35b19a1af12d, 0xbf6eb9ff0ed90cda, 0xbfcbcb5be9aaa638, + 0xbf6efca8307673c4, 0xbfe83eb271a4f72b, 0xbf6f3f51518d6273, 0xbfefebc966e03224, 0xbf6f81fa721cb7a1, 0xbfeaee6081476b25, 0xbf6fc4a392235205, 0xbfd682aaded7fd08, + 0xbf7003a658d0082d, 0x3fd1c5ffcee3acc7, 0xbf7024fae848e8ac, 0x3fe980a1a1ea1c7d, 0xbf70464f777bb9dc, 0x3fefffc12ad1131d, 0xbf7067a40667eb19, 0x3fe9cc748a2b03b4, + 0xbf7088f8950cebc0, 0x3fd2b91f40a3c7c9, 0xbf70aa4d236a2b2d, 0xbfd59489e89b9079, 0xbf70cba1b17f18be, 0xbfeaa90dacf91a18, 0xbf70ecf63f4b23cd, 0xbfeff3b606106567, + 0xbf710e4acccdbbb9, 0xbfe890b99376b6e1, 0xbf712f9f5a064fdc, 0xbfcdb9b1555fd96b, 0xbf7150f3e6f44f95, 0x3fd94d7d57d1d784, 0xbf71724873972a3e, 0x3febb6ce098e62c6, + 0xbf71939cffee4f36, 0x3fefc7b404f2d7c0, 0xbf71b4f18bf92dd7, 0x3fe73c6b7740fa80, 0xbf71d64617b73580, 0x3fc5e36789fce8a2, 0xbf71f79aa327d58c, 0xbfdced20cb26ab85, + 0xbf7218ef2e4a7d57, 0xbfeca8d4dcb5f214, 0xbf723a43b91e9c3f, 0xbfef7be72dd01c14, 0xbf725b9843a3a1a0, 0xbfe5d0dea537cb38, 0xbf727ceccdd8fcd6, 0xbfbbee705da110b8, + 0xbf729e4157be1d3f, 0x3fe037ea21d38a97, 0xbf72bf95e1527235, 0x3fed7e3007bdbfc0, 0xbf72e0ea6a956b17, 0x3fef109b54fa2443, 0xbf73023ef3867741, 0x3fe44f7ecdf86042, + 0xbf7323937c25060e, 0x3fa7f440eb96f569, 0xbf7344e8047086dd, 0xbfe1e90a5aaf885a, 0xbf73663c8c686909, 0xbfee360a1a792edd, 0xbf738791140c1bef, 0xbfee863bd0da25cf, + 0xbf73a8e59b5b0eeb, 0xbfe2b9cd775cc36c, 0xbf73ca3a2254b15a, 0x3f9018ab030224fe, 0xbf73eb8ea8f87299, 0x3fe3883fc534f7ff, 0xbf740ce32f45c205, 0x3feecfab28b247b1, + 0xbf742e37b53c0ef9, 0x3feddd530e99a93a, 0xbf744f8c3adac8d3, 0x3fe111607ab99b53, 0xbf7470e0c0215eef, 0xbfb4026f66fe8d6c, 0xbf749235450f40aa, 0xbfe513eb030b2456, + 0xbf74b389c9a3dd61, 0xbfef4a798235d6e9, 0xbf74d4de4ddea46f, 0xbfed168a07a184cf, 0xbf74f632d1bf0532, 0xbfdeafc0ddc4a9c9, 0xbf75178755446f07, 0x3fc1f557d27004ad, + 0xbf7538dbd86e5149, 0x3fe68a8041f32218, 0xbf755a305b3c1b56, 0x3fefa5fa4c8f3836, 0xbf757b84ddad3c8b, 0x3fec32a7989139d6, 0xbf759cd95fc12444, 0x3fdb1e0dfed0ea0e, + 0xbf75be2de17741dd, 0xbfc9d780d45bfc37, 0xbf75df8262cf04b4, 0xbfe7ea88c7c113bf, 0xbf7600d6e3c7dc24, 0xbfefe1d1fdeee748, 0xbf76222b6461378c, 0xbfeb328fba4ebaa3, + 0xbf76437fe49a8647, 0xbfd7713a6588fa3a, 0xbf7664d4647337b3, 0x3fd0cfe7e4a78768, 0xbf768628e3eabb2b, 0x3fe932a4693b45fd, 0xbf76a77d6300800d, 0x3feffdc4b8bd5560, + 0xbf76c8d1e1b3f5b5, 0x3fea17429df70b84, 0xbf76ea2660048b81, 0x3fd3acf34244ca16, 0xbf770b7addf1b0cc, 0xbfd4a33dcef73dd4, 0xbf772ccf5b7ad4f5, 0xbfea618aea6820c2, + 0xbf774e23d89f6756, 0xbfeff9b6877f0814, 0xbf776f78555ed74e, 0xbfe8e1dbac9df40f, 0xbf7790ccd1b89438, 0xbfcfa9fa76aa3031, 0xbf77b2214dac0d73, 0x3fd861ee728ac39a, + 0xbf77d375c938b259, 0x3feb760d46e24551, 0xbf77f4ca445df24a, 0x3fefd5ab78cb549e, 0xbf78161ebf1b3ca0, 0x3fe793906ba1890e, 0xbf783773397000b9, 0x3fc7da614f0522b7, + 0xbf7858c7b35badf2, 0xbfdc083ac078f0e8, 0xbf787a1c2cddb3a7, 0xbfec6f16e11c854f, 0xbf789b70a5f58136, 0xbfef91c79b3e24b3, 0xbf78bcc51ea285fb, 0xbfe62daf4740448c, + 0xbf78de1996e43153, 0xbfbfe5d6d83978af, 0xbf78ff6e0eb9f29b, 0x3fdf927c103ba608, 0xbf7920c28623392f, 0x3fed4bae96e6e52e, 0xbf794216fd1f746e, 0x3fef2e4ed9664afc, + 0xbf79636b73ae13b2, 0x3fe4b19e43e5f5c6, 0xbf7984bfe9ce865a, 0x3fafee042d2f68a3, 0xbf79a6145f803bc3, 0xbfe17e93e39674ed, 0xbf79c768d4c2a348, 0xbfee0af7baccbd15, + 0xbf79e8bd49952c48, 0xbfeeaba4b5d3e2c5, 0xbf7a0a11bdf7461e, 0xbfe320d9980d4dfd, 0xbf7a2b6631e86028, 0x3f1f2d0010d1c417, 0xbf7a4cbaa567e9c3, 0x3fe3226971ae523a, + 0xbf7a6e0f1875524c, 0x3feeac32f0cee034, 0xbf7a8f638b100920, 0x3fee0a4be78bf0a1, 0xbf7ab0b7fd377d9b, 0x3fe17cf22fe3eab6, 0xbf7ad20c6eeb1f1a, 0xbfb00690ca9b68f5, + 0xbf7af360e02a5cfb, 0xbfe4b31ab374686c, 0xbf7b14b550f4a69b, 0xbfef2ebeedd27917, 0xbf7b3609c1496b56, 0xbfed4ae5d7447aae, 0xbf7b575e31281a89, 0xbfdf8f18386d44f1, + 0xbf7b78b2a0902392, 0x3fbff54e2ffbda10, 0xbf7b9a070f80f5cd, 0x3fe62f16d027167e, 0xbf7bbb5b7dfa0098, 0x3fef921918fc0ada, 0xbf7bdcafebfab34f, 0x3fec6e31fdebe942, + 0xbf7bfe0459827d4f, 0x3fdc04b9dc6e9e63, 0xbf7c1f58c690cdf6, 0xbfc7e2099056a1af, 0xbf7c40ad332514a1, 0xbfe794e1a6346248, 0xbf7c62019f3ec0ac, 0xbfefd5de0e552c6b, + 0xbf7c83560add4175, 0xbfeb750d251d3885, 0xbf7ca4aa76000658, 0xbfd85e540380f3dd, 0xbf7cc5fee0a67eb4, 0x3fcfb187a4696f09, 0xbf7ce7534ad019e4, 0x3fe8e3154781036d, + 0xbf7d08a7b47c4746, 0x3feff9ca023a4b24, 0xbf7d29fc1daa7637, 0x3fea60708a4099ac, 0xbf7d4b50865a1614, 0x3fd49f8d6f999ec9, 0xbf7d6ca4ee8a963a, 0xbfd3b0a888839449, + 0xbf7d8df9563b6607, 0xbfea18635f79c75b, 0xbf7daf4dbd6bf4d7, 0xbfeffdb9052cfd42, 0xbf7dd0a2241bb208, 0xbfe93170e53578f8, 0xbf7df1f68a4a0cf7, 0xbfd0cc2545ef05d2, + 0xbf7e134aeff67500, 0x3fd774daa5465537, 0xbf7e349f55205982, 0x3feb33968180ac3f, 0xbf7e55f3b9c729d9, 0x3fefe1a727c86b6b, 0xbf7e77481dea5563, 0x3fe7e93d5389f925, +] )) ), + +################ chunk 19456 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x412687c488416000, 0x4126cbcdf1658cee, 0x4126a04fb7ad8000, 0x4126e4a33eade169, 0x4126b8dae719a000, 0x4126fd788bf635e4, 0x4126d1661685c000, 0x4127164dd93e8a5f, + 0x4126e9f145f1e000, 0x41272f232686deda, 0x4127027c755e0000, 0x412747f873cf3355, 0x41271b07a4ca2000, 0x412760cdc11787d0, 0x41273392d4364000, 0x412779a30e5fdc4b, + 0x41274c1e03a26000, 0x412792785ba830c6, 0x412764a9330e8000, 0x4127ab4da8f08541, 0x41277d34627aa000, 0x4127c422f638d9bc, 0x412795bf91e6c000, 0x4127dcf843812e37, + 0x4127ae4ac152e000, 0x4127f5cd90c982b2, 0x4127c6d5f0bf0000, 0x41280ea2de11d72d, 0x4127df61202b2000, 0x412827782b5a2ba8, 0x4127f7ec4f974000, 0x4128404d78a28023, + 0x412810777f036000, 0x41285922c5ead49e, 0x41282902ae6f8000, 0x412871f813332919, 0x4128418ddddba000, 0x41288acd607b7d94, 0x41285a190d47c000, 0x4128a3a2adc3d20f, + 0x412872a43cb3e000, 0x4128bc77fb0c268a, 0x41288b2f6c200000, 0x4128d54d48547b05, 0x4128a3ba9b8c2000, 0x4128ee22959ccf80, 0x4128bc45caf84000, 0x412906f7e2e523fb, + 0x4128d4d0fa646000, 0x41291fcd302d7876, 0x4128ed5c29d08000, 0x412938a27d75ccf1, 0x412905e7593ca000, 0x41295177cabe216c, 0x41291e7288a8c000, 0x41296a4d180675e7, + 0x412936fdb814e000, 0x41298322654eca62, 0x41294f88e7810000, 0x41299bf7b2971edd, 0x4129681416ed2000, 0x4129b4ccffdf7358, 0x4129809f46594000, 0x4129cda24d27c7d3, + 0x4129992a75c56000, 0x4129e6779a701c4e, 0x4129b1b5a5318000, 0x4129ff4ce7b870c9, 0x4129ca40d49da000, 0x412a18223500c544, 0x4129e2cc0409c000, 0x412a30f7824919bf, + 0x4129fb573375e000, 0x412a49cccf916e3a, 0x412a13e262e20000, 0x412a62a21cd9c2b5, 0x412a2c6d924e2000, 0x412a7b776a221730, 0x412a44f8c1ba4000, 0x412a944cb76a6bab, + 0x412a5d83f1266000, 0x412aad2204b2c026, 0x412a760f20928000, 0x412ac5f751fb14a1, 0x412a8e9a4ffea000, 0x412adecc9f43691c, 0x412aa7257f6ac000, 0x412af7a1ec8bbd97, + 0x412abfb0aed6e000, 0x412b107739d41212, 0x412ad83bde430000, 0x412b294c871c668d, 0x412af0c70daf2000, 0x412b4221d464bb09, 0x412b09523d1b4000, 0x412b5af721ad0f84, + 0x412b21dd6c876000, 0x412b73cc6ef563ff, 0x412b3a689bf38000, 0x412b8ca1bc3db87a, 0x412b52f3cb5fa000, 0x412ba57709860cf5, 0x412b6b7efacbc000, 0x412bbe4c56ce6170, + 0x412b840a2a37e000, 0x412bd721a416b5eb, 0x412b9c9559a40000, 0x412beff6f15f0a66, 0x412bb52089102000, 0x412c08cc3ea75ee1, 0x412bcdabb87c4000, 0x412c21a18befb35c, + 0x412be636e7e86000, 0x412c3a76d93807d7, 0x412bfec217548000, 0x412c534c26805c52, 0x412c174d46c0a000, 0x412c6c2173c8b0cd, 0x412c2fd8762cc000, 0x412c84f6c1110548, + 0x412c4863a598e000, 0x412c9dcc0e5959c3, 0x412c60eed5050000, 0x412cb6a15ba1ae3e, 0x412c797a04712000, 0x412ccf76a8ea02b9, 0x412c920533dd4000, 0x412ce84bf6325734, + 0x412caa9063496000, 0x412d0121437aabaf, 0x412cc31b92b58000, 0x412d19f690c3002a, 0x412cdba6c221a000, 0x412d32cbde0b54a5, 0x412cf431f18dc000, 0x412d4ba12b53a920, + 0x412d0cbd20f9e000, 0x412d6476789bfd9b, 0x412d254850660000, 0x412d7d4bc5e45216, 0x412d3dd37fd22000, 0x412d9621132ca691, 0x412d565eaf3e4000, 0x412daef66074fb0c, + 0x412d6ee9deaa6000, 0x412dc7cbadbd4f87, 0x412d87750e168000, 0x412de0a0fb05a402, 0x412da0003d82a000, 0x412df976484df87d, 0x412db88b6ceec000, 0x412e124b95964cf8, + 0x412dd1169c5ae000, 0x412e2b20e2dea173, 0x412de9a1cbc70000, 0x412e43f63026f5ee, 0x412e022cfb332000, 0x412e5ccb7d6f4a69, 0x412e1ab82a9f4000, 0x412e75a0cab79ee4, + 0x412e33435a0b6000, 0x412e8e7617fff35f, 0x412e4bce89778000, 0x412ea74b654847da, 0x412e6459b8e3a000, 0x412ec020b2909c55, 0x412e7ce4e84fc000, 0x412ed8f5ffd8f0d0, + 0x412e957017bbe000, 0x412ef1cb4d21454b, 0x412eadfb47280000, 0x412f0aa09a6999c6, 0x412ec68676942000, 0x412f2375e7b1ee41, 0x412edf11a6004000, 0x412f3c4b34fa42bc, + 0x412ef79cd56c6000, 0x412f552082429737, 0x412f102804d88000, 0x412f6df5cf8aebb2, 0x412f28b33444a000, 0x412f86cb1cd3402d, 0x412f413e63b0c000, 0x412f9fa06a1b94a8, + 0x412f59c9931ce000, 0x412fb875b763e923, 0x412f7254c2890000, 0x412fd14b04ac3d9e, 0x412f8adff1f52000, 0x412fea2051f49219, 0x412fa36b21614000, 0x4130017acf9e734a, + 0x412fbbf650cd6000, 0x41300de576429d88, 0x412fd48180398000, 0x41301a501ce6c7c5, 0x412fed0cafa5a000, 0x413026bac38af203, 0x413002cbef88e000, 0x413033256a2f1c40, + 0x41300f11873ef000, 0x41303f9010d3467e, 0x41301b571ef50000, 0x41304bfab77770bb, 0x4130279cb6ab1000, 0x413058655e1b9af9, 0x413033e24e612000, 0x413064d004bfc536, + 0x41304027e6173000, 0x4130713aab63ef74, 0x41304c6d7dcd4000, 0x41307da5520819b1, 0x413058b315835000, 0x41308a0ff8ac43ef, 0x413064f8ad396000, 0x4130967a9f506e2c, + 0x4130713e44ef7000, 0x4130a2e545f4986a, 0x41307d83dca58000, 0x4130af4fec98c2a7, 0x413089c9745b9000, 0x4130bbba933cece5, 0x4130960f0c11a000, 0x4130c82539e11722, + 0x4130a254a3c7b000, 0x4130d48fe0854160, 0x4130ae9a3b7dc000, 0x4130e0fa87296b9d, 0x4130badfd333d000, 0x4130ed652dcd95db, 0x4130c7256ae9e000, 0x4130f9cfd471c018, + 0x4130d36b029ff000, 0x4131063a7b15ea56, 0x4130dfb09a560000, 0x413112a521ba1493, 0x4130ebf6320c1000, 0x41311f0fc85e3ed1, 0x4130f83bc9c22000, 0x41312b7a6f02690e, + 0x4131048161783000, 0x413137e515a6934c, 0x413110c6f92e4000, 0x4131444fbc4abd89, 0x41311d0c90e45000, 0x413150ba62eee7c7, 0x41312952289a6000, 0x41315d2509931205, + 0x41313597c0507000, 0x4131698fb0373c42, 0x413141dd58068000, 0x413175fa56db6680, 0x41314e22efbc9000, 0x41318264fd7f90bd, 0x41315a688772a000, 0x41318ecfa423bafb, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbf7e989c81894b7c, 0x3fc9cfde9df3d832, 0xbf7eb9f0e4a37b82, 0xbfdb2195979009e5, 0xbf7edb45473854d2, 0xbfec33935e9a8a8a, 0xbf7efc99a94746c9, 0xbfefa5b07eac9789, + 0xbf7f1dee0acfc0c4, 0xbfe6891e2915c006, 0xbf7f3f426bd13222, 0xbfc1eda04607cc5d, 0xbf7f6096cc4b0a3e, 0x3fdeb32c4793bc39, 0xbf7f81eb2c3cb877, 0x3fed1759e0a4ed52, + 0xbf7fa33f8ba5ac29, 0x3fef4a11066c3a92, 0xbf7fc493ea8554b2, 0x3fe51273a7c34029, 0xbf7fe5e848db216f, 0x3fb3f2e512cc425a, 0xbf80039e535340de, 0xbfe113066249105d, + 0xbf80144881f3727d, 0xbfedde062aa9a8e7, 0xbf8024f2b04ddd41, 0xbfeecf246787c60a, 0xbf80359cde6238da, 0xbfe386b49f02da16, 0xbf8046470c303cf6, 0xbf8fb4a5e84617a0, + 0xbf8056f139b7a145, 0x3fe2bb61eb82fda9, 0xbf80679b66f81d73, 0x3fee86d17cc904a5, 0xbf80784593f16932, 0x3fee35659abc3b10, 0xbf8088efc0a33c2e, 0x3fe1e76cf4e056ca, + 0xbf809999ed0d4e16, 0xbfa8136522f76142, 0xbf80aa44192f569b, 0xbfe451003a195ab1, 0xbf80baee45090d69, 0xbfef1112fb0d3249, 0xbf80cb98709a2a30, 0xbfed7d6e6dfe4e0b, + 0xbf80dc429be2649e, 0xbfe0363c19f5d50e, 0xbf80ececc6e17462, 0x3fbbfdeefda514d2, 0xbf80fd96f197112c, 0x3fe5d24b87c1665f, 0xbf810e411c02f2a9, 0x3fef7c405656e916, + 0xbf811eeb4624d088, 0x3feca7f6ea9d4892, 0xbf812f956ffc6279, 0x3fdce9a6d3a476a2, 0xbf81403f99896029, 0xbfc5eb155c34d451, 0xbf8150e9c2cb8147, 0xbfe73dc2633234ac, + 0xbf816193ebc27d83, 0xbfefc7ee56ba2776, 0xbf81723e146e0c8b, 0xbfebb5d49d2795ca, 0xbf8182e83ccde60e, 0xbfd949e8f2e5e122, 0xbf81939264e1c1ba, 0x3fcdc145fb19de59, + 0xbf81a43c8ca9573f, 0x3fe891f931bbf698, 0xbf81b4e6b4245e4b, 0x3feff3d146c0b0c2, 0xbf81c590db528e8c, 0x3feaa7f9bfc926e0, 0xbf81d63b02339fb2, 0x3fd590deab051aa4, + 0xbf81e6e528c7496c, 0xbfd2bcd9328f52d2, 0xbf81f78f4f0d4367, 0xbfe9cd9b9b0681d7, 0xbf82083975054554, 0xbfefffbd3f26fa13, 0xbf8218e39aaf06e1, 0xbfe97f7447f96640, + 0xbf82298dc00a3fbc, 0xbfd1c241643ce496, 0xbf823a37e516a794, 0x3fd68650b5821b62, 0xbf824ae209d3f619, 0x3feaef6ddd829281, 0xbf825b8c2e41e2f9, 0x3fefeba652c8e245, + 0xbf826c36526025e2, 0x3fe83d6cd8759588, 0xbf827ce0762e7684, 0x3fcbc3c0380d2db7, 0xbf828d8a99ac8c8e, 0xbfda393faf33b9ac, 0xbf829e34bcda1faf, 0xbfebf64e0a6ddb94, + 0xbf82aededfb6e794, 0xbfefb7a09a8c80cf, 0xbf82bf8902429bee, 0xbfe6e3259857d15f, 0xbf82d033247cf46a, 0xbfc3e7372a8028f1, 0xbf82e0dd4665a8b8, 0x3fddd1f2d38cdb89, + 0xbf82f18767fc7087, 0x3fece13527a8100e, 0xbf83023189410386, 0x3fef63e0214b081b, 0xbf8312dbaa331963, 0x3fe571f8f10c8c67, 0xbf832385cad269cd, 0x3fb7ed89df0408d3, + 0xbf83342feb1eac73, 0xbfe0a6688a443ba4, 0xbf8344da0b179905, 0xbfedaf3836ebf6c2, 0xbf8355842abce730, 0xbfeef0b8afbf4870, 0xbf83662e4a0e4ea4, 0xbfe3eb58339f89eb, + 0xbf8376d8690b8711, 0xbf9fd2d60d43b2a0, 0xbf83878287b44824, 0x3fe2532f9e09d462, 0xbf83982ca608498c, 0x3fee5f8920db634f, 0xbf83a8d6c40742f9, 0x3fee5e9d78b4d36f, + 0xbf83b980e1b0ec1a, 0x3fe250ca275014ff, 0xbf83ca2aff04fc9d, 0xbfa01828ad57981a, 0xbf83dad51c032c32, 0xbfe3eda1b3bed580, 0xbf83eb7f38ab3287, 0xbfeef177832ae534, + 0xbf83fc2954fcc74b, 0xbfedae20a5c9d55d, 0xbf840cd370f7a22d, 0xbfe0a3e982a33b89, 0xbf841d7d8c9b7add, 0x3fb804d1513dc709, 0xbf842e27a7e80909, 0x3fe5742430d78d37, + 0xbf843ed1c2dd0460, 0x3fef64716115767a, 0xbf844f7bdd7a2492, 0x3fecdff2c5370e68, 0xbf846025f7bf214c, 0x3fddccc6a10998f2, 0xbf8470d011abb23f, 0xbfc3f2c38e2d9e6e, + 0xbf84817a2b3f8f19, 0xbfe6e5306c58002c, 0xbf849224447a6f89, 0xbfefb803b567a4db, 0xbf84a2ce5d5c0b3f, 0xbfebf4e21930325d, 0xbf84b37875e419e8, 0xbfda33ea86244159, + 0xbf84c4228e125335, 0x3fcbcf29b8c41cd1, 0xbf84d4cca5e66ed4, 0x3fe83f5535a36812, 0xbf84e576bd602475, 0x3fefebdae5901bd8, 0xbf84f620d47f2bc6, 0x3feaedd9c98d5fd1, + 0xbf8506caeb433c76, 0x3fd680d7eb781c0b, 0xbf85177501ac0e35, 0xbfd1c7defdeb7c55, 0xbf85281f17b958b1, 0xbfe9813845d13550, 0xbf8538c92d6ad39a, 0xbfefffc3154273e3, + 0xbf85497342c0369f, 0xbfe9cbe0f88c19a2, 0xbf855a1d57b9396f, 0xbfd2b74240fc1d76, 0xbf856ac76c5593b8, 0x3fd5965f7fc02fd0, 0xbf857b718094fd2a, 0x3feaa9979a161a30, + 0xbf858c1b94772d75, 0x3feff3a85a597c47, 0xbf859cc5a7fbdc46, 0x3fe89019bb931905, 0xbf85ad6fbb22c14e, 0x3fcdb5e6f81c8d00, 0xbf85be19cdeb943c, 0xbfd94f47814dd775, + 0xbf85cec3e0560cbd, 0xbfebb74ab5de9523, 0xbf85df6df261e283, 0xbfefc796d0bef3ff, 0xbf85f018040ecd3b, 0xbfe73bbff90b4ee1, 0xbf8600c2155c8495, 0xbfc5df9099064d07, + 0xbf86116c264ac041, 0x3fdceeddbc86dad4, 0xbf86221636d937ec, 0x3feca943cb90b2dd, 0xbf8632c04707a347, 0x3fef7bba8e5a106a, 0xbf86436a56d5ba01, 0x3fe5d0282c235eca, + 0xbf865414664333c8, 0x3fbbe6b103ad12f0, 0xbf8664be754fc84c, 0xbfe038c1200a7dd6, 0xbf86756883fb2f3d, 0xbfed7e90ca1e2b35, 0xbf86861292452048, 0xbfef105f76de2a0d, + 0xbf8696bca02d531f, 0xbfe44ebe10ad2294, 0xbf86a766adb37f6f, 0xbfa7e4aec65e84ef, 0xbf86b810bad75ce8, 0x3fe1e9d907374431, 0xbf86c8bac798a339, 0x3fee365c4f9c2f39, + 0xbf86d964d3f70a11, 0x3fee85f0f005592f, 0xbf86ea0edff24920, 0x3fe2b90336925108, 0xbf86fab8eb8a1815, 0xbf9037d704bab7c3, 0xbf870b62f6be2e9f, 0xbfe3890551670bf6, + 0xbf871c0d018e446e, 0xbfeecfee7e5018eb, 0xbf872cb70bfa1130, 0xbfeddcf975eaa982, 0xbf873d6116014c95, 0xbfe1108d80de953a, 0xbf874e0b1fa3ae4c, 0x3fb40a348979c782, + 0xbf875eb528e0ee05, 0x3fe514a6a92e9960, 0xbf876f5f31b8c36e, 0x3fef4aadb4f424c7, 0xbf8780093a2ae638, 0x3fed162210c54fa0, 0xbf8790b342370e10, 0x3fdeae0b1e0ce67e, +] )) ), + +################ chunk 19968 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x413166ae1f28b000, 0x41319b3a4ac7e538, 0x413172f3b6dec000, 0x4131a7a4f16c0f76, 0x41317f394e94d000, 0x4131b40f981039b3, 0x41318b7ee64ae000, 0x4131c07a3eb463f1, + 0x413197c47e00f000, 0x4131cce4e5588e2e, 0x4131a40a15b70000, 0x4131d94f8bfcb86c, 0x4131b04fad6d1000, 0x4131e5ba32a0e2a9, 0x4131bc9545232000, 0x4131f224d9450ce7, + 0x4131c8dadcd93000, 0x4131fe8f7fe93724, 0x4131d520748f4000, 0x41320afa268d6162, 0x4131e1660c455000, 0x41321764cd318b9f, 0x4131edaba3fb6000, 0x413223cf73d5b5dd, + 0x4131f9f13bb17000, 0x4132303a1a79e01a, 0x41320636d3678000, 0x41323ca4c11e0a58, 0x4132127c6b1d9000, 0x4132490f67c23495, 0x41321ec202d3a000, 0x4132557a0e665ed3, + 0x41322b079a89b000, 0x413261e4b50a8910, 0x4132374d323fc000, 0x41326e4f5baeb34e, 0x41324392c9f5d000, 0x41327aba0252dd8b, 0x41324fd861abe000, 0x41328724a8f707c9, + 0x41325c1df961f000, 0x4132938f4f9b3206, 0x4132686391180000, 0x41329ff9f63f5c44, 0x413274a928ce1000, 0x4132ac649ce38681, 0x413280eec0842000, 0x4132b8cf4387b0bf, + 0x41328d34583a3000, 0x4132c539ea2bdafc, 0x41329979eff04000, 0x4132d1a490d0053a, 0x4132a5bf87a65000, 0x4132de0f37742f77, 0x4132b2051f5c6000, 0x4132ea79de1859b5, + 0x4132be4ab7127000, 0x4132f6e484bc83f2, 0x4132ca904ec88000, 0x4133034f2b60ae30, 0x4132d6d5e67e9000, 0x41330fb9d204d86d, 0x4132e31b7e34a000, 0x41331c2478a902ab, + 0x4132ef6115eab000, 0x4133288f1f4d2ce8, 0x4132fba6ada0c000, 0x413334f9c5f15726, 0x413307ec4556d000, 0x413341646c958163, 0x41331431dd0ce000, 0x41334dcf1339aba1, + 0x4133207774c2f000, 0x41335a39b9ddd5de, 0x41332cbd0c790000, 0x413366a46082001c, 0x41333902a42f1000, 0x4133730f07262a59, 0x413345483be52000, 0x41337f79adca5497, + 0x4133518dd39b3000, 0x41338be4546e7ed4, 0x41335dd36b514000, 0x4133984efb12a912, 0x41336a1903075000, 0x4133a4b9a1b6d34f, 0x4133765e9abd6000, 0x4133b124485afd8d, + 0x413382a432737000, 0x4133bd8eeeff27ca, 0x41338ee9ca298000, 0x4133c9f995a35208, 0x41339b2f61df9000, 0x4133d6643c477c46, 0x4133a774f995a000, 0x4133e2cee2eba683, + 0x4133b3ba914bb000, 0x4133ef39898fd0c1, 0x4133c0002901c000, 0x4133fba43033fafe, 0x4133cc45c0b7d000, 0x4134080ed6d8253c, 0x4133d88b586de000, 0x413414797d7c4f79, + 0x4133e4d0f023f000, 0x413420e4242079b7, 0x4133f11687da0000, 0x41342d4ecac4a3f4, 0x4133fd5c1f901000, 0x413439b97168ce32, 0x413409a1b7462000, 0x41344624180cf86f, + 0x413415e74efc3000, 0x4134528ebeb122ad, 0x4134222ce6b24000, 0x41345ef965554cea, 0x41342e727e685000, 0x41346b640bf97728, 0x41343ab8161e6000, 0x413477ceb29da165, + 0x413446fdadd47000, 0x413484395941cba3, 0x41345343458a8000, 0x413490a3ffe5f5e0, 0x41345f88dd409000, 0x41349d0ea68a201e, 0x41346bce74f6a000, 0x4134a9794d2e4a5b, + 0x413478140cacb000, 0x4134b5e3f3d27499, 0x41348459a462c000, 0x4134c24e9a769ed6, 0x4134909f3c18d000, 0x4134ceb9411ac914, 0x41349ce4d3cee000, 0x4134db23e7bef351, + 0x4134a92a6b84f000, 0x4134e78e8e631d8f, 0x4134b570033b0000, 0x4134f3f9350747cc, 0x4134c1b59af11000, 0x41350063dbab720a, 0x4134cdfb32a72000, 0x41350cce824f9c47, + 0x4134da40ca5d3000, 0x4135193928f3c685, 0x4134e68662134000, 0x413525a3cf97f0c2, 0x4134f2cbf9c95000, 0x4135320e763c1b00, 0x4134ff11917f6000, 0x41353e791ce0453d, + 0x41350b5729357000, 0x41354ae3c3846f7b, 0x4135179cc0eb8000, 0x4135574e6a2899b8, 0x413523e258a19000, 0x413563b910ccc3f6, 0x41353027f057a000, 0x41357023b770ee33, + 0x41353c6d880db000, 0x41357c8e5e151871, 0x413548b31fc3c000, 0x413588f904b942ae, 0x413554f8b779d000, 0x41359563ab5d6cec, 0x4135613e4f2fe000, 0x4135a1ce52019729, + 0x41356d83e6e5f000, 0x4135ae38f8a5c167, 0x413579c97e9c0000, 0x4135baa39f49eba4, 0x4135860f16521000, 0x4135c70e45ee15e2, 0x41359254ae082000, 0x4135d378ec92401f, + 0x41359e9a45be3000, 0x4135dfe393366a5d, 0x4135aadfdd744000, 0x4135ec4e39da949a, 0x4135b725752a5000, 0x4135f8b8e07ebed8, 0x4135c36b0ce06000, 0x413605238722e915, + 0x4135cfb0a4967000, 0x4136118e2dc71353, 0x4135dbf63c4c8000, 0x41361df8d46b3d90, 0x4135e83bd4029000, 0x41362a637b0f67ce, 0x4135f4816bb8a000, 0x413636ce21b3920b, + 0x413600c7036eb000, 0x41364338c857bc49, 0x41360d0c9b24c000, 0x41364fa36efbe687, 0x4136195232dad000, 0x41365c0e15a010c4, 0x41362597ca90e000, 0x41366878bc443b02, + 0x413631dd6246f000, 0x413674e362e8653f, 0x41363e22f9fd0000, 0x4136814e098c8f7d, 0x41364a6891b31000, 0x41368db8b030b9ba, 0x413656ae29692000, 0x41369a2356d4e3f8, + 0x413662f3c11f3000, 0x4136a68dfd790e35, 0x41366f3958d54000, 0x4136b2f8a41d3873, 0x41367b7ef08b5000, 0x4136bf634ac162b0, 0x413687c488416000, 0x4136cbcdf1658cee, + 0x4136940a1ff77000, 0x4136d8389809b72b, 0x4136a04fb7ad8000, 0x4136e4a33eade169, 0x4136ac954f639000, 0x4136f10de5520ba6, 0x4136b8dae719a000, 0x4136fd788bf635e4, + 0x4136c5207ecfb000, 0x413709e3329a6021, 0x4136d1661685c000, 0x4137164dd93e8a5f, 0x4136ddabae3bd000, 0x413722b87fe2b49c, 0x4136e9f145f1e000, 0x41372f232686deda, + 0x4136f636dda7f000, 0x41373b8dcd2b0917, 0x4137027c755e0000, 0x413747f873cf3355, 0x41370ec20d141000, 0x413754631a735d92, 0x41371b07a4ca2000, 0x413760cdc11787d0, + 0x4137274d3c803000, 0x41376d3867bbb20d, 0x41373392d4364000, 0x413779a30e5fdc4b, 0x41373fd86bec5000, 0x4137860db5040688, 0x41374c1e03a26000, 0x413792785ba830c6, + 0x413758639b587000, 0x41379ee3024c5b03, 0x413764a9330e8000, 0x4137ab4da8f08541, 0x413770eecac49000, 0x4137b7b84f94af7e, 0x41377d34627aa000, 0x4137c422f638d9bc, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbf87a15d49dcf2a8, 0xbfc1f93392403f91, 0xbf87b207511c4bad, 0xbfe68b314650a670, 0xbf87c2b157f4d0d0, 0xbfefa61f283ccdd4, 0xbf87d35b5e6639bf, 0xbfec3231ab8abc48, + 0xbf87e40564703e2a, 0xbfdb1c4a28ca3fbf, 0xbf87f4af6a1295c0, 0x3fc9db51e61f29f9, 0xbf8805596f4cf831, 0x3fe7eb2e7959814b, 0xbf881603741f1d2c, 0x3fefe1e75da7bd1e, + 0xbf8826ad7888bc61, 0x3feb320c4d0780e9, 0xbf8837577c898d7e, 0x3fd76f6a3d6fd682, 0xbf88480180214833, 0xbfd0d1c92e081c5e, 0xbf8858ab834fa430, 0xbfe9333e2237777d, + 0xbf88695586145923, 0xbfeffdca87225365, 0xbf8879ff886f1ebd, 0xbfea16b233fa265c, 0xbf888aa98a5facad, 0xbfd3ab1898339741, 0xbf889b538be5baa1, 0x3fd4a515f7205d5e, + 0xbf88abfd8d01004a, 0x3fea62181113a19d, 0xbf88bca78db13557, 0x3feff9acbebfd878, 0xbf88cd518df61177, 0x3fe8e13ed6470eaf, 0xbf88ddfb8dcf4c5a, 0x3fcfa633d484f274, + 0xbf88eea58d3c9db0, 0xbfd863bba17fc553, 0xbf88ff4f8c3dbd27, 0xbfeb768d4dfea3f6, 0xbf890ff98ad2626f, 0xbfefd59222b00ca7, 0xbf8920a388fa4537, 0xbfe792e7c5f3c99a, + 0xbf89314d86b51d30, 0xbfc7d68d259f9a1b, 0xbf8941f78402a209, 0x3fdc09fb288410f4, 0xbf8952a180e28b70, 0x3fec6f89489d5cb6, 0xbf89634b7d549116, 0x3fef919ed1229e19, + 0xbf8973f579586aaa, 0x3fe62cfb7adc5fcf, 0xbf89849f74edcfdc, 0x3fbfde1b20fce311, 0xbf8995497014785b, 0xbfdf942df1021079, 0xbf89a5f36acc1bd6, 0xbfed4c12ec4ac774, + 0xbf89b69d651471fd, 0xbfef2e16c4136d01, 0xbf89c7475eed3281, 0xbfe4b0e004c10f7b, 0xbf89d7f15856150f, 0xbfafde756cccf76a, 0xbf89e89b514ed158, 0x3fe17f64b735c210, + 0xbf89f94549d71f0c, 0x3fee0b4d99c13b00, 0xbf8a09ef41eeb5d9, 0x3feeab5d8d6bb694, 0xbf8a1a9939954d70, 0x3fe32011a460ef26, 0xbf8a2b4330ca9d80, 0xbf2f2d000d1eded0, + 0xbf8a3bed278e5db9, 0xbfe3233157bc3f7d, 0xbf8a4c971de045ca, 0xbfeeac7a03618fb2, 0xbf8a5d4113c00d63, 0xbfee09f5f334c4fb, 0xbf8a6deb092d6c33, 0xbfe17c214fd110bf, + 0xbf8a7e94fe2819eb, 0x3fb00e581f69b3e4, 0xbf8a8f3ef2afce39, 0x3fe4b3d8e3dd9a81, 0xbf8a9fe8e6c440ce, 0x3fef2ef6ecebb084, 0xbf8ab092da652959, 0x3fed4a816d062216, + 0xbf8ac13ccd923f89, 0x3fdf8d6641661e25, 0xbf8ad1e6c04b3b0f, 0xbfbffd09d07dfa51, 0xbf8ae290b28fd39a, 0xbfe62fca8ca9afbe, 0xbf8af33aa45fc0d9, 0xbfef9241cc9e5712, + 0xbf8b03e495baba7d, 0xbfec6dbf823c5ca8, 0xbf8b148e86a07835, 0xbfdc02f9607040bb, 0xbf8b25387710b1b1, 0x3fc7e5dda840c85a, 0xbf8b35e2670b1ea0, 0x3fe7958a3b192c09, + 0xbf8b468c568f76b3, 0x3fefd5f74dc3b230, 0xbf8b5736459d7198, 0x3feb748d0a74c725, 0xbf8b67e03434c700, 0x3fd85c86c36d0237, 0xbf8b788a22552e9b, 0xbfcfb54e3001a56e, + 0xbf8b89340ffe6017, 0xbfe8e3b20c0ce484, 0xbf8b99ddfd301326, 0xbfeff9d3b43659f8, 0xbf8baa87e9e9ff76, 0xbfea5fe350d6f4b4, 0xbf8bbb31d62bdcb7, 0xbfd49db538a29429, + 0xbf8bcbdbc1f5629a, 0x3fd3b28324736512, 0xbf8bdc85ad4648ce, 0x3fea18f3b6ecd27c, 0xbf8bed2f981e4702, 0x3feffdb320026715, 0xbf8bfdd9827d14e7, 0x3fe930d71a3fdffb, + 0xbf8c0e836c626a2d, 0x3fd0ca43f097fd9e, 0xbf8c1f2d55cdfe83, 0xbfd776aabce9aecb, 0xbf8c2fd73ebf8998, 0xbfeb3419db6b25c7, 0xbf8c40812736c31e, 0xbfefe191b15acd9d, + 0xbf8c512b0f3362c3, 0xbfe7e89790eb9abd, 0xbf8c61d4f6b52038, 0xbfc9cc0d7950b012, 0xbf8c727eddbbb32d, 0x3fdb23595a47a903, 0xbf8c8328c446d350, 0x3fec3409379d2406, + 0xbf8c93d2aa563853, 0x3fefa58b8c779dfd, 0xbf8ca47c8fe999e5, 0x3fe6886d149634f3, 0xbf8cb5267500afb6, 0x3fc1e9c47971a3b7, 0xbf8cc5d0599b3175, 0xbfdeb4e1f1aa39c6, + 0xbf8cd67a3db8d6d4, 0xbfed17c1c2cbef53, 0xbf8ce72421595781, 0xbfef49dcbd6102fc, 0xbf8cf7ce047c6b2d, 0xbfe511b7f29f2a16, 0xbf8d0877e721c987, 0xbfb3eb1fe118e029, + 0xbf8d1921c9492a3f, 0x3fe113d94ffd1b31, 0xbf8d29cbaaf24507, 0x3fedde5fae15fbe0, 0xbf8d3a758c1cd18c, 0x3feecee0fbfb3596, 0xbf8d4b1f6cc88780, 0x3fe385ef04e9d45d, + 0xbf8d5bc94cf51e92, 0x3f8f764dce16a10c, 0xbf8d6c732ca24e72, 0xbfe2bc2c1ef857e1, 0xbf8d7d1d0bcfced1, 0xbfee871c47e2f358, 0xbf8d8dc6ea7d575e, 0xbfee35135017e117, + 0xbf8d9e70c8aa9fc9, 0xbfe1e69e3b994329, 0xbf8daf1aa6575fc3, 0x3fa822f7371768aa, 0xbf8dbfc483834efb, 0x3fe451c0e8eebbfe, 0xbf8dd06e602e2521, 0x3fef114ec30bd6b3, + 0xbf8de1183c5799e6, 0x3fed7d0d969f75bd, 0xbf8df1c217ff64f9, 0x3fe03565104f79cb, 0xbf8e026bf3253e0b, 0xbfbc05ae43b16de9, 0xbf8e1315cdc8dccb, 0xbfe5d301f1363fd7, + 0xbf8e23bfa7e9f8ea, 0xbfef7c6cdf64b8ac, 0xbf8e346981884a18, 0xbfeca787e766b455, 0xbf8e45135aa38805, 0xbfdce7e9cd9fcfc1, 0xbf8e55bd333b6a60, 0x3fc5eeec3d354497, + 0xbf8e66670b4fa8db, 0x3fe73e6dd0e27198, 0xbf8e7710e2dffb25, 0x3fefc80b744ba824, 0xbf8e87bab9ec18ee, 0x3febb557dd193613, 0xbf8e98649073b9e6, 0x3fd9481eb7942a44, + 0xbf8ea90e667695bf, 0xbfcdc51043508a4c, 0xbf8eb9b83bf46427, 0xbfe89298f8130d2f, 0xbf8eca6210ecdcce, 0xbfeff3dedbb92c40, 0xbf8edb0be55fb766, 0xbfeaa76fbfbf5035, + 0xbf8eebb5b94cab9f, 0xbfd58f0904942358, 0xbf8efc5f8cb37127, 0x3fd2beb624b3b8b6, 0xbf8f0d095f93bfb1, 0x3fe9ce2f1a42d04a, 0xbf8f1db331ed4eeb, 0x3fefffbb3dee6464, + 0xbf8f2e5d03bfd687, 0x3fe97edd91f010bb, 0xbf8f3f06d50b0e33, 0x3fd1c06228bd8e37, 0xbf8f4fb0a5ceada1, 0xbfd6882398cb7b80, 0xbf8f605a760a6c81, 0xbfeaeff4820c12e2, + 0xbf8f710445be0284, 0xbfefeb94bd5f43da, 0xbf8f81ae14e92758, 0xbfe83cca033a80c7, 0xbf8f9257e38b92af, 0xbfcbbff2550e068e, 0xbf8fa301b1a4fc39, 0x3fda3b06b0722bee, + 0xbf8fb3ab7f351ba6, 0x3febf6c74d9a8570, 0xbf8fc4554c3ba8a6, 0x3fefb77f828b6099, 0xbf8fd4ff18b85aeb, 0x3fe6e27746c51651, 0xbf8fe5a8e4aaea23, 0x3fc3e35daa7dba46, +] )) ), + +################ chunk 20480 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x41378979fa30b000, 0x4137d08d9cdd03f9, 0x413795bf91e6c000, 0x4137dcf843812e37, 0x4137a205299cd000, 0x4137e962ea255874, 0x4137ae4ac152e000, 0x4137f5cd90c982b2, + 0x4137ba905908f000, 0x41380238376dacef, 0x4137c6d5f0bf0000, 0x41380ea2de11d72d, 0x4137d31b88751000, 0x41381b0d84b6016a, 0x4137df61202b2000, 0x413827782b5a2ba8, + 0x4137eba6b7e13000, 0x413833e2d1fe55e5, 0x4137f7ec4f974000, 0x4138404d78a28023, 0x41380431e74d5000, 0x41384cb81f46aa60, 0x413810777f036000, 0x41385922c5ead49e, + 0x41381cbd16b97000, 0x4138658d6c8efedb, 0x41382902ae6f8000, 0x413871f813332919, 0x4138354846259000, 0x41387e62b9d75356, 0x4138418ddddba000, 0x41388acd607b7d94, + 0x41384dd37591b000, 0x41389738071fa7d1, 0x41385a190d47c000, 0x4138a3a2adc3d20f, 0x4138665ea4fdd000, 0x4138b00d5467fc4c, 0x413872a43cb3e000, 0x4138bc77fb0c268a, + 0x41387ee9d469f000, 0x4138c8e2a1b050c8, 0x41388b2f6c200000, 0x4138d54d48547b05, 0x4138977503d61000, 0x4138e1b7eef8a543, 0x4138a3ba9b8c2000, 0x4138ee22959ccf80, + 0x4138b00033423000, 0x4138fa8d3c40f9be, 0x4138bc45caf84000, 0x413906f7e2e523fb, 0x4138c88b62ae5000, 0x4139136289894e39, 0x4138d4d0fa646000, 0x41391fcd302d7876, + 0x4138e116921a7000, 0x41392c37d6d1a2b4, 0x4138ed5c29d08000, 0x413938a27d75ccf1, 0x4138f9a1c1869000, 0x4139450d2419f72f, 0x413905e7593ca000, 0x41395177cabe216c, + 0x4139122cf0f2b000, 0x41395de271624baa, 0x41391e7288a8c000, 0x41396a4d180675e7, 0x41392ab8205ed000, 0x413976b7beaaa025, 0x413936fdb814e000, 0x41398322654eca62, + 0x413943434fcaf000, 0x41398f8d0bf2f4a0, 0x41394f88e7810000, 0x41399bf7b2971edd, 0x41395bce7f371000, 0x4139a862593b491b, 0x4139681416ed2000, 0x4139b4ccffdf7358, + 0x41397459aea33000, 0x4139c137a6839d96, 0x4139809f46594000, 0x4139cda24d27c7d3, 0x41398ce4de0f5000, 0x4139da0cf3cbf211, 0x4139992a75c56000, 0x4139e6779a701c4e, + 0x4139a5700d7b7000, 0x4139f2e24114468c, 0x4139b1b5a5318000, 0x4139ff4ce7b870c9, 0x4139bdfb3ce79000, 0x413a0bb78e5c9b07, 0x4139ca40d49da000, 0x413a18223500c544, + 0x4139d6866c53b000, 0x413a248cdba4ef82, 0x4139e2cc0409c000, 0x413a30f7824919bf, 0x4139ef119bbfd000, 0x413a3d6228ed43fd, 0x4139fb573375e000, 0x413a49cccf916e3a, + 0x413a079ccb2bf000, 0x413a563776359878, 0x413a13e262e20000, 0x413a62a21cd9c2b5, 0x413a2027fa981000, 0x413a6f0cc37decf3, 0x413a2c6d924e2000, 0x413a7b776a221730, + 0x413a38b32a043000, 0x413a87e210c6416e, 0x413a44f8c1ba4000, 0x413a944cb76a6bab, 0x413a513e59705000, 0x413aa0b75e0e95e9, 0x413a5d83f1266000, 0x413aad2204b2c026, + 0x413a69c988dc7000, 0x413ab98cab56ea64, 0x413a760f20928000, 0x413ac5f751fb14a1, 0x413a8254b8489000, 0x413ad261f89f3edf, 0x413a8e9a4ffea000, 0x413adecc9f43691c, + 0x413a9adfe7b4b000, 0x413aeb3745e7935a, 0x413aa7257f6ac000, 0x413af7a1ec8bbd97, 0x413ab36b1720d000, 0x413b040c932fe7d5, 0x413abfb0aed6e000, 0x413b107739d41212, + 0x413acbf6468cf000, 0x413b1ce1e0783c50, 0x413ad83bde430000, 0x413b294c871c668d, 0x413ae48175f91000, 0x413b35b72dc090cb, 0x413af0c70daf2000, 0x413b4221d464bb09, + 0x413afd0ca5653000, 0x413b4e8c7b08e546, 0x413b09523d1b4000, 0x413b5af721ad0f84, 0x413b1597d4d15000, 0x413b6761c85139c1, 0x413b21dd6c876000, 0x413b73cc6ef563ff, + 0x413b2e23043d7000, 0x413b803715998e3c, 0x413b3a689bf38000, 0x413b8ca1bc3db87a, 0x413b46ae33a99000, 0x413b990c62e1e2b7, 0x413b52f3cb5fa000, 0x413ba57709860cf5, + 0x413b5f396315b000, 0x413bb1e1b02a3732, 0x413b6b7efacbc000, 0x413bbe4c56ce6170, 0x413b77c49281d000, 0x413bcab6fd728bad, 0x413b840a2a37e000, 0x413bd721a416b5eb, + 0x413b904fc1edf000, 0x413be38c4abae028, 0x413b9c9559a40000, 0x413beff6f15f0a66, 0x413ba8daf15a1000, 0x413bfc61980334a3, 0x413bb52089102000, 0x413c08cc3ea75ee1, + 0x413bc16620c63000, 0x413c1536e54b891e, 0x413bcdabb87c4000, 0x413c21a18befb35c, 0x413bd9f150325000, 0x413c2e0c3293dd99, 0x413be636e7e86000, 0x413c3a76d93807d7, + 0x413bf27c7f9e7000, 0x413c46e17fdc3214, 0x413bfec217548000, 0x413c534c26805c52, 0x413c0b07af0a9000, 0x413c5fb6cd24868f, 0x413c174d46c0a000, 0x413c6c2173c8b0cd, + 0x413c2392de76b000, 0x413c788c1a6cdb0a, 0x413c2fd8762cc000, 0x413c84f6c1110548, 0x413c3c1e0de2d000, 0x413c916167b52f85, 0x413c4863a598e000, 0x413c9dcc0e5959c3, + 0x413c54a93d4ef000, 0x413caa36b4fd8400, 0x413c60eed5050000, 0x413cb6a15ba1ae3e, 0x413c6d346cbb1000, 0x413cc30c0245d87b, 0x413c797a04712000, 0x413ccf76a8ea02b9, + 0x413c85bf9c273000, 0x413cdbe14f8e2cf6, 0x413c920533dd4000, 0x413ce84bf6325734, 0x413c9e4acb935000, 0x413cf4b69cd68171, 0x413caa9063496000, 0x413d0121437aabaf, + 0x413cb6d5faff7000, 0x413d0d8bea1ed5ec, 0x413cc31b92b58000, 0x413d19f690c3002a, 0x413ccf612a6b9000, 0x413d266137672a67, 0x413cdba6c221a000, 0x413d32cbde0b54a5, + 0x413ce7ec59d7b000, 0x413d3f3684af7ee2, 0x413cf431f18dc000, 0x413d4ba12b53a920, 0x413d00778943d000, 0x413d580bd1f7d35d, 0x413d0cbd20f9e000, 0x413d6476789bfd9b, + 0x413d1902b8aff000, 0x413d70e11f4027d8, 0x413d254850660000, 0x413d7d4bc5e45216, 0x413d318de81c1000, 0x413d89b66c887c53, 0x413d3dd37fd22000, 0x413d9621132ca691, + 0x413d4a1917883000, 0x413da28bb9d0d0ce, 0x413d565eaf3e4000, 0x413daef66074fb0c, 0x413d62a446f45000, 0x413dbb610719254a, 0x413d6ee9deaa6000, 0x413dc7cbadbd4f87, + 0x413d7b2f76607000, 0x413dd436546179c5, 0x413d87750e168000, 0x413de0a0fb05a402, 0x413d93baa5cc9000, 0x413ded0ba1a9ce40, 0x413da0003d82a000, 0x413df976484df87d, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbf8ff652b0130e00, 0xbfddd3ac2bae96a0, 0xbf90037e3d783f19, 0xbfece1a090193bc8, 0xbf900bd322a17934, 0xbfef63afa7c96d06, 0xbf9014280785112a, 0xbfe5713fd19b3fb3, + 0xbf901c7cec22e2d3, 0xbfb7e5c757be87cc, 0xbf9024d1d07aca07, 0x3fe0a73d84e8aa10, 0xbf902d26b48ca29e, 0x3fedaf95593c5d3b, 0xbf90357b98584871, 0x3feef0790541b0f6, + 0xbf903dd07bdd9757, 0x3fe3ea94ff69a7a1, 0xbf9046255f1c6b29, 0x3f9fb3ace4510ee8, 0xbf904e7a42149fc0, 0xbfe253fc124d761d, 0xbf9056cf24c610f2, 0xbfee5fd79fd39926, + 0xbf905f2407309a9a, 0xbfee5e4edce3dc44, 0xbf906778e954188d, 0xbfe24ffda1b6109a, 0xbf906fcdcb3066a6, 0x3fa027bd33a05207, 0xbf907822acc560bc, 0x3fe3ee64d4ff1136, + 0xbf9080778e12e2a8, 0x3feef1b7104e4210, 0xbf9088cc6f18c841, 0x3fedadc3675320a1, 0xbf9091214fd6ed60, 0x3fe0a3147824a779, 0xbf909976304d2dde, 0xbfb80c93c142bd2c, + 0xbf90a1cb107b6591, 0xbfe574dd3be12532, 0xbf90aa1ff0617054, 0xbfef64a1bcc8705b, 0xbf90b274cfff29fd, 0xbfecdf8741641ea2, 0xbf90bac9af546e66, 0xbfddcb0d2cb8df7a, + 0xbf90c31e8e611966, 0x3fc3f69cfb073b1e, 0xbf90cb736d2506d6, 0x3fe6e5dea8255ed1, 0xbf90d3c84ba0128e, 0x3fefb824af4bba8d, 0xbf90dc1d29d21867, 0x3febf468bb81aec1, + 0xbf90e47207baf438, 0x3fda32236c21a853, 0xbf90ecc6e55a81da, 0xbfcbd2f781250d24, 0xbf90f51bc2b09d25, 0xbfe83ff7f3d143b5, 0xbf90fd709fbd21f2, 0xbfefebec5cac61a1, + 0xbf9105c57c7fec19, 0xbfeaed530b7c78b0, 0xbf910e1a58f8d772, 0xbfd67f04f2d03b84, 0xbf91166f3527bfd5, 0x3fd1c9be288d15b2, 0xbf911ec4110c811c, 0x3fe981cee3a62bc3, + 0xbf912718eca6f71d, 0x3fefffc4f81bd8ad, 0xbf912f6dc7f6fdb2, 0x3fe9cb4d60d2e6ba, 0xbf9137c2a2fc70b3, 0x3fd2b5653d117249, 0xbf9140177db72bf8, 0xbfd5983511b66841, + 0xbf91486c58270b5a, 0xbfeaaa2180d2346f, 0xbf9150c1324beab1, 0xbfeff39aa70c53ab, 0xbf9159160c25a5d5, 0xbfe88f79ddeac6ed, 0xbf91616ae5b4189f, 0xbfcdb21c936f1690, + 0xbf9169bfbef71ee6, 0x3fd95111a49c4da9, 0xbf91721497ee9484, 0x3febb7c75ba72690, 0xbf917a69709a5551, 0x3fefc77995036722, 0xbf9182be48fa3d26, 0x3fe73b147541ce9b, + 0xbf918b13210e27d9, 0x3fc5dbb9a33d933e, 0xbf919367f8d5f145, 0xbfdcf09aa7344c19, 0xbf919bbcd0517541, 0xbfeca9b2b393bcf5, 0xbf91a411a7808fa6, 0xbfef7b8de7673fef, + 0xbf91ac667e631c4c, 0xbfe5cf71adf94f4d, 0xbf91b4bb54f8f70c, 0xbfbbdef1a29af8f1, 0xbf91bd102b41fbbe, 0x3fe039981a4c762a, 0xbf91c565013e063a, 0x3fed7ef185852388, + 0xbf91cdb9d6ecf259, 0x3fef1023916adf29, 0xbf91d60eac4e9bf4, 0x3fe44dfd4e83ee68, 0xbf91de638162dee2, 0x3fa7d51c9d7a1c2c, 0xbf91e6b8562996fd, 0xbfe1eaa7af8c17d0, + 0xbf91ef0d2aa2a01c, 0xbfee36ae7d895f94, 0xbf91f761fecdd619, 0xbfee85a607ed97b1, 0xbf91ffb6d2ab14cb, 0xbfe2b838f1707fc3, 0xbf92080ba63a380b, 0x3f905703049a0be3, + 0xbf921060797b1bb2, 0x3fe389cad8dd19a2, 0xbf9218b54c6d9b98, 0x3feed031cca2863a, 0xbf92210a1f119395, 0x3feddc9fd6311aa8, 0xbf92295ef166df83, 0x3fe10fba82e96b93, + 0xbf9231b3c36d5b38, 0xbfb411f9a832e328, 0xbf923a089524e28f, 0xbfe515624a5d88f4, 0xbf92425d668d5160, 0xbfef4ae1e04c4f4d, 0xbf924ab237a68383, 0xbfed15ba1308e6c8, + 0xbf925307087054d0, 0xbfdeac5556d54dee, 0xbf925b5bd8eaa120, 0x3fc1fd0f4d8d4e5f, 0xbf9263b0a915444c, 0x3fe68be2456b7245, 0xbf926c0578f01a2c, 0x3fefa643fc657eb3, + 0xbf92745a487afe98, 0x3fec31bbb7c45375, 0xbf927caf17b5cd6a, 0x3fdb1a864c71ba96, 0xbf928503e6a0627a, 0xbfc9df22f23d05b7, 0xbf928d58b53a99a0, 0xbfe7ebd4253a59ef, + 0xbf9295ad83844eb5, 0xbfefe1fcb5d298e0, 0xbf929e02517d5d91, 0xbfeb3188d954b488, 0xbf92a6571f25a20d, 0xbfd76d9a0f8b8ebb, 0xbf92aeabec7cf802, 0x3fd0d3aa734c1c0d, + 0xbf92b700b9833b48, 0x3fe933d7d54c9541, 0xbf92bf55863847b8, 0x3feffdd04def9d1e, 0xbf92c7aa529bf92b, 0x3fea1621c3b9f40e, 0xbf92cfff1eae2b78, 0x3fd3a93de996146a, + 0xbf92d853ea6eba78, 0xbfd4a6ee1a9ffb6e, 0xbf92e0a8b5dd8205, 0xbfea62a531736b89, 0xbf92e8fd80fa5df7, 0xbfeff9a2ee69abd2, 0xbf92f1524bc52a26, 0xbfe8e0a1fa1cf19b, + 0xbf92f9a7163dc26b, 0xbfcfa26d2a9f23ec, 0xbf9301fbe064029f, 0x3fd86588ca700c2c, 0xbf930a50aa37c69a, 0x3feb770d4e9ef592, 0xbf9312a573b8ea35, 0x3fefd578c50a3ae6, + 0xbf931afa3ce74948, 0x3fe7923f1aa3360a, 0xbf93234f05c2bfad, 0x3fc7d2b8f70fc528, 0xbf932ba3ce4b293c, 0xbfdc0bbb8a04b5dd, 0xbf9333f8968061cd, 0xbfec6ffba9502f1e, + 0xbf933c4d5e624539, 0xbfef9175ff86ce1c, 0xbf9344a225f0af59, 0xbfe62c47a94c796e, 0xbf934cf6ed2b7c06, 0xbfbfd65f61b17ae5, 0xbf93554bb4128718, 0x3fdf95dfca128a03, + 0xbf935da07aa5ac68, 0x3fed4c773ac16c70, 0xbf9365f540e4c7cf, 0x3fef2ddea761b4ed, 0xbf936e4a06cfb525, 0x3fe4b021c0a71282, 0xbf93769ecc665042, 0x3fafcee6a6d9a1ab, + 0xbf937ef391a87501, 0xbfe1803586bb8cf9, 0xbf9387485695ff39, 0xbfee0ba37189a822, 0xbf938f9d1b2ecac4, 0xbfeeab165db7f140, 0xbf9397f1df72b379, 0xbfe31f49ac4471a2, + 0xbf93a046a3619532, 0x3f3761c0853787fc, 0xbf93a89b66fb4bc7, 0x3fe323f9392602d5, 0xbf93b0f02a3fb311, 0x3feeacc10eb18267, 0xbf93b944ed2ea6ea, 0x3fee099ff7c7e5dd, + 0xbf93c199afc80328, 0x3fe17b506b8aaede, 0xbf93c9ee720ba3a7, 0xbfb0161f6f692a92, 0xbf93d24333f9643d, 0xbfe4b4970f696942, 0xbf93da97f59120c5, 0xbfef2f2ee4a5d4db, + 0xbf93e2ecb6d2b516, 0xbfed4a1cfbce0a95, 0xbf93eb4177bdfd09, 0xbfdf8bb442aa9e76, 0xbf93f3963852d478, 0x3fc00262b474f9f7, 0xbf93fbeaf891173c, 0x3fe6307e43ff9a06, + 0xbf94043fb878a12b, 0x3fef926a78c0361d, 0xbf940c9478094e21, 0x3fec6d4cffbf3437, 0xbf9414e93742f9f5, 0x3fdc0138dde91424, 0xbf941d3df6258081, 0xbfc7e9b1bafcfd7d, +] )) ), + +################ chunk 20992 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x413dac45d538b000, 0x413e05e0eef222bb, 0x413db88b6ceec000, 0x413e124b95964cf8, 0x413dc4d104a4d000, 0x413e1eb63c3a7736, 0x413dd1169c5ae000, 0x413e2b20e2dea173, + 0x413ddd5c3410f000, 0x413e378b8982cbb1, 0x413de9a1cbc70000, 0x413e43f63026f5ee, 0x413df5e7637d1000, 0x413e5060d6cb202c, 0x413e022cfb332000, 0x413e5ccb7d6f4a69, + 0x413e0e7292e93000, 0x413e6936241374a7, 0x413e1ab82a9f4000, 0x413e75a0cab79ee4, 0x413e26fdc2555000, 0x413e820b715bc922, 0x413e33435a0b6000, 0x413e8e7617fff35f, + 0x413e3f88f1c17000, 0x413e9ae0bea41d9d, 0x413e4bce89778000, 0x413ea74b654847da, 0x413e5814212d9000, 0x413eb3b60bec7218, 0x413e6459b8e3a000, 0x413ec020b2909c55, + 0x413e709f5099b000, 0x413ecc8b5934c693, 0x413e7ce4e84fc000, 0x413ed8f5ffd8f0d0, 0x413e892a8005d000, 0x413ee560a67d1b0e, 0x413e957017bbe000, 0x413ef1cb4d21454b, + 0x413ea1b5af71f000, 0x413efe35f3c56f89, 0x413eadfb47280000, 0x413f0aa09a6999c6, 0x413eba40dede1000, 0x413f170b410dc404, 0x413ec68676942000, 0x413f2375e7b1ee41, + 0x413ed2cc0e4a3000, 0x413f2fe08e56187f, 0x413edf11a6004000, 0x413f3c4b34fa42bc, 0x413eeb573db65000, 0x413f48b5db9e6cfa, 0x413ef79cd56c6000, 0x413f552082429737, + 0x413f03e26d227000, 0x413f618b28e6c175, 0x413f102804d88000, 0x413f6df5cf8aebb2, 0x413f1c6d9c8e9000, 0x413f7a60762f15f0, 0x413f28b33444a000, 0x413f86cb1cd3402d, + 0x413f34f8cbfab000, 0x413f9335c3776a6b, 0x413f413e63b0c000, 0x413f9fa06a1b94a8, 0x413f4d83fb66d000, 0x413fac0b10bfbee6, 0x413f59c9931ce000, 0x413fb875b763e923, + 0x413f660f2ad2f000, 0x413fc4e05e081361, 0x413f7254c2890000, 0x413fd14b04ac3d9e, 0x413f7e9a5a3f1000, 0x413fddb5ab5067dc, 0x413f8adff1f52000, 0x413fea2051f49219, + 0x413f972589ab3000, 0x413ff68af898bc57, 0x413fa36b21614000, 0x4140017acf9e734a, 0x413fafb0b9175000, 0x414007b022f08869, 0x413fbbf650cd6000, 0x41400de576429d88, + 0x413fc83be8837000, 0x4140141ac994b2a7, 0x413fd48180398000, 0x41401a501ce6c7c5, 0x413fe0c717ef9000, 0x414020857038dce4, 0x413fed0cafa5a000, 0x414026bac38af203, + 0x413ff952475bb000, 0x41402cf016dd0722, 0x414002cbef88e000, 0x414033256a2f1c40, 0x414008eebb63e800, 0x4140395abd81315f, 0x41400f11873ef000, 0x41403f9010d3467e, + 0x414015345319f800, 0x414045c564255b9d, 0x41401b571ef50000, 0x41404bfab77770bb, 0x41402179ead00800, 0x414052300ac985da, 0x4140279cb6ab1000, 0x414058655e1b9af9, + 0x41402dbf82861800, 0x41405e9ab16db018, 0x414033e24e612000, 0x414064d004bfc536, 0x41403a051a3c2800, 0x41406b055811da55, 0x41404027e6173000, 0x4140713aab63ef74, + 0x4140464ab1f23800, 0x4140776ffeb60493, 0x41404c6d7dcd4000, 0x41407da5520819b1, 0x4140529049a84800, 0x414083daa55a2ed0, 0x414058b315835000, 0x41408a0ff8ac43ef, + 0x41405ed5e15e5800, 0x414090454bfe590e, 0x414064f8ad396000, 0x4140967a9f506e2c, 0x41406b1b79146800, 0x41409caff2a2834b, 0x4140713e44ef7000, 0x4140a2e545f4986a, + 0x4140776110ca7800, 0x4140a91a9946ad89, 0x41407d83dca58000, 0x4140af4fec98c2a7, 0x414083a6a8808800, 0x4140b5853fead7c6, 0x414089c9745b9000, 0x4140bbba933cece5, + 0x41408fec40369800, 0x4140c1efe68f0204, 0x4140960f0c11a000, 0x4140c82539e11722, 0x41409c31d7eca800, 0x4140ce5a8d332c41, 0x4140a254a3c7b000, 0x4140d48fe0854160, + 0x4140a8776fa2b800, 0x4140dac533d7567f, 0x4140ae9a3b7dc000, 0x4140e0fa87296b9d, 0x4140b4bd0758c800, 0x4140e72fda7b80bc, 0x4140badfd333d000, 0x4140ed652dcd95db, + 0x4140c1029f0ed800, 0x4140f39a811faafa, 0x4140c7256ae9e000, 0x4140f9cfd471c018, 0x4140cd4836c4e800, 0x4141000527c3d537, 0x4140d36b029ff000, 0x4141063a7b15ea56, + 0x4140d98dce7af800, 0x41410c6fce67ff75, 0x4140dfb09a560000, 0x414112a521ba1493, 0x4140e5d366310800, 0x414118da750c29b2, 0x4140ebf6320c1000, 0x41411f0fc85e3ed1, + 0x4140f218fde71800, 0x414125451bb053f0, 0x4140f83bc9c22000, 0x41412b7a6f02690e, 0x4140fe5e959d2800, 0x414131afc2547e2d, 0x4141048161783000, 0x414137e515a6934c, + 0x41410aa42d533800, 0x41413e1a68f8a86b, 0x414110c6f92e4000, 0x4141444fbc4abd89, 0x414116e9c5094800, 0x41414a850f9cd2a8, 0x41411d0c90e45000, 0x414150ba62eee7c7, + 0x4141232f5cbf5800, 0x414156efb640fce6, 0x41412952289a6000, 0x41415d2509931205, 0x41412f74f4756800, 0x4141635a5ce52723, 0x41413597c0507000, 0x4141698fb0373c42, + 0x41413bba8c2b7800, 0x41416fc503895161, 0x414141dd58068000, 0x414175fa56db6680, 0x4141480023e18800, 0x41417c2faa2d7b9e, 0x41414e22efbc9000, 0x41418264fd7f90bd, + 0x41415445bb979800, 0x4141889a50d1a5dc, 0x41415a688772a000, 0x41418ecfa423bafb, 0x4141608b534da800, 0x41419504f775d019, 0x414166ae1f28b000, 0x41419b3a4ac7e538, + 0x41416cd0eb03b800, 0x4141a16f9e19fa57, 0x414172f3b6dec000, 0x4141a7a4f16c0f76, 0x4141791682b9c800, 0x4141adda44be2494, 0x41417f394e94d000, 0x4141b40f981039b3, + 0x4141855c1a6fd800, 0x4141ba44eb624ed2, 0x41418b7ee64ae000, 0x4141c07a3eb463f1, 0x414191a1b225e800, 0x4141c6af9206790f, 0x414197c47e00f000, 0x4141cce4e5588e2e, + 0x41419de749dbf800, 0x4141d31a38aaa34d, 0x4141a40a15b70000, 0x4141d94f8bfcb86c, 0x4141aa2ce1920800, 0x4141df84df4ecd8a, 0x4141b04fad6d1000, 0x4141e5ba32a0e2a9, + 0x4141b67279481800, 0x4141ebef85f2f7c8, 0x4141bc9545232000, 0x4141f224d9450ce7, 0x4141c2b810fe2800, 0x4141f85a2c972205, 0x4141c8dadcd93000, 0x4141fe8f7fe93724, + 0x4141cefda8b43800, 0x414204c4d33b4c43, 0x4141d520748f4000, 0x41420afa268d6162, 0x4141db43406a4800, 0x4142112f79df7680, 0x4141e1660c455000, 0x41421764cd318b9f, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbf942592b4b0bd9d, 0xbfe79632ca5a83cb, 0xbf942de772e48d21, 0xbfefd61085a79249, 0xbf94363c30c0cae8, 0xbfeb740ce950c4cb, 0xbf943e90ee4552c9, 0xbfd85ab97d56087c, + 0xbf9446e5ab72009e, 0x3fcfb914b3d5b87c, 0xbf944f3a6846b03f, 0x3fe8e44ecac4f60b, 0xbf94578f24c33d85, 0x3feff9dd5e9b6570, 0xbf945fe3e0e7844a, 0x3fea5f5611190d45, + 0xbf9468389cb36065, 0x3fd49bdcfce57fb9, 0xbf94708d5826adb1, 0xbfd3b45dbbf39437, 0xbf9478e213414805, 0xbfea198408254d55, 0xbf948136ce030b3b, 0xbfeffdad333fbeaa, + 0xbf94898b886bd32b, 0xbfe9303d4959eab7, 0xbf9491e0427b7baf, 0xbfd0c8629726276f, 0xbf949a34fc31e09f, 0x3fd7787acec02ea6, 0xbf94a289b58eddd4, 0x3feb349d2ee98d77, + 0xbf94aade6e924f27, 0x3fefe17c335f4df1, 0xbf94b333273c1072, 0x3fe7e7f1c896428b, 0xbf94bb87df8bfd8c, 0x3fc9c83c4f0bd87f, 0xbf94c3dc9781f250, 0xbfdb251d16abbdf9, + 0xbf94cc314f1dca95, 0xbfec347f09df65c9, 0xbf94d486065f6236, 0xbfefa56692bddfd5, 0xbf94dcdabd46950a, 0xbfe687bbfad49c27, 0xbf94e52f73d33eeb, 0xbfc1e5e8a85bf6e3, + 0xbf94ed842a053bb1, 0x3fdeb697943f4659, 0xbf94f5d8dfdc6737, 0x3fed18299e125861, 0xbf94fe2d95589d54, 0x3fef49a86cefdd72, 0xbf9506824a79b9e1, 0x3fe510fc386f2c36, + 0xbf950ed6ff3f98b9, 0x3fb3e35aabaac1fb, 0xbf95172bb3aa15b3, 0xbfe114ac39b14b2e, 0xbf951f8067b90ca9, 0xbfeddeb92a606fae, 0xbf9527d51b6c5973, 0xbfeece9d891adc18, + 0xbf953029cec3d7eb, 0xbfe38529664836f4, 0xbf95387e81bf63ea, 0xbf8f37f5a8701980, 0xbf9540d3345ed948, 0x3fe2bcf64de1ae97, 0xbf954927e6a213e0, 0x3fee87670bc34033, + 0xbf95517c9888ef89, 0x3fee34c0fe532050, 0xbf9559d14a13481d, 0x3fe1e5cf7e058644, 0xbf956225fb40f975, 0xbfa83289437dd0e4, 0xbf956a7aac11df6a, 0xbfe4528192fe29ae, + 0xbf9572cf5c85d5d4, 0xbfef118a83a397ab, 0xbf957b240c9cb88e, 0xbfed7cacb83b1aab, 0xbf958378bc566371, 0xbfe0348e02b4edb9, 0xbf958bcd6bb2b254, 0x3fbc0d6d829852e0, + 0xbf9594221ab18112, 0x3fe5d3b8557d5fe9, 0xbf959c76c952ab83, 0x3fef7c9960fcbfac, 0xbf95a4cb77960d81, 0x3feca718dd554034, 0xbf95ad20257b82e4, 0x3fdce62cc0dbce13, + 0xbf95b574d302e786, 0xbfc5f2c319015bbf, 0xbf95bdc9802c1741, 0xbfe73f193919b70d, 0xbf95c61e2cf6edec, 0xbfefc8288a564fd9, 0xbf95ce72d9634761, 0xbfebb4db167fae76, + 0xbf95d6c78570ff79, 0xbfd946547642b371, 0xbf95df1c311ff20e, 0x3fcdc8da84b51287, 0xbf95e770dc6ffaf9, 0x3fe89338b8a9f554, 0xbf95efc58760f612, 0x3feff3ec691bce60, + 0xbf95f81a31f2bf33, 0x3feaa6e5b9625cb1, 0xbf96006edc253236, 0x3fd58d3358e77174, 0xbf9608c385f82af2, 0xbfd2c09312a2a38d, 0xbf9611182f6b8542, 0xbfe9cec293561873, + 0xbf96196cd87f1cff, 0xbfefffb9351e0425, 0xbf9621c18132ce01, 0xbfe97e46d5d05137, 0xbf962a1629867422, 0xbfd1be82e8ca6772, 0xbf96326ad179eb3c, 0x3fd689f6769e336f, + 0xbf963abf790d0f27, 0x3feaf07b20289dcb, 0xbf964314203fbbbd, 0x3fefeb832062a0f7, 0xbf964b68c711ccd6, 0x3fe83c272834a7b4, 0xbf9653bd6d831e4d, 0x3fcbbc246bf626ab, + 0xbf965c1213938bfa, 0xbfda3ccdab5a0a08, 0xbf966466b942f1b7, 0xbfebf7408a247e3b, 0xbf966cbb5e912b5c, 0xbfefb75e6301787a, 0xbf967510037e14c4, 0xbfe6e1c8efda9552, + 0xbf967d64a80989c7, 0xbfc3df84260266ea, 0xbf9685b94c33663e, 0x3fddd5657cbc7765, 0xbf968e0deffb8604, 0x3fece20bf1b6e094, 0xbf9696629361c4f1, 0x3fef637f26db4624, + 0xbf969eb73665fede, 0x3fe57086ad1f4c16, 0xbf96a70bd9080fa5, 0x3fb7de04cacd59fc, 0xbf96af607b47d320, 0xbfe0a8127ba724d3, 0xbf96b7b51d252526, 0xbfedaff2747587ea, + 0xbf96c009be9fe193, 0xbfeef0395370c201, 0xbf96c85e5fb7e43e, 0xbfe3e9d1c679f05f, 0xbf96d0b3006d0902, 0xbf9f9483b1d8ea10, 0xbf96d907a0bf2bb8, 0x3fe254c8821d8343, + 0xbf96e15c40ae2839, 0x3fee60261791aa6f, 0xbf96e9b0e039da5e, 0x3fee5e0039de2543, 0xbf96f2057f621e01, 0x3fe24f3117b6862b, 0xbf96fa5a1e26cefb, 0xbfa03751b413f151, + 0xbf9702aebc87c925, 0xbfe3ef27f1780cd8, 0xbf970b035a84e85a, 0xbfeef1f69619e4bd, 0xbf971357f81e0872, 0xbfedad6621cb9547, 0xbf971bac95530546, 0xbfe0a23f69cec8e4, + 0xbf9724013223bab0, 0x3fb814562b1363b1, 0xbf972c55ce90048a, 0x3fe575964202d478, 0xbf9734aa6a97bead, 0x3fef64d2110b85c8, 0xbf973cff063ac4f2, 0x3fecdf1bb6a97840, + 0xbf974553a178f333, 0x3fddc953b172aaf8, 0xbf974da83c522549, 0xbfc3fa7663242936, 0xbf9755fcd6c6370e, 0xbfe6e68cde8ef7a6, 0xbf975e5170d5045a, 0xbfefb845a1ad3c07, + 0xbf9766a60a7e6909, 0xbfebf3ef5738d4b2, 0xbf976efaa3c240f2, 0xbfda305c4be7c7c9, 0xbf97774f3ca067ef, 0x3fcbd6c5432a4476, 0xbf977fa3d518b9da, 0x3fe8409aac52edbc, + 0xbf9787f86d2b128d, 0x3fefebfdcc347107, 0xbf97904d04d74de0, 0x3feaeccc4707df57, 0xbf9798a19c1d47ae, 0x3fd67d31f4b3da63, 0xbf97a0f632fcdbd0, 0xbfd1cb9d4f339dba, + 0xbf97a94ac975e61f, 0xbfe982657b64082e, 0xbf97b19f5f884274, 0xbfefffc6d35d7098, 0xbf97b9f3f533ccaa, 0xbfe9cab9c2f159d7, 0xbf97c2488a78609a, 0xbfd2b38834791c1f, + 0xbf97ca9d1f55da1e, 0x3fd59a0a9e6ebb3c, 0xbf97d2f1b3cc150e, 0x3feaaaab613a8e29, 0xbf97db4647daed45, 0x3feff38cec2a3f39, 0xbf97e39adb823e9b, 0x3fe88ed9fa5a0113, + 0xbf97ebef6ec1e4ec, 0x3fcdae5228323f5b, 0xbf97f4440199bc0f, 0xbfd952dbc1e8e44c, 0xbf97fc9894099fe0, 0xbfebb843fadbf9e5, 0xbf9804ed26116c36, 0xbfefc75c51b9a761, + 0xbf980d41b7b0fced, 0xbfe73a68ec0b2564, 0xbf98159648e82ddd, 0xbfc5d7e2a8450e82, 0xbf981dead9b6dae0, 0x3fdcf2578b03c47b, 0xbf98263f6a1cdfcf, 0x3fecaa2194d7dcaa, + 0xbf982e93fa1a1886, 0x3fef7b613901bc35, 0xbf9836e889ae60dc, 0x3fe5cebb2aa25ee3, 0xbf983f3d18d994ab, 0x3fbbd7323aebd5bc, 0xbf984791a79b8fce, 0xbfe03a6f10d06ae4, +] )) ), + +################ chunk 21504 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4141e788d8205800, 0x41421d9a2083a0be, 0x4141edaba3fb6000, 0x414223cf73d5b5dd, 0x4141f3ce6fd66800, 0x41422a04c727cafb, 0x4141f9f13bb17000, 0x4142303a1a79e01a, + 0x41420014078c7800, 0x4142366f6dcbf539, 0x41420636d3678000, 0x41423ca4c11e0a58, 0x41420c599f428800, 0x414242da14701f76, 0x4142127c6b1d9000, 0x4142490f67c23495, + 0x4142189f36f89800, 0x41424f44bb1449b4, 0x41421ec202d3a000, 0x4142557a0e665ed3, 0x414224e4ceaea800, 0x41425baf61b873f1, 0x41422b079a89b000, 0x414261e4b50a8910, + 0x4142312a6664b800, 0x4142681a085c9e2f, 0x4142374d323fc000, 0x41426e4f5baeb34e, 0x41423d6ffe1ac800, 0x41427484af00c86c, 0x41424392c9f5d000, 0x41427aba0252dd8b, + 0x414249b595d0d800, 0x414280ef55a4f2aa, 0x41424fd861abe000, 0x41428724a8f707c9, 0x414255fb2d86e800, 0x41428d59fc491ce8, 0x41425c1df961f000, 0x4142938f4f9b3206, + 0x41426240c53cf800, 0x414299c4a2ed4725, 0x4142686391180000, 0x41429ff9f63f5c44, 0x41426e865cf30800, 0x4142a62f49917163, 0x414274a928ce1000, 0x4142ac649ce38681, + 0x41427acbf4a91800, 0x4142b299f0359ba0, 0x414280eec0842000, 0x4142b8cf4387b0bf, 0x414287118c5f2800, 0x4142bf0496d9c5de, 0x41428d34583a3000, 0x4142c539ea2bdafc, + 0x4142935724153800, 0x4142cb6f3d7df01b, 0x41429979eff04000, 0x4142d1a490d0053a, 0x41429f9cbbcb4800, 0x4142d7d9e4221a59, 0x4142a5bf87a65000, 0x4142de0f37742f77, + 0x4142abe253815800, 0x4142e4448ac64496, 0x4142b2051f5c6000, 0x4142ea79de1859b5, 0x4142b827eb376800, 0x4142f0af316a6ed4, 0x4142be4ab7127000, 0x4142f6e484bc83f2, + 0x4142c46d82ed7800, 0x4142fd19d80e9911, 0x4142ca904ec88000, 0x4143034f2b60ae30, 0x4142d0b31aa38800, 0x414309847eb2c34f, 0x4142d6d5e67e9000, 0x41430fb9d204d86d, + 0x4142dcf8b2599800, 0x414315ef2556ed8c, 0x4142e31b7e34a000, 0x41431c2478a902ab, 0x4142e93e4a0fa800, 0x41432259cbfb17ca, 0x4142ef6115eab000, 0x4143288f1f4d2ce8, + 0x4142f583e1c5b800, 0x41432ec4729f4207, 0x4142fba6ada0c000, 0x414334f9c5f15726, 0x414301c9797bc800, 0x41433b2f19436c45, 0x414307ec4556d000, 0x414341646c958163, + 0x41430e0f1131d800, 0x41434799bfe79682, 0x41431431dd0ce000, 0x41434dcf1339aba1, 0x41431a54a8e7e800, 0x41435404668bc0c0, 0x4143207774c2f000, 0x41435a39b9ddd5de, + 0x4143269a409df800, 0x4143606f0d2feafd, 0x41432cbd0c790000, 0x414366a46082001c, 0x414332dfd8540800, 0x41436cd9b3d4153b, 0x41433902a42f1000, 0x4143730f07262a59, + 0x41433f25700a1800, 0x414379445a783f78, 0x414345483be52000, 0x41437f79adca5497, 0x41434b6b07c02800, 0x414385af011c69b6, 0x4143518dd39b3000, 0x41438be4546e7ed4, + 0x414357b09f763800, 0x41439219a7c093f3, 0x41435dd36b514000, 0x4143984efb12a912, 0x414363f6372c4800, 0x41439e844e64be31, 0x41436a1903075000, 0x4143a4b9a1b6d34f, + 0x4143703bcee25800, 0x4143aaeef508e86e, 0x4143765e9abd6000, 0x4143b124485afd8d, 0x41437c8166986800, 0x4143b7599bad12ac, 0x414382a432737000, 0x4143bd8eeeff27ca, + 0x414388c6fe4e7800, 0x4143c3c442513ce9, 0x41438ee9ca298000, 0x4143c9f995a35208, 0x4143950c96048800, 0x4143d02ee8f56727, 0x41439b2f61df9000, 0x4143d6643c477c46, + 0x4143a1522dba9800, 0x4143dc998f999164, 0x4143a774f995a000, 0x4143e2cee2eba683, 0x4143ad97c570a800, 0x4143e904363dbba2, 0x4143b3ba914bb000, 0x4143ef39898fd0c1, + 0x4143b9dd5d26b800, 0x4143f56edce1e5df, 0x4143c0002901c000, 0x4143fba43033fafe, 0x4143c622f4dcc800, 0x414401d98386101d, 0x4143cc45c0b7d000, 0x4144080ed6d8253c, + 0x4143d2688c92d800, 0x41440e442a2a3a5a, 0x4143d88b586de000, 0x414414797d7c4f79, 0x4143deae2448e800, 0x41441aaed0ce6498, 0x4143e4d0f023f000, 0x414420e4242079b7, + 0x4143eaf3bbfef800, 0x4144271977728ed5, 0x4143f11687da0000, 0x41442d4ecac4a3f4, 0x4143f73953b50800, 0x414433841e16b913, 0x4143fd5c1f901000, 0x414439b97168ce32, + 0x4144037eeb6b1800, 0x41443feec4bae350, 0x414409a1b7462000, 0x41444624180cf86f, 0x41440fc483212800, 0x41444c596b5f0d8e, 0x414415e74efc3000, 0x4144528ebeb122ad, + 0x41441c0a1ad73800, 0x414458c4120337cb, 0x4144222ce6b24000, 0x41445ef965554cea, 0x4144284fb28d4800, 0x4144652eb8a76209, 0x41442e727e685000, 0x41446b640bf97728, + 0x414434954a435800, 0x414471995f4b8c46, 0x41443ab8161e6000, 0x414477ceb29da165, 0x414440dae1f96800, 0x41447e0405efb684, 0x414446fdadd47000, 0x414484395941cba3, + 0x41444d2079af7800, 0x41448a6eac93e0c1, 0x41445343458a8000, 0x414490a3ffe5f5e0, 0x4144596611658800, 0x414496d953380aff, 0x41445f88dd409000, 0x41449d0ea68a201e, + 0x414465aba91b9800, 0x4144a343f9dc353c, 0x41446bce74f6a000, 0x4144a9794d2e4a5b, 0x414471f140d1a800, 0x4144afaea0805f7a, 0x414478140cacb000, 0x4144b5e3f3d27499, + 0x41447e36d887b800, 0x4144bc19472489b7, 0x41448459a462c000, 0x4144c24e9a769ed6, 0x41448a7c703dc800, 0x4144c883edc8b3f5, 0x4144909f3c18d000, 0x4144ceb9411ac914, + 0x414496c207f3d800, 0x4144d4ee946cde32, 0x41449ce4d3cee000, 0x4144db23e7bef351, 0x4144a3079fa9e800, 0x4144e1593b110870, 0x4144a92a6b84f000, 0x4144e78e8e631d8f, + 0x4144af4d375ff800, 0x4144edc3e1b532ad, 0x4144b570033b0000, 0x4144f3f9350747cc, 0x4144bb92cf160800, 0x4144fa2e88595ceb, 0x4144c1b59af11000, 0x41450063dbab720a, + 0x4144c7d866cc1800, 0x414506992efd8729, 0x4144cdfb32a72000, 0x41450cce824f9c47, 0x4144d41dfe822800, 0x41451303d5a1b166, 0x4144da40ca5d3000, 0x4145193928f3c685, + 0x4144e06396383800, 0x41451f6e7c45dba4, 0x4144e68662134000, 0x414525a3cf97f0c2, 0x4144eca92dee4800, 0x41452bd922ea05e1, 0x4144f2cbf9c95000, 0x4145320e763c1b00, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbf984fe635f42e1d, 0xbfed7f5239dff48c, 0xbf98583ac3e34b73, 0xbfef0fe7a498a3dc, 0xbf98608f5168c3aa, 0xbfe44d3c87894eb2, 0xbf9868e3de84729a, 0xbfa7c58a6cee89dd, + 0xbf9871386b36341d, 0x3fe1eb7653860cc8, 0xbf98798cf77de40e, 0x3fee3700a44b3913, 0xbf9881e1835b5e45, 0x3fee855b1897c098, 0xbf988a360ece7e9d, 0x3fe2b76ea7c39812, + 0xbf98928a99d720ef, 0xbf90762efc98ede2, 0xbf989adf24752115, 0xbfe38a905bb04b15, 0xbf98a333aea85ae9, 0xbfeed07513a52d97, 0xbf98ab883870aa44, 0xbfeddc462f56125c, + 0xbf98b3dcc1cdeb00, 0xbfe10ee78102ec30, 0xbf98bc314abff8f7, 0x3fb419bec1299b33, 0xbf98c485d346b003, 0x3fe5161de68bbca2, 0xbf98ccda5b61ebfd, 0x3fef4b160437971d, + 0xbf98d52ee31188be, 0x3fed15520e585ebe, 0xbf98dd836a556222, 0x3fdeaa9f888e9e7c, 0xbf98e5d7f12d5401, 0xbfc200eb0495a4a9, 0xbf98ee2c77993a36, 0xbfe68c933f2ca4f0, + 0xbf98f680fd98f09a, 0xbfefa668c91057e3, 0xbf98fed5832c5306, 0xbfec3145bd5c5fe0, 0xbf99072a08533d56, 0xbfdb18c269aac97f, 0xbf990f7e8d0d8b62, 0x3fc9e2f3f8374a59, + 0xbf9917d3115b1904, 0x3fe7ec79cb83584a, 0xbf992027953bc216, 0x3fefe2120669fb55, 0xbf99287c18af6273, 0x3feb31055f2e0679, 0xbf9930d09bb5d5f3, 0x3fd76bc9dc181e66, + 0xbf9939251e4ef871, 0xbfd0d58bb4cfb39e, 0xbf994179a07aa5c6, 0xbfe93471825309fe, 0xbf9949ce2238b9cd, 0xbfeffdd60d2590c4, 0xbf995222a389105f, 0xbfea15914d491de9, + 0xbf995a77246b8556, 0xbfd3a7633611569d, 0xbf9962cba4dff48c, 0x3fd4a8c638fc8047, 0xbf996b2024e639db, 0x3fea63324b906b5d, 0xbf997374a47e311d, 0x3feff999167d24e6, + 0xbf997bc923a7b62b, 0x3fe8e00517f78194, 0xbf99841da262a4e0, 0x3fcf9ea679b3b536, 0xbf998c7220aed915, 0xbfd86755ed96571c, 0xbf9994c69e8c2ea5, 0xbfeb778d48bae4f4, + 0xbf999d1b1bfa8169, 0xbfefd55f5fd3630b, 0xbf99a56f98f9ad3b, 0xbfe7919669d06d18, 0xbf99adc415898df6, 0xbfc7cee4c2d8ca73, 0xbf99b61891a9ff72, 0x3fdc0d7be4ddb0d8, + 0xbf99be6d0d5add8b, 0x3fec706e03523b19, 0xbf99c6c1889c0419, 0x3fef914d26729a3f, 0xbf99cf16036d4ef8, 0x3fe62b93d279aac5, 0xbf99d76a7dce9a01, 0x3fbfcea39ad81696, + 0xbf99dfbef7bfc10e, 0xbfdf97919bdc0015, 0xbf99e81371409ff8, 0xbfed4cdb82376f01, 0xbf99f067ea51129b, 0xbfef2da68349fe6d, 0xbf99f8bc62f0f4d0, 0xbfe4af6377a46043, + 0xbf9a0110db202271, 0xbfafbf57d75b13cd, 0xbf9a096552de7758, 0x3fe1810651ff74a0, 0xbf9a11b9ca2bcf5e, 0x3fee0bf94230f515, 0xbf9a1a0e4108065f, 0x3feeaacf26bd3412, + 0xbf9a2262b772f835, 0x3fe31e81af84b47f, 0xbf9a2ab72d6c80b8, 0xbf3f2cfffe5349b9, 0xbf9a330ba2f47bc4, 0xbfe324c1160512fd, 0xbf9a3b60180ac532, 0xbfeead0812ba1803, + 0xbf9a43b48caf38dc, 0xbfee0949f52f5755, 0xbf9a4c0900e1b29d, 0xbfe17a7f83392aeb, 0xbf9a545d74a20e4f, 0x3fb01de6bb9773f4, 0xbf9a5cb1e7f027cb, 0x3fe4b555360b73ec, + 0xbf9a65065acbdaec, 0x3fef2f66d4f9a919, 0xbf9a6d5acd35038c, 0x3fed49b883afa15a, 0xbf9a75af3f2b7d85, 0x3fdf8a023caa8adb, 0xbf9a7e03b0af24b1, 0xbfc006407ddc74d4, + 0xbf9a865821bfd4ea, 0xbfe63131f6119abc, 0xbf9a8eac925d6a0b, 0xbfef92931d69717f, 0xbf9a97010287bfee, 0xbfec6cda7691ed7b, 0xbf9a9f55723eb26c, 0xbfdbff7854bcbdcb, + 0xbf9aa7a9e1821d60, 0x3fc7ed85c80c97fc, 0xbf9aaffe5051dca5, 0x3fe796db5418b1cc, 0xbf9ab852beadcc13, 0x3fefd629b5fa4e16, 0xbf9ac0a72c95c786, 0x3feb738cc1a91839, + 0xbf9ac8fb9a09aad8, 0x3fd858ec3177a202, 0xbf9ad150070951e3, 0xbfcfbcdb309ec569, 0xbf9ad9a473949880, 0xbfe8e4eb8380d9ed, 0xbf9ae1f8dfab5a8c, 0xbfeff9e7016a0ab7, + 0xbf9aea4d4b4d73de, 0xbfea5ec8cb192326, 0xbf9af2a1b67ac053, 0xbfd49a04bc07ee90, 0xbf9afaf621331bc3, 0x3fd3b6384e89e83e, 0xbf9b034a8b76620a, 0x3fea1a14532c5860, + 0xbf9b0b9ef5446f01, 0x3feffda73ee5c68e, 0xbf9b13f35e9d1e83, 0x3fe92fa3726622bb, 0xbf9b1c47c7804c6a, 0x3fd0c68139f69974, 0xbf9b249c2fedd491, 0xbfd77a4adb04f296, + 0xbf9b2cf097e592d1, 0xbfeb35207bf356c0, 0xbf9b3544ff676305, 0xbfefe166add06da5, 0xbf9b3d9966732107, 0xbfe7e74bfaaa0062, 0xbf9b45edcd08a8b2, 0xbfc9c46b1ea8da85, + 0xbf9b4e423327d5e0, 0x3fdb26e0cc9ee21e, 0xbf9b569698d0846c, 0x3fec34f4d57f6fcb, 0xbf9b5eeafe02902e, 0x3fefa54191868450, 0xbf9b673f62bdd503, 0x3fe6870adbba67a1, + 0xbf9b6f93c7022ec4, 0x3fc1e20cd3070ec5, 0xbf9b77e82acf794b, 0xbfdeb84d2fc2c741, 0xbf9b803c8e259074, 0xbfed189172641397, 0xbf9b8890f1045018, 0xbfef49741512217c, + 0xbf9b90e5536b9411, 0xbfe51040793f7da2, 0xbf9b9939b55b383b, 0xbfb3db9570854c91, 0xbf9ba18e16d31870, 0x3fe1157f1f3cd737, 0xbf9ba9e277d31089, 0x3feddf129f946bb1, + 0xbf9bb236d85afc62, 0x3feece5a0eeb1c95, 0xbf9bba8b386ab7d4, 0x3fe38463c2eb7ab2, 0xbf9bc2df98021ebb, 0x3f8ef99d8360f0c1, 0xbf9bcb33f7210cf1, 0xbfe2bdc07858c396, + 0xbf9bd38855c75e4f, 0xbfee87b1c8650ce9, 0xbf9bdbdcb3f4eeb1, 0xbfee346ea558ec88, 0xbf9be43111a999f2, 0xbfe1e500bc4d1b78, 0xbf9bec856ee53beb, 0x3fa8421b4a26571e, + 0xbf9bf4d9cba7b076, 0x3fe45342383b1975, 0xbf9bfd2e27f0d370, 0x3fef11c63ce3bc43, 0xbf9c058283c080b1, 0x3fed7c4bd2e3f91d, 0xbf9c0dd6df169415, 0x3fe033b6f15d9322, + 0xbf9c162b39f2e976, 0xbfbc152cbcd4119f, 0xbf9c1e7f94555cae, 0xbfe5d46eb4c56702, 0xbf9c26d3ee3dc998, 0xbfef7cc5db166378, 0xbf9c2f2847ac0c0f, 0xbfeca6a9cc8584eb, + 0xbf9c377ca09fffee, 0xbfdce46fad3c4ecd, 0xbf9c3fd0f919810e, 0x3fc5f699f0946496, 0xbf9c482551186b4a, 0x3fe73fc49bb6dfdb, 0xbf9c5079a89c9a7d, 0x3fefc84598d2a0f5, + 0xbf9c58cdffa5ea81, 0x3febb45e49531c00, 0xbf9c612256343731, 0x3fd9448a2e7c4f59, 0xbf9c6976ac475c68, 0xbfcdcca4be8bd603, 0xbf9c71cb01df3601, 0xbfe893d873578aac, +] )) ), + +################ chunk 22016 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4144f8eec5a45800, 0x41453843c98e301f, 0x4144ff11917f6000, 0x41453e791ce0453d, 0x414505345d5a6800, 0x414544ae70325a5c, 0x41450b5729357000, 0x41454ae3c3846f7b, + 0x41451179f5107800, 0x4145511916d6849a, 0x4145179cc0eb8000, 0x4145574e6a2899b8, 0x41451dbf8cc68800, 0x41455d83bd7aaed7, 0x414523e258a19000, 0x414563b910ccc3f6, + 0x41452a05247c9800, 0x414569ee641ed915, 0x41453027f057a000, 0x41457023b770ee33, 0x4145364abc32a800, 0x414576590ac30352, 0x41453c6d880db000, 0x41457c8e5e151871, + 0x4145429053e8b800, 0x414582c3b1672d90, 0x414548b31fc3c000, 0x414588f904b942ae, 0x41454ed5eb9ec800, 0x41458f2e580b57cd, 0x414554f8b779d000, 0x41459563ab5d6cec, + 0x41455b1b8354d800, 0x41459b98feaf820b, 0x4145613e4f2fe000, 0x4145a1ce52019729, 0x414567611b0ae800, 0x4145a803a553ac48, 0x41456d83e6e5f000, 0x4145ae38f8a5c167, + 0x414573a6b2c0f800, 0x4145b46e4bf7d686, 0x414579c97e9c0000, 0x4145baa39f49eba4, 0x41457fec4a770800, 0x4145c0d8f29c00c3, 0x4145860f16521000, 0x4145c70e45ee15e2, + 0x41458c31e22d1800, 0x4145cd4399402b01, 0x41459254ae082000, 0x4145d378ec92401f, 0x4145987779e32800, 0x4145d9ae3fe4553e, 0x41459e9a45be3000, 0x4145dfe393366a5d, + 0x4145a4bd11993800, 0x4145e618e6887f7c, 0x4145aadfdd744000, 0x4145ec4e39da949a, 0x4145b102a94f4800, 0x4145f2838d2ca9b9, 0x4145b725752a5000, 0x4145f8b8e07ebed8, + 0x4145bd4841055800, 0x4145feee33d0d3f7, 0x4145c36b0ce06000, 0x414605238722e915, 0x4145c98dd8bb6800, 0x41460b58da74fe34, 0x4145cfb0a4967000, 0x4146118e2dc71353, + 0x4145d5d370717800, 0x414617c381192872, 0x4145dbf63c4c8000, 0x41461df8d46b3d90, 0x4145e21908278800, 0x4146242e27bd52af, 0x4145e83bd4029000, 0x41462a637b0f67ce, + 0x4145ee5e9fdd9800, 0x41463098ce617ced, 0x4145f4816bb8a000, 0x414636ce21b3920b, 0x4145faa43793a800, 0x41463d037505a72a, 0x414600c7036eb000, 0x41464338c857bc49, + 0x414606e9cf49b800, 0x4146496e1ba9d168, 0x41460d0c9b24c000, 0x41464fa36efbe687, 0x4146132f66ffc800, 0x414655d8c24dfba5, 0x4146195232dad000, 0x41465c0e15a010c4, + 0x41461f74feb5d800, 0x4146624368f225e3, 0x41462597ca90e000, 0x41466878bc443b02, 0x41462bba966be800, 0x41466eae0f965020, 0x414631dd6246f000, 0x414674e362e8653f, + 0x414638002e21f800, 0x41467b18b63a7a5e, 0x41463e22f9fd0000, 0x4146814e098c8f7d, 0x41464445c5d80800, 0x414687835cdea49b, 0x41464a6891b31000, 0x41468db8b030b9ba, + 0x4146508b5d8e1800, 0x414693ee0382ced9, 0x414656ae29692000, 0x41469a2356d4e3f8, 0x41465cd0f5442800, 0x4146a058aa26f916, 0x414662f3c11f3000, 0x4146a68dfd790e35, + 0x414669168cfa3800, 0x4146acc350cb2354, 0x41466f3958d54000, 0x4146b2f8a41d3873, 0x4146755c24b04800, 0x4146b92df76f4d91, 0x41467b7ef08b5000, 0x4146bf634ac162b0, + 0x414681a1bc665800, 0x4146c5989e1377cf, 0x414687c488416000, 0x4146cbcdf1658cee, 0x41468de7541c6800, 0x4146d20344b7a20c, 0x4146940a1ff77000, 0x4146d8389809b72b, + 0x41469a2cebd27800, 0x4146de6deb5bcc4a, 0x4146a04fb7ad8000, 0x4146e4a33eade169, 0x4146a67283888800, 0x4146ead891fff687, 0x4146ac954f639000, 0x4146f10de5520ba6, + 0x4146b2b81b3e9800, 0x4146f74338a420c5, 0x4146b8dae719a000, 0x4146fd788bf635e4, 0x4146befdb2f4a800, 0x414703addf484b02, 0x4146c5207ecfb000, 0x414709e3329a6021, + 0x4146cb434aaab800, 0x4147101885ec7540, 0x4146d1661685c000, 0x4147164dd93e8a5f, 0x4146d788e260c800, 0x41471c832c909f7d, 0x4146ddabae3bd000, 0x414722b87fe2b49c, + 0x4146e3ce7a16d800, 0x414728edd334c9bb, 0x4146e9f145f1e000, 0x41472f232686deda, 0x4146f01411cce800, 0x4147355879d8f3f8, 0x4146f636dda7f000, 0x41473b8dcd2b0917, + 0x4146fc59a982f800, 0x414741c3207d1e36, 0x4147027c755e0000, 0x414747f873cf3355, 0x4147089f41390800, 0x41474e2dc7214873, 0x41470ec20d141000, 0x414754631a735d92, + 0x414714e4d8ef1800, 0x41475a986dc572b1, 0x41471b07a4ca2000, 0x414760cdc11787d0, 0x4147212a70a52800, 0x4147670314699cee, 0x4147274d3c803000, 0x41476d3867bbb20d, + 0x41472d70085b3800, 0x4147736dbb0dc72c, 0x41473392d4364000, 0x414779a30e5fdc4b, 0x414739b5a0114800, 0x41477fd861b1f16a, 0x41473fd86bec5000, 0x4147860db5040688, + 0x414745fb37c75800, 0x41478c4308561ba7, 0x41474c1e03a26000, 0x414792785ba830c6, 0x41475240cf7d6800, 0x414798adaefa45e5, 0x414758639b587000, 0x41479ee3024c5b03, + 0x41475e8667337800, 0x4147a518559e7022, 0x414764a9330e8000, 0x4147ab4da8f08541, 0x41476acbfee98800, 0x4147b182fc429a60, 0x414770eecac49000, 0x4147b7b84f94af7e, + 0x41477711969f9800, 0x4147bdeda2e6c49d, 0x41477d34627aa000, 0x4147c422f638d9bc, 0x414783572e55a800, 0x4147ca58498aeedb, 0x41478979fa30b000, 0x4147d08d9cdd03f9, + 0x41478f9cc60bb800, 0x4147d6c2f02f1918, 0x414795bf91e6c000, 0x4147dcf843812e37, 0x41479be25dc1c800, 0x4147e32d96d34356, 0x4147a205299cd000, 0x4147e962ea255874, + 0x4147a827f577d800, 0x4147ef983d776d93, 0x4147ae4ac152e000, 0x4147f5cd90c982b2, 0x4147b46d8d2de800, 0x4147fc02e41b97d1, 0x4147ba905908f000, 0x41480238376dacef, + 0x4147c0b324e3f800, 0x4148086d8abfc20e, 0x4147c6d5f0bf0000, 0x41480ea2de11d72d, 0x4147ccf8bc9a0800, 0x414814d83163ec4c, 0x4147d31b88751000, 0x41481b0d84b6016a, + 0x4147d93e54501800, 0x41482142d8081689, 0x4147df61202b2000, 0x414827782b5a2ba8, 0x4147e583ec062800, 0x41482dad7eac40c7, 0x4147eba6b7e13000, 0x414833e2d1fe55e5, + 0x4147f1c983bc3800, 0x41483a1825506b04, 0x4147f7ec4f974000, 0x4148404d78a28023, 0x4137f7ec53a8d491, 0x4137f7ec53a8d492, 0x4137f7ec53a8d490, 0x40fe240c9fbe76c9, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbf9c7a1f56fb9fd4, 0xbfeff3f9eee97337, 0xbf9c8273ab9c75bf, 0xbfeaa65bac8eff80, 0xbf9c8ac7ffc1939a, 0xbfd58b5da859d917, 0xbf9c931c536ad541, 0x3fd2c26ffbe13fbe, + 0xbf9c9b70a698168f, 0x3fe9cf560649ade0, 0xbf9ca3c4f949335d, 0x3fefffb724b5513f, 0xbf9cac194b7e0787, 0x3fe97db013b74e9c, 0xbf9cb46d9d366ee8, 0x3fd1bca3a4dedcdb, + 0xbf9cbcc1ee724559, 0xbfd68bc94f17c847, 0xbf9cc5163f3166b6, 0xbfeaf101b8033f96, 0xbf9ccd6a8f73aed9, 0xbfefeb717bd541c8, 0xbf9cd5bedf38f99e, 0xbfe83b844783893b, + 0xbf9cde132e8122de, 0xbfcbb8567c49814f, 0xbf9ce6677d4c0675, 0x3fda3e94a07cd6f4, 0xbf9ceebbcb99803d, 0x3febf7b9bffc1c59, 0xbf9cf71019696c10, 0x3fefb73d3bf530fc, + 0xbf9cff6466bba5cb, 0x3fe6e11a93821a6f, 0xbf9d07b8b3900947, 0x3fc3dbaa9bd2f97e, 0xbf9d100cffe6725f, 0xbfddd71ec67d7702, 0xbf9d18614bbebcee, 0xbfece2774c6c3b10, + 0xbf9d20b59718c4cf, 0xbfef634e9e7a673f, 0xbf9d2909e1f465dc, 0xbfe56fcd835d7907, 0xbf9d315e2c517bf1, 0xbfb7d64239313a0c, 0xbf9d39b2762fe2e8, 0x3fe0a8e76e567d43, + 0xbf9d4206bf8f769c, 0x3fedb04f88a35440, 0xbf9d4a5b087012e7, 0x3feeeff99a381a48, 0xbf9d52af50d193a5, 0x3fe3e90e88e99fa6, 0xbf9d5b0398b3d4b1, 0x3f9f755a7be1edf2, + 0xbf9d6357e016b1e5, 0xbfe25594ed940717, 0xbf9d6bac26fa071b, 0xbfee6074882eadd9, 0xbf9d74006d5db030, 0xbfee5db18fadd95f, 0xbf9d7c54b34188fe, 0xbfe24e6489790415, + 0xbf9d84a8f8a56d5f, 0x3fa046e630ae82c8, 0xbf9d8cfd3d89392f, 0x3fe3efeb09682e50, 0xbf9d955181ecc848, 0x3feef2361485991c, 0xbf9d9da5c5cff686, 0x3fedad08d5453d82, + 0xbf9da5fa09329fc3, 0x3fe0a16a57867d0e, 0xbf9dae4e4c149fda, 0xbfb81c18912b0c1e, 0xbf9db6a28e75d2a7, 0xbfe5764f42dd7a04, 0xbf9dbef6d0561403, 0xbfef65025dd55ee1, + 0xbf9dc74b11b53fcb, 0xbfecdeb02522cd69, 0xbf9dcf9f529331d8, 0xbfddc79a2ea9c5d8, 0xbf9dd7f392efc607, 0x3fc3fe4fc7805a7b, 0xbf9de047d2cad831, 0x3fe6e73b0f731a97, + 0xbf9de89c12244432, 0x3fefb8668c83ad1e, 0xbf9df0f050fbe5e5, 0x3febf375ec4df805, 0xbf9df9448f519925, 0x3fda2e9525023f2a, 0xbf9e0198cd2539cd, 0xbfcbda92fe177450, + 0xbf9e09ed0a76a3b8, 0xbfe8413d5efe7e1a, 0xbf9e12414745b2c1, 0xbfefec0f342964fb, 0xbf9e1a95839242c2, 0xbfeaec457c0d1c23, 0xbf9e22e9bf5c2f98, 0xbfd67b5ef17d483a, + 0xbf9e2b3dfaa3551c, 0x3fd1cd7c7163ae5e, 0xbf9e339235678f2b, 0x3fe982fc0d14509c, 0xbf9e3be66fa8b99f, 0x3fefffc8a707b23b, 0xbf9e443aa966b053, 0x3fe9ca261f03ff84, + 0xbf9e4c8ee2a14f22, 0x3fd2b1ab27adf56c, 0xbf9e54e31b5871e8, 0xbfd59be02606d940, 0xbf9e5d37538bf47f, 0xbfeaab353b72659e, 0xbf9e658b8b3bb2c3, 0xbfeff37f29b506a4, + 0xbf9e6ddfc267888f, 0xbfe88e3a1109f4d0, 0xbf9e7633f90f51bd, 0xbfcdaa87b5ea6c94, 0xbf9e7e882f32ea29, 0x3fd954a5d9a8bad6, 0xbf9e86dc64d22daf, 0x3febb8c0936cf580, + 0xbf9e8f3099ecf829, 0x3fefc73f06e93e03, 0xbf9e9784ce832572, 0x3fe739bd5d517aba, 0xbf9e9fd902949166, 0x3fc5d40ba721680f, 0xbf9ea82d362117e0, 0xbfdcf41467bbc6e2, + 0xbf9eb081692894ba, 0xbfecaa906f4083c2, 0xbf9eb8d59baae3d1, 0xbfef7b348323d5ae, 0xbf9ec129cda7e0ff, 0xbfe5ce04a1efe134, 0xbf9ec97dff1f6820, 0xbfbbcf72cd9ffc1b, + 0xbf9ed1d23011550f, 0x3fe03b46035effac, 0xbf9eda26607d83a6, 0x3fed7fb2e73af104, 0xbf9ee27a9063cfc2, 0x3fef0fabb05822ef, 0xbf9eeacebfc4153e, 0x3fe44c7bbbd62e10, + 0xbf9ef322ee9e2ff4, 0x3fa7b5f838be6475, 0xbf9efb771cf1fbc0, 0xbfe1ec44f33f7635, 0xbf9f03cb4abf547e, 0xbfee3752c3f6ba27, 0xbf9f0c1f78061608, 0xbfee8510220d8462, + 0xbf9f1473a4c61c3a, 0xbfe2b6a459bfb2a3, 0xbf9f1cc7d0ff42f0, 0x3f90955af0afd752, 0xbf9f251bfcb16604, 0x3fe38b55da131e91, 0xbf9f2d7027dc6152, 0x3feed0b8534f5ea7, + 0xbf9f35c4528010b5, 0x3feddbec8170a74b, 0xbf9f3e187c9c5008, 0x3fe10e147b103725, 0xbf9f466ca630fb28, 0xbfb42183d759b8a8, 0xbf9f4ec0cf3dedee, 0xbfe516d97da0f69e, + 0xbf9f5714f7c30437, 0xbfef4b4a20af40ad, 0xbf9f5f691fc019df, 0xbfed14ea02ce815c, 0xbf9f67bd47350abf, 0xbfdea8e9b290ba14, 0xbf9f70116e21b2b4, 0x3fc204c6b855cb78, + 0xbf9f78659485ed9a, 0x3fe68d44337d608b, 0xbf9f80b9ba61974b, 0x3fefa68d8e33df3a, 0xbf9f890ddfb48ba3, 0x3fec30cfbc43dbb1, 0xbf9f9162047ea67d, 0x3fdb16fe8001dfe9, + 0xbf9f99b628bfc3b5, 0xbfc9e6c4f78fb5f0, 0xbf9fa20a4c77bf27, 0xbfe7ed1f6c09d335, 0xbf9faa5e6fa674ad, 0xbfefe2274f709d00, 0xbf9fb2b2924bc023, 0xbfeb3081de71d670, + 0xbf9fbb06b4677d65, 0xbfd769f9a35183db, 0xbf9fc35ad5f9884f, 0x3fd0d76cf216f23b, 0xbf9fcbaef701bcba, 0x3fe9350b295e6a07, 0xbf9fd403177ff685, 0x3feffddbc4c5a395, + 0xbf9fdc5737741188, 0x3fea1500d0ba506a, 0xbf9fe4ab56dde9a1, 0x3fd3a5887e1f9e8b, 0xbf9fecff75bd5aab, 0xbfd4aa9e5272100d, 0xbf9ff55394124081, 0xbfea63bf5f8eb27d, + 0xbf9ffda7b1dc76fe, 0xbfeff98f36fb8ad3, 0xbfa002fde78ded00, 0xbfe8df682fff25ce, 0xbfa00727f5e822b0, 0xbfcf9adfc147852d, 0xbfa00b5203fcca7d, 0x3fd869230b688b8d, + 0xbfa00f7c11cbd255, 0x3feb780d3c41e97a, 0xbfa013a61f552826, 0x3fefd545f3120f62, 0xbfa017d02c98b9de, 0x3fe790edb365f30b, 0xbfa01bfa3996756a, 0x3fc7cb10880008c3, + 0xbfa02024464e48b9, 0xbfdc0f3c38d51222, 0xbfa0244e52c021b7, 0xbfec70e056860d8a, 0xbfa028785eebee54, 0xbfef912445e0cff0, 0xbfa02ca26ad19c7c, 0xbfe62adff635f677, + 0xbfa030cc76711a1e, 0xbfbfc6e7cd709110, 0xbfa034f681ca5527, 0x3fdf994365eeb94a, 0xbfa039208cdd3b85, 0x3fed4d3fc2b99678, 0xbfa03d4a97a9bb26, 0x3fef2d6e57bdebf8, + 0xbfa04174a22fc1f9, 0x3fe4aea529d190f2, 0xbfa0459eac6f3dea, 0x3fafafc90253057c, 0xbddeacd7c60e9693, 0x3de0a9941cf8b4b6, 0xbdf7ab35f183a5a5, 0xbfeff50e60ab53f9, +] )) ), + +################ chunk 22528 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x412e240ca45a1cac, 0x41132cbd0f5c28f6, 0x41109750ba5e353f, 0x41219d7f53f7ced9, 0x412a6dd2ce560419, 0x412594458fdf3b64, 0x4132d687e3d70a3d, 0x4162d687e6b851ec, + 0x4147f7ec53333333, 0x4144bd24e8f5c28f, 0x415604df28f5c28f, 0x416084a3c0f5c28f, 0x415af956f3d70a3d, 0x41678c29dccccccd, 0x41978c29e0666666, 0x417df5e768000000, + 0x4179ec6e23333333, 0x418b8616f3333333, 0x4194a5ccb1333333, 0x4190dbd658666666, 0x419d6f3454000000, 0x41cd6f3458800000, 0x41b2b9b0a1000000, 0x41b033c4d6000000, + 0x41c133ce58000000, 0x41c9cf3fdd800000, 0x41c512cbee800000, 0x41d26580b4800000, 0x42026580b7500000, 0x41e7681cc9400000, 0x41e440b60b800000, 0x41f580c1ee000000, + 0x42002187ea700000, 0x41fa577eea200000, 0x4206fee0e1a00000, 0x4236fee0e5240000, 0x421d4223fb900000, 0x421950e38e600000, 0x422ae0f269800000, 0x423429e9e50c0000, + 0x423076af52540000, 0x423cbe991a080000, 0x426cbe991e6d0000, 0x425249567d3a0000, 0x424fa51c71f80000, 0x4260cc9781f00000, 0x426934645e4f0000, 0x4264945b26e90000, + 0x4271f71fb0450000, 0x42a1f71fb3042000, 0x4286dbac1c888000, 0x4283c731c73b0000, 0x4294ffbd626c0000, 0x429f817d75e2c000, 0x4299b971f0a34000, 0x42a674e79c564000, + 0x42d674e79fc52800, 0x42bc929723aaa000, 0x42b8b8fe3909c000, 0x42ca3facbb070000, 0x42d3b0ee69adb800, 0x42d013e736660800, 0x42dc1221836bd000, 0x430c122187b67200, + 0x42f1db9e764aa400, 0x42eee73dc74c3000, 0x430067cbf4e46000, 0x43089d2a04192600, 0x430418e103ff8a00, 0x43118b54f2236200, 0x43418b54f4d20740, 0x4326528613dd4d00, + 0x432350869c8f9e00, 0x433481bef21d7800, 0x433ec474851f6f80, 0x43391f1944ff6c80, 0x4345ee2a2eac3a80, 0x4375ee2a32068910, 0x435be72798d4a040, 0x435824a843b38580, + 0x4369a22eaea4d600, 0x43733ac8d333a5b0, 0x436f66df963f47a0, 0xc073a28c59d5433b, 0xc073a28c59d5433b, 0xc073a28c59d5433b, 0xc073a28c59d5434d, 0xc073a28c59d54329, + 0xc083a28c59d5433b, 0xc083a28c59d5433b, 0xc083a28c59d5433b, 0xc083a28c59d54344, 0xc083a28c59d54332, 0xc08d73d286bfe4d8, 0xc08d73d286bfe4d8, 0xc08d73d286bfe4d8, + 0xc08d73d286bfe4e1, 0xc08d73d286bfe4d0, 0xc093a28c59d5433b, 0xc093a28c59d5433b, 0xc093a28c59d5433b, 0xc093a28c59d5433f, 0xc093a28c59d54337, 0xc0988b2f704a940a, + 0xc0988b2f704a940a, 0xc0988b2f704a940a, 0xc0988b2f704a940e, 0xc0988b2f704a9405, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4dd, + 0xc09d73d286bfe4d4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad6, 0xc0a12e3ace9a9ad1, 0xc0a3a28c59d5433b, 0xc0a3a28c59d5433b, + 0xc0a3a28c59d5433b, 0xc0a3a28c59d5433d, 0xc0a3a28c59d54339, 0xc0a616dde50feba2, 0xc0a616dde50feba2, 0xc0a616dde50feba2, 0xc0a616dde50feba5, 0xc0a616dde50feba0, + 0xc0a88b2f704a940a, 0xc0a88b2f704a940a, 0xc0a88b2f704a940a, 0xc0a88b2f704a940c, 0xc0a88b2f704a9408, 0xc0aaff80fb853c71, 0xc0aaff80fb853c71, 0xc0aaff80fb853c71, + 0xc0aaff80fb853c73, 0xc0aaff80fb853c6f, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4db, 0xc0ad73d286bfe4d6, 0xc0afe82411fa8d40, + 0xc0afe82411fa8d40, 0xc0afe82411fa8d40, 0xc0afe82411fa8d42, 0xc0afe82411fa8d3e, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad5, + 0xc0b12e3ace9a9ad2, 0xc0b268639437ef07, 0xc0b268639437ef07, 0xc0b268639437ef07, 0xc0b268639437ef08, 0xc0b268639437ef06, 0xc0b3a28c59d5433b, 0xc0b3a28c59d5433b, + 0xc0b3a28c59d5433b, 0xc0b3a28c59d5433c, 0xc0b3a28c59d5433a, 0xc0b4dcb51f72976f, 0xc0b4dcb51f72976f, 0xc0b4dcb51f72976f, 0xc0b4dcb51f729770, 0xc0b4dcb51f72976e, + 0xc0b616dde50feba2, 0xc0b616dde50feba2, 0xc0b616dde50feba2, 0xc0b616dde50feba3, 0xc0b616dde50feba1, 0xc0b75106aaad3fd6, 0xc0b75106aaad3fd6, 0xc0b75106aaad3fd6, + 0xc0b75106aaad3fd7, 0xc0b75106aaad3fd5, 0xc0b88b2f704a940a, 0xc0b88b2f704a940a, 0xc0b88b2f704a940a, 0xc0b88b2f704a940b, 0xc0b88b2f704a9409, 0xc0b9c55835e7e83d, + 0xc0b9c55835e7e83d, 0xc0b9c55835e7e83d, 0xc0b9c55835e7e83e, 0xc0b9c55835e7e83c, 0xc0baff80fb853c71, 0xc0baff80fb853c71, 0xc0baff80fb853c71, 0xc0baff80fb853c72, + 0xc0baff80fb853c70, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a6, 0xc0bc39a9c12290a4, 0xc0bd73d286bfe4d8, 0xc0bd73d286bfe4d8, + 0xc0bd73d286bfe4d8, 0xc0bd73d286bfe4da, 0xc0bd73d286bfe4d7, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390d, 0xc0beadfb4c5d390b, + 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d41, 0xc0bfe82411fa8d3f, 0xc0c091266bcbf0ba, 0xc0c091266bcbf0ba, 0xc0c091266bcbf0ba, + 0xc0c091266bcbf0ba, 0xc0c091266bcbf0b9, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad3, 0xc0c1cb4f316944ed, + 0xc0c1cb4f316944ed, 0xc0c1cb4f316944ed, 0xc0c1cb4f316944ee, 0xc0c1cb4f316944ed, 0xc0c268639437ef07, 0xc0c268639437ef07, 0xc0c268639437ef07, 0xc0c268639437ef08, + 0xc0c268639437ef07, 0xc0c30577f7069921, 0xc0c30577f7069921, 0xc0c30577f7069921, 0xc0c30577f7069922, 0xc0c30577f7069921, 0xc0c3a28c59d5433b, 0xc0c3a28c59d5433b, + 0xc0c3a28c59d5433b, 0xc0c3a28c59d5433c, 0xc0c3a28c59d5433a, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed54, + 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976e, 0xc0c579c982414188, 0xc0c579c982414188, 0xc0c579c982414188, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3fda3f16e3d46852, 0xbf3786ac5cdce39d, 0xbfee81586a1953c0, 0xbfefa43c23fc85dc, 0x3fef90aa1ace3d07, 0xbfcf6f508364a0ba, 0xbfdfa18f39db7dc7, 0xbfec489554f09fb9, + 0xbf6d68537b03d0c3, 0xbfb2b0bfb20e497b, 0x3fefea69ab25e742, 0x3fefe5f511ddc5c9, 0x3fe3a1058d3e2c00, 0xbfecb6bcc6c2b873, 0xbfef9db7fb3caf63, 0xbfa260340aa29cc1, + 0xbfe55b8ab126a549, 0xbfe53f5384ae6858, 0x3fe6e6cae22d27b5, 0xbfd4293e8f4955dc, 0x3fefaf0521c8dc5c, 0x3feffe52edc52dfb, 0xbfd67c01dbaaccb6, 0xbfeb56af891ce586, + 0x3fea8ac8e2eb956e, 0xbfefc33898dc74e2, 0x3fb028496cc842e4, 0x3fef92ab48541c23, 0xbfc9b77d05d14d37, 0x3fdbbbeaca65664f, 0x3fe759916769c83c, 0xbfd652c786c6b0ff, + 0x3fee09fab282caf0, 0xbfe2e4a40f3ea385, 0xbfefeeceb9eee7f9, 0x3fecc8fd0a789c79, 0x3fef278f19e5c94a, 0xbfee542d027c7474, 0xbfda2cbf9926e774, 0x3fd796489c4331d2, + 0xbfa0a1298d92710f, 0xbfe35089e6beee20, 0x3fef6a50570b98df, 0xbfe7c7dc48450a96, 0xbfbab42850333fbf, 0xbfec1905372ab2a7, 0xbfe2ed3e4f383f6e, 0xbfd46d45303a1ba2, + 0x3fc902f93fb80e7e, 0x3fee20a4c6e3370c, 0xbfebb6585845277d, 0xbfebad86e5cef3c9, 0xbfeec602659332f1, 0x3fa74a081eb69e6e, 0x3fbb52cb11da3e90, 0x3fed86614c0b38b6, + 0xbfd2af94d06d0b55, 0xbfebb52130de48e8, 0x3feb5b6f9b3ed0cb, 0x3fd6c84791de947b, 0x3fdc2080ad546045, 0xbfec0f7fa0f9dbac, 0x3fe75676552aa1ec, 0xbfc6c2bbc507d601, + 0xbfeba8f0de21ea58, 0x3fe797bfb3567eaf, 0xbfde91b316619947, 0xbfef948aa152ef10, 0x3fee8d43aa98892a, 0x3fee6289d2949922, 0x3fef40137f2dab4a, 0xbfeb2ba4e38e6616, + 0xbfed00a49add331b, 0xbfeedd1091ff8e13, 0x3feff5791cd2ceee, 0xbfbf0e7a4ed36de4, 0x3fa91d9ba309ead0, 0xbfea71fd289919ff, 0xbfe50ad2e9fd00b0, 0xbfee1096a32e9c10, + 0xbfdce65a270047d4, 0x3fdf1383125ae3a8, 0xbfee022f391f8f2c, 0xbce1b19140c0c0d5, 0xbce1b19140c0c0d5, 0xbce1b19140c0c0d5, 0xbd7208d8c8a06060, 0x3d71f727375f9fa0, + 0xbcf1b19140c0c0d5, 0xbcf1b19140c0c0d5, 0xbcf1b19140c0c0d5, 0xbd7211b19140c0c1, 0x3d71ee4e6ebf3f3f, 0x3d2caeb4c3dbdbd8, 0x3d2caeb4c3dbdbd8, 0x3d2caeb4c3dbdbd8, + 0xbd711a8a59e12121, 0x3d70e575a61ededf, 0xbd01b19140c0c0d5, 0xbd01b19140c0c0d5, 0xbd01b19140c0c0d5, 0xbd70236322818182, 0x3d6fb939bafcfcfd, 0xbd32c3beb21e1e21, + 0xbd32c3beb21e1e21, 0xbd32c3beb21e1e21, 0xbd712c3beb21e1e2, 0x3d72d3c414de1e1e, 0x3d3caeb4c3dbdbd8, 0x3d3caeb4c3dbdbd8, 0x3d3caeb4c3dbdbd8, 0xbd723514b3c24242, + 0x3d71caeb4c3dbdbe, 0xbd49ef6be3151517, 0xbd49ef6be3151517, 0xbd49ef6be3151517, 0xbd733ded7c62a2a3, 0x3d74c212839d5d5d, 0xbd11b19140c0c0d5, 0xbd11b19140c0c0d5, + 0xbd11b19140c0c0d5, 0xbd7046c645030303, 0x3d6f727375f9f9f9, 0x3d45830792e4e4e2, 0x3d45830792e4e4e2, 0x3d45830792e4e4e2, 0xbd754f9f0da36364, 0x3d72b060f25c9c9c, + 0xbd42c3beb21e1e21, 0xbd42c3beb21e1e21, 0xbd42c3beb21e1e21, 0xbd725877d643c3c4, 0x3d6b4f1053787878, 0x3d23d5ec237b7b6e, 0x3d23d5ec237b7b6e, 0x3d23d5ec237b7b6e, + 0xbd6ec2a13dc84849, 0x3d709eaf611bdbdb, 0x3d4caeb4c3dbdbd8, 0x3d4caeb4c3dbdbd8, 0x3d4caeb4c3dbdbd8, 0xbd746a2967848485, 0x3d7395d6987b7b7b, 0xbd373023024e4e57, + 0xbd373023024e4e57, 0xbd373023024e4e57, 0xbd7173023024e4e5, 0x3d6d19fb9fb63635, 0xbd59ef6be3151517, 0xbd59ef6be3151517, 0xbd59ef6be3151517, 0xbd767bdaf8c54546, + 0x3d798425073ababa, 0x3d51ed30fa696967, 0x3d51ed30fa696967, 0x3d51ed30fa696967, 0xbd67096782cb4b4c, 0x3d747b4c3e9a5a5a, 0xbd21b19140c0c0d5, 0xbd21b19140c0c0d5, + 0xbd21b19140c0c0d5, 0xbd708d8c8a060607, 0x3d6ee4e6ebf3f3f3, 0xbd5659954a99999c, 0xbd5659954a99999c, 0xbd5659954a99999c, 0xbd75966552a66667, 0x3d64d3355ab33332, + 0x3d55830792e4e4e2, 0x3d55830792e4e4e2, 0x3d55830792e4e4e2, 0xbd653e7c368d8d8f, 0x3d7560c1e4b93939, 0x3d15fa4706363606, 0x3d15fa4706363606, 0x3d15fa4706363606, + 0xbd6f502dc7ce4e50, 0x3d7057e91c18d8d8, 0xbd52c3beb21e1e21, 0xbd52c3beb21e1e21, 0xbd52c3beb21e1e21, 0xbd74b0efac878788, 0x3d669e20a6f0f0ef, 0x3d5918de2b60605d, + 0x3d5918de2b60605d, 0x3d5918de2b60605d, 0xbd637390ea4fcfd1, 0x3d7646378ad81817, 0x3d33d5ec237b7b6e, 0x3d33d5ec237b7b6e, 0x3d33d5ec237b7b6e, 0xbd6d85427b909092, + 0x3d713d5ec237b7b7, 0xbd4e5bd03345454d, 0xbd4e5bd03345454d, 0xbd4e5bd03345454d, 0xbd73cb7a0668a8aa, 0x3d68690bf32eaead, 0x3d5caeb4c3dbdbd8, 0x3d5caeb4c3dbdbd8, + 0x3d5caeb4c3dbdbd8, 0xbd78d452cf09090a, 0x3d772bad30f6f6f6, 0x3d4116a342b4b4ad, 0x3d4116a342b4b4ad, 0x3d4116a342b4b4ad, 0xbd6bba572f52d2d5, 0x3d7222d468569696, + 0xbd473023024e4e57, 0xbd473023024e4e57, 0xbd473023024e4e57, 0xbd72e6046049c9cb, 0x3d6a33f73f6c6c6a, 0xbd5fbb74a3a8a8ad, 0xbd5fbb74a3a8a8ad, 0xbd5fbb74a3a8a8ad, + 0xbd5fbb74a3a8a8ad, 0x3d781122d715d5d5, 0xbd69ef6be3151517, 0xbd69ef6be3151517, 0xbd69ef6be3151517, 0xbd69ef6be3151517, 0x3d73084a0e757574, 0x3d6bfee28baa2a28, + 0x3d6bfee28baa2a28, 0x3d6bfee28baa2a28, 0xbd72008eba2aeaec, 0x3d6bfee28baa2a28, 0x3d61ed30fa696967, 0x3d61ed30fa696967, 0x3d61ed30fa696967, 0xbd77096782cb4b4c, + 0x3d61ed30fa696967, 0x3d4f6dfda4a2a299, 0x3d4f6dfda4a2a299, 0x3d4f6dfda4a2a299, 0xbd7c12404b6babad, 0x3d4f6dfda4a2a299, 0xbd31b19140c0c0d5, 0xbd31b19140c0c0d5, + 0xbd31b19140c0c0d5, 0xbd808d8c8a060607, 0x3d7ee4e6ebf3f3f3, 0xbd588fc772b1b1b7, 0xbd588fc772b1b1b7, 0xbd588fc772b1b1b7, 0xbd588fc772b1b1b7, 0x3d79dc0e23539392, + 0xbd6659954a99999c, 0xbd6659954a99999c, 0xbd6659954a99999c, 0xbd6659954a99999c, 0x3d74d3355ab33332, 0x3d6f94b92425a5a3, 0x3d6f94b92425a5a3, 0x3d6f94b92425a5a3, +] )) ), + +################ chunk 23040 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0xc0c579c982414189, 0xc0c579c982414188, 0xc0c616dde50feba2, 0xc0c616dde50feba2, 0xc0c616dde50feba2, 0xc0c616dde50feba3, 0xc0c616dde50feba2, 0xc0c6b3f247de95bc, + 0xc0c6b3f247de95bc, 0xc0c6b3f247de95bc, 0xc0c6b3f247de95bd, 0xc0c6b3f247de95bc, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd7, + 0xc0c75106aaad3fd5, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9ef, 0xc0c88b2f704a940a, 0xc0c88b2f704a940a, + 0xc0c88b2f704a940a, 0xc0c88b2f704a940a, 0xc0c88b2f704a9409, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e23, + 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83e, 0xc0c9c55835e7e83d, 0xc0ca626c98b69257, 0xc0ca626c98b69257, 0xc0ca626c98b69257, + 0xc0ca626c98b69258, 0xc0ca626c98b69257, 0xc0caff80fb853c71, 0xc0caff80fb853c71, 0xc0caff80fb853c71, 0xc0caff80fb853c72, 0xc0caff80fb853c71, 0xc0cb9c955e53e68b, + 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68a, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, + 0xc0cc39a9c12290a4, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abe, 0xc0cd73d286bfe4d8, 0xc0cd73d286bfe4d8, + 0xc0cd73d286bfe4d8, 0xc0cd73d286bfe4d9, 0xc0cd73d286bfe4d8, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef3, 0xc0ce10e6e98e8ef2, + 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390d, 0xc0ceadfb4c5d390c, 0xc0cf4b0faf2be326, 0xc0cf4b0faf2be326, 0xc0cf4b0faf2be326, + 0xc0cf4b0faf2be327, 0xc0cf4b0faf2be325, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d3f, 0xc0d0429c3a649bad, + 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, + 0xc0d091266bcbf0b9, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c6, 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad4, + 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad3, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe0, + 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ee, 0xc0d1cb4f316944ed, 0xc0d219d962d099fa, 0xc0d219d962d099fa, 0xc0d219d962d099fa, + 0xc0d219d962d099fb, 0xc0d219d962d099fa, 0xc0d268639437ef07, 0xc0d268639437ef07, 0xc0d268639437ef07, 0xc0d268639437ef08, 0xc0d268639437ef07, 0xc0d2b6edc59f4414, + 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d30577f7069921, 0xc0d30577f7069921, 0xc0d30577f7069921, 0xc0d30577f7069921, + 0xc0d30577f7069921, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, + 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, + 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4262, + 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4261, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976e, 0xc0d52b3f50d9ec7c, + 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7b, 0xc0d579c982414188, 0xc0d579c982414188, 0xc0d579c982414188, 0xc0d579c982414189, + 0xc0d579c982414188, 0xc0d5c853b3a89695, 0xc0d5c853b3a89695, 0xc0d5c853b3a89695, 0xc0d5c853b3a89696, 0xc0d5c853b3a89695, 0xc0d616dde50feba2, 0xc0d616dde50feba2, + 0xc0d616dde50feba2, 0xc0d616dde50feba3, 0xc0d616dde50feba2, 0xc0d66568167740af, 0xc0d66568167740af, 0xc0d66568167740af, 0xc0d66568167740b0, 0xc0d66568167740af, + 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, + 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d79f90dc1494e3, + 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, + 0xc0d7ee1b0d7be9f0, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d88b2f704a940a, 0xc0d88b2f704a940a, + 0xc0d88b2f704a940a, 0xc0d88b2f704a940a, 0xc0d88b2f704a9409, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e916, + 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e23, 0xc0d976ce04809330, 0xc0d976ce04809330, 0xc0d976ce04809330, + 0xc0d976ce04809331, 0xc0d976ce04809330, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83e, 0xc0d9c55835e7e83d, 0xc0da13e2674f3d4a, + 0xc0da13e2674f3d4a, 0xc0da13e2674f3d4a, 0xc0da13e2674f3d4b, 0xc0da13e2674f3d4a, 0xc0da626c98b69257, 0xc0da626c98b69257, 0xc0da626c98b69257, 0xc0da626c98b69258, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbd7035a36ded2d2f, 0x3d6f94b92425a5a3, 0x3d65830792e4e4e2, 0x3d65830792e4e4e2, 0x3d65830792e4e4e2, 0xbd753e7c368d8d8f, 0x3d65830792e4e4e2, 0x3d56e2ac03484842, + 0x3d56e2ac03484842, 0x3d56e2ac03484842, 0xbd7a4754ff2dedef, 0x3d56e2ac03484842, 0x3d25fa4706363606, 0x3d25fa4706363606, 0x3d25fa4706363606, 0xbd7f502dc7ce4e50, + 0x3d8057e91c18d8d8, 0xbd51641a41babac1, 0xbd51641a41babac1, 0xbd51641a41babac1, 0xbd51641a41babac1, 0x3d7ba6f96f915150, 0xbd62c3beb21e1e21, 0xbd62c3beb21e1e21, + 0xbd62c3beb21e1e21, 0xbd62c3beb21e1e21, 0x3d769e20a6f0f0ef, 0xbd6cd570435edee2, 0xbd6cd570435edee2, 0xbd6cd570435edee2, 0xbd6cd570435edee2, 0x3d719547de50908f, + 0x3d6918de2b60605d, 0x3d6918de2b60605d, 0x3d6918de2b60605d, 0xbd737390ea4fcfd1, 0x3d6918de2b60605d, 0x3d5e0e59343f3f38, 0x3d5e0e59343f3f38, 0x3d5e0e59343f3f38, + 0xbd787c69b2f03032, 0x3d5e0e59343f3f38, 0x3d43d5ec237b7b6e, 0x3d43d5ec237b7b6e, 0x3d43d5ec237b7b6e, 0xbd7d85427b909092, 0x3d43d5ec237b7b6e, 0xbd4470da21878796, + 0xbd4470da21878796, 0xbd4470da21878796, 0xbd4470da21878796, 0x3d7d71e4bbcf0f0d, 0xbd5e5bd03345454d, 0xbd5e5bd03345454d, 0xbd5e5bd03345454d, 0xbd5e5bd03345454d, + 0x3d78690bf32eaead, 0xbd693f99aae36367, 0xbd693f99aae36367, 0xbd693f99aae36367, 0xbd693f99aae36367, 0x3d7360332a8e4e4c, 0x3d6caeb4c3dbdbd8, 0x3d6caeb4c3dbdbd8, + 0x3d6caeb4c3dbdbd8, 0xbd71a8a59e121214, 0x3d6caeb4c3dbdbd8, 0x3d629d03329b1b17, 0x3d629d03329b1b17, 0x3d629d03329b1b17, 0xbd76b17e66b27274, 0x3d629d03329b1b17, + 0x3d5116a342b4b4ad, 0x3d5116a342b4b4ad, 0x3d5116a342b4b4ad, 0xbd7bba572f52d2d5, 0x3d5116a342b4b4ad, 0xbd2865fefe6666a7, 0xbd2865fefe6666a7, 0xbd2865fefe6666a7, + 0xbd806197fbf9999b, 0x3d7f3cd0080ccccb, 0xbd573023024e4e57, 0xbd573023024e4e57, 0xbd573023024e4e57, 0xbd573023024e4e57, 0x3d7a33f73f6c6c6a, 0xbd65a9c31267e7ec, + 0xbd65a9c31267e7ec, 0xbd65a9c31267e7ec, 0xbd65a9c31267e7ec, 0xbd65a9c31267e7ec, 0xbd6fbb74a3a8a8ad, 0xbd6fbb74a3a8a8ad, 0xbd6fbb74a3a8a8ad, 0xbd6fbb74a3a8a8ad, + 0x3d881122d715d5d5, 0xbd74e6931a74b4b7, 0xbd74e6931a74b4b7, 0xbd74e6931a74b4b7, 0xbd74e6931a74b4b7, 0x3d858cb672c5a5a5, 0xbd79ef6be3151517, 0xbd79ef6be3151517, + 0xbd79ef6be3151517, 0xbd79ef6be3151517, 0x3d83084a0e757574, 0xbd7ef844abb57578, 0xbd7ef844abb57578, 0xbd7ef844abb57578, 0xbd7ef844abb57578, 0x3d8083ddaa254544, + 0x3d7bfee28baa2a28, 0x3d7bfee28baa2a28, 0x3d7bfee28baa2a28, 0xbd82008eba2aeaec, 0x3d7bfee28baa2a28, 0x3d76f609c309c9c7, 0x3d76f609c309c9c7, 0x3d76f609c309c9c7, + 0xbd8484fb1e7b1b1c, 0x3d76f609c309c9c7, 0x3d71ed30fa696967, 0x3d71ed30fa696967, 0x3d71ed30fa696967, 0xbd87096782cb4b4c, 0x3d71ed30fa696967, 0x3d69c8b06392120d, + 0x3d69c8b06392120d, 0x3d69c8b06392120d, 0x3d69c8b06392120d, 0x3d69c8b06392120d, 0x3d5f6dfda4a2a299, 0x3d5f6dfda4a2a299, 0x3d5f6dfda4a2a299, 0x3d5f6dfda4a2a299, + 0x3d5f6dfda4a2a299, 0x3d4695350442422e, 0x3d4695350442422e, 0x3d4695350442422e, 0x3d4695350442422e, 0x3d4695350442422e, 0xbd41b19140c0c0d5, 0xbd41b19140c0c0d5, + 0xbd41b19140c0c0d5, 0xbd41b19140c0c0d5, 0xbd41b19140c0c0d5, 0xbd5cfc2bc2e1e1ec, 0xbd5cfc2bc2e1e1ec, 0xbd5cfc2bc2e1e1ec, 0xbd5cfc2bc2e1e1ec, 0xbd5cfc2bc2e1e1ec, + 0xbd688fc772b1b1b7, 0xbd688fc772b1b1b7, 0xbd688fc772b1b1b7, 0xbd688fc772b1b1b7, 0xbd688fc772b1b1b7, 0xbd7150bc81f9393c, 0xbd7150bc81f9393c, 0xbd7150bc81f9393c, + 0xbd7150bc81f9393c, 0x3d8757a1bf036362, 0xbd7659954a99999c, 0xbd7659954a99999c, 0xbd7659954a99999c, 0xbd7659954a99999c, 0x3d84d3355ab33332, 0xbd7b626e1339f9fd, + 0xbd7b626e1339f9fd, 0xbd7b626e1339f9fd, 0xbd7b626e1339f9fd, 0x3d824ec8f6630302, 0x3d7f94b92425a5a3, 0x3d7f94b92425a5a3, 0x3d7f94b92425a5a3, 0xbd8035a36ded2d2f, + 0x3d7f94b92425a5a3, 0x3d7a8be05b854542, 0x3d7a8be05b854542, 0x3d7a8be05b854542, 0xbd82ba0fd23d5d5f, 0x3d7a8be05b854542, 0x3d75830792e4e4e2, 0x3d75830792e4e4e2, + 0x3d75830792e4e4e2, 0xbd853e7c368d8d8f, 0x3d75830792e4e4e2, 0x3d707a2eca448482, 0x3d707a2eca448482, 0x3d707a2eca448482, 0xbd87c2e89addbdbf, 0x3d707a2eca448482, + 0x3d66e2ac03484842, 0x3d66e2ac03484842, 0x3d66e2ac03484842, 0x3d66e2ac03484842, 0x3d66e2ac03484842, 0x3d59a1f4e40f0f03, 0x3d59a1f4e40f0f03, 0x3d59a1f4e40f0f03, + 0x3d59a1f4e40f0f03, 0x3d59a1f4e40f0f03, 0x3d35fa4706363606, 0x3d35fa4706363606, 0x3d35fa4706363606, 0x3d35fa4706363606, 0x3d35fa4706363606, 0xbd4d49a2c1e7e800, + 0xbd4d49a2c1e7e800, 0xbd4d49a2c1e7e800, 0xbd4d49a2c1e7e800, 0xbd4d49a2c1e7e800, 0xbd61641a41babac1, 0xbd61641a41babac1, 0xbd61641a41babac1, 0xbd61641a41babac1, + 0xbd61641a41babac1, 0xbd6b75cbd2fb7b82, 0xbd6b75cbd2fb7b82, 0xbd6b75cbd2fb7b82, 0xbd6b75cbd2fb7b82, 0xbd6b75cbd2fb7b82, 0xbd72c3beb21e1e21, 0xbd72c3beb21e1e21, + 0xbd72c3beb21e1e21, 0xbd72c3beb21e1e21, 0x3d869e20a6f0f0ef, 0xbd77cc977abe7e82, 0xbd77cc977abe7e82, 0xbd77cc977abe7e82, 0xbd77cc977abe7e82, 0x3d8419b442a0c0bf, + 0xbd7cd570435edee2, 0xbd7cd570435edee2, 0xbd7cd570435edee2, 0xbd7cd570435edee2, 0x3d819547de50908f, 0x3d7e21b6f400c0bd, 0x3d7e21b6f400c0bd, 0x3d7e21b6f400c0bd, + 0xbd80ef2485ff9fa1, 0x3d7e21b6f400c0bd, 0x3d7918de2b60605d, 0x3d7918de2b60605d, 0x3d7918de2b60605d, 0xbd837390ea4fcfd1, 0x3d7918de2b60605d, 0x3d74100562bffffd, + 0x3d74100562bffffd, 0x3d74100562bffffd, 0xbd85f7fd4ea00002, 0x3d74100562bffffd, 0x3d6e0e59343f3f38, 0x3d6e0e59343f3f38, 0x3d6e0e59343f3f38, 0xbd887c69b2f03032, +] )) ), + +################ chunk 23552 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0xc0da626c98b69257, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0daff80fb853c71, 0xc0daff80fb853c71, + 0xc0daff80fb853c71, 0xc0daff80fb853c71, 0xc0daff80fb853c71, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, + 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, + 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a4, 0xc0dc8833f289e5b2, + 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b1, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, + 0xc0dcd6be23f13abe, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcb, 0xc0dd73d286bfe4d8, 0xc0dd73d286bfe4d8, + 0xc0dd73d286bfe4d8, 0xc0dd73d286bfe4d9, 0xc0dd73d286bfe4d8, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e6, 0xc0ddc25cb82739e5, + 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef3, 0xc0de10e6e98e8ef2, 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, + 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0defc857dc48e19, + 0x4330000000000000, 0x4330000000000001, 0x432ffffffffffffe, 0x4340000000000000, 0x433fffffffffffff, 0x43265286144ada42, 0x432350869d91c44a, 0x431418e104164f9c, + 0x401921fb54442d18, 0x402921fb54442d18, 0x403921fb54442d18, 0x4127f7eac1891f4d, 0x415df5e7364f130d, 0x5fe7dddf6b095ff1, 0x601dd55745cbb7ed, 0x6052a5568b9f52f4, + 0x7fefffffffffffff, 0x7fdfffffffffffff, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5434d, 0x4073a28c59d54329, 0x4083a28c59d5433b, + 0x4083a28c59d5433b, 0x4083a28c59d5433b, 0x4083a28c59d54344, 0x4083a28c59d54332, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4e1, + 0x408d73d286bfe4d0, 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433f, 0x4093a28c59d54337, 0x40988b2f704a940a, 0x40988b2f704a940a, + 0x40988b2f704a940a, 0x40988b2f704a940e, 0x40988b2f704a9405, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4dd, 0x409d73d286bfe4d4, + 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad6, 0x40a12e3ace9a9ad1, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, + 0x40a3a28c59d5433d, 0x40a3a28c59d54339, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba5, 0x40a616dde50feba0, 0x40a88b2f704a940a, + 0x40a88b2f704a940a, 0x40a88b2f704a940a, 0x40a88b2f704a940c, 0x40a88b2f704a9408, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c73, + 0x40aaff80fb853c6f, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4db, 0x40ad73d286bfe4d6, 0x40afe82411fa8d40, 0x40afe82411fa8d40, + 0x40afe82411fa8d40, 0x40afe82411fa8d42, 0x40afe82411fa8d3e, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad5, 0x40b12e3ace9a9ad2, + 0x40b268639437ef07, 0x40b268639437ef07, 0x40b268639437ef07, 0x40b268639437ef08, 0x40b268639437ef06, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, + 0x40b3a28c59d5433c, 0x40b3a28c59d5433a, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f729770, 0x40b4dcb51f72976e, 0x40b616dde50feba2, + 0x40b616dde50feba2, 0x40b616dde50feba2, 0x40b616dde50feba3, 0x40b616dde50feba1, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd7, + 0x40b75106aaad3fd5, 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940b, 0x40b88b2f704a9409, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, + 0x40b9c55835e7e83d, 0x40b9c55835e7e83e, 0x40b9c55835e7e83c, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c72, 0x40baff80fb853c70, + 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, 0x40bc39a9c12290a6, 0x40bc39a9c12290a4, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, + 0x40bd73d286bfe4da, 0x40bd73d286bfe4d7, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390d, 0x40beadfb4c5d390b, 0x40bfe82411fa8d40, + 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, 0x40bfe82411fa8d41, 0x40bfe82411fa8d3f, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, + 0x40c091266bcbf0b9, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad3, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, + 0x40c1cb4f316944ed, 0x40c1cb4f316944ee, 0x40c1cb4f316944ed, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef08, 0x40c268639437ef07, + 0x40c30577f7069921, 0x40c30577f7069921, 0x40c30577f7069921, 0x40c30577f7069922, 0x40c30577f7069921, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, + 0x40c3a28c59d5433c, 0x40c3a28c59d5433a, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed54, 0x40c4dcb51f72976f, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d6e0e59343f3f38, 0x3d63fca7a2fe7e78, 0x3d63fca7a2fe7e78, 0x3d63fca7a2fe7e78, 0x3d63fca7a2fe7e78, 0x3d63fca7a2fe7e78, 0x3d53d5ec237b7b6e, 0x3d53d5ec237b7b6e, + 0x3d53d5ec237b7b6e, 0x3d53d5ec237b7b6e, 0x3d53d5ec237b7b6e, 0xbcf35dbfc1818507, 0xbcf35dbfc1818507, 0xbcf35dbfc1818507, 0xbcf35dbfc1818507, 0xbcf35dbfc1818507, + 0xbd5470da21878796, 0xbd5470da21878796, 0xbd5470da21878796, 0xbd5470da21878796, 0xbd5470da21878796, 0xbd644a1ea204848c, 0xbd644a1ea204848c, 0xbd644a1ea204848c, + 0xbd644a1ea204848c, 0xbd644a1ea204848c, 0xbd6e5bd03345454d, 0xbd6e5bd03345454d, 0xbd6e5bd03345454d, 0xbd6e5bd03345454d, 0x3d88690bf32eaead, 0xbd7436c0e2430307, + 0xbd7436c0e2430307, 0xbd7436c0e2430307, 0xbd7436c0e2430307, 0x3d85e49f8ede7e7d, 0xbd793f99aae36367, 0xbd793f99aae36367, 0xbd793f99aae36367, 0xbd793f99aae36367, + 0x3d8360332a8e4e4c, 0xbd7e48727383c3c8, 0xbd7e48727383c3c8, 0xbd7e48727383c3c8, 0xbd7e48727383c3c8, 0x3d80dbc6c63e1e1c, 0x3d7caeb4c3dbdbd8, 0x3d7caeb4c3dbdbd8, + 0x3d7caeb4c3dbdbd8, 0xbd81a8a59e121214, 0x3d7caeb4c3dbdbd8, 0x3d77a5dbfb3b7b78, 0x3d77a5dbfb3b7b78, 0x3d77a5dbfb3b7b78, 0xbd842d1202624244, 0x3d77a5dbfb3b7b78, + 0x3d729d03329b1b17, 0x3d729d03329b1b17, 0x3d729d03329b1b17, 0xbd86b17e66b27274, 0x3d729d03329b1b17, 0x3d6b2854d3f5756e, 0x3d6b2854d3f5756e, 0x3d6b2854d3f5756e, + 0x3d6b2854d3f5756e, 0x3d6b2854d3f5756e, 0x3d6116a342b4b4ad, 0x3d6116a342b4b4ad, 0x3d6116a342b4b4ad, 0x3d6116a342b4b4ad, 0x3d6116a342b4b4ad, 0x3d4c13c6c5cfcfb0, + 0x3febf996908bb506, 0x3fb053c35068e10d, 0x3fec305ff352c3c8, 0xbfeb2a66c8f35586, 0xbf8c9176a7414f8f, 0xbfce3c19275e1ff0, 0xbfa3c7ae38d5f2e3, 0xbfaeef2de8eeb189, + 0xbcb1a62633145c07, 0xbcc1a62633145c07, 0xbcd1a62633145c07, 0xbfe6a09e6681b409, 0xbfe6a09e669be136, 0xbfd23d1bb04074f8, 0xbfa1c2f8985056fe, 0xbfef79889b7413b3, + 0x3f7452fc98b34e97, 0x3feffff98bb3443c, 0x3ce1b19140c0c0d5, 0x3ce1b19140c0c0d5, 0x3ce1b19140c0c0d5, 0x3d7208d8c8a06060, 0xbd71f727375f9fa0, 0x3cf1b19140c0c0d5, + 0x3cf1b19140c0c0d5, 0x3cf1b19140c0c0d5, 0x3d7211b19140c0c1, 0xbd71ee4e6ebf3f3f, 0xbd2caeb4c3dbdbd8, 0xbd2caeb4c3dbdbd8, 0xbd2caeb4c3dbdbd8, 0x3d711a8a59e12121, + 0xbd70e575a61ededf, 0x3d01b19140c0c0d5, 0x3d01b19140c0c0d5, 0x3d01b19140c0c0d5, 0x3d70236322818182, 0xbd6fb939bafcfcfd, 0x3d32c3beb21e1e21, 0x3d32c3beb21e1e21, + 0x3d32c3beb21e1e21, 0x3d712c3beb21e1e2, 0xbd72d3c414de1e1e, 0xbd3caeb4c3dbdbd8, 0xbd3caeb4c3dbdbd8, 0xbd3caeb4c3dbdbd8, 0x3d723514b3c24242, 0xbd71caeb4c3dbdbe, + 0x3d49ef6be3151517, 0x3d49ef6be3151517, 0x3d49ef6be3151517, 0x3d733ded7c62a2a3, 0xbd74c212839d5d5d, 0x3d11b19140c0c0d5, 0x3d11b19140c0c0d5, 0x3d11b19140c0c0d5, + 0x3d7046c645030303, 0xbd6f727375f9f9f9, 0xbd45830792e4e4e2, 0xbd45830792e4e4e2, 0xbd45830792e4e4e2, 0x3d754f9f0da36364, 0xbd72b060f25c9c9c, 0x3d42c3beb21e1e21, + 0x3d42c3beb21e1e21, 0x3d42c3beb21e1e21, 0x3d725877d643c3c4, 0xbd6b4f1053787878, 0xbd23d5ec237b7b6e, 0xbd23d5ec237b7b6e, 0xbd23d5ec237b7b6e, 0x3d6ec2a13dc84849, + 0xbd709eaf611bdbdb, 0xbd4caeb4c3dbdbd8, 0xbd4caeb4c3dbdbd8, 0xbd4caeb4c3dbdbd8, 0x3d746a2967848485, 0xbd7395d6987b7b7b, 0x3d373023024e4e57, 0x3d373023024e4e57, + 0x3d373023024e4e57, 0x3d7173023024e4e5, 0xbd6d19fb9fb63635, 0x3d59ef6be3151517, 0x3d59ef6be3151517, 0x3d59ef6be3151517, 0x3d767bdaf8c54546, 0xbd798425073ababa, + 0xbd51ed30fa696967, 0xbd51ed30fa696967, 0xbd51ed30fa696967, 0x3d67096782cb4b4c, 0xbd747b4c3e9a5a5a, 0x3d21b19140c0c0d5, 0x3d21b19140c0c0d5, 0x3d21b19140c0c0d5, + 0x3d708d8c8a060607, 0xbd6ee4e6ebf3f3f3, 0x3d5659954a99999c, 0x3d5659954a99999c, 0x3d5659954a99999c, 0x3d75966552a66667, 0xbd64d3355ab33332, 0xbd55830792e4e4e2, + 0xbd55830792e4e4e2, 0xbd55830792e4e4e2, 0x3d653e7c368d8d8f, 0xbd7560c1e4b93939, 0xbd15fa4706363606, 0xbd15fa4706363606, 0xbd15fa4706363606, 0x3d6f502dc7ce4e50, + 0xbd7057e91c18d8d8, 0x3d52c3beb21e1e21, 0x3d52c3beb21e1e21, 0x3d52c3beb21e1e21, 0x3d74b0efac878788, 0xbd669e20a6f0f0ef, 0xbd5918de2b60605d, 0xbd5918de2b60605d, + 0xbd5918de2b60605d, 0x3d637390ea4fcfd1, 0xbd7646378ad81817, 0xbd33d5ec237b7b6e, 0xbd33d5ec237b7b6e, 0xbd33d5ec237b7b6e, 0x3d6d85427b909092, 0xbd713d5ec237b7b7, + 0x3d4e5bd03345454d, 0x3d4e5bd03345454d, 0x3d4e5bd03345454d, 0x3d73cb7a0668a8aa, 0xbd68690bf32eaead, 0xbd5caeb4c3dbdbd8, 0xbd5caeb4c3dbdbd8, 0xbd5caeb4c3dbdbd8, + 0x3d78d452cf09090a, 0xbd772bad30f6f6f6, 0xbd4116a342b4b4ad, 0xbd4116a342b4b4ad, 0xbd4116a342b4b4ad, 0x3d6bba572f52d2d5, 0xbd7222d468569696, 0x3d473023024e4e57, + 0x3d473023024e4e57, 0x3d473023024e4e57, 0x3d72e6046049c9cb, 0xbd6a33f73f6c6c6a, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, + 0xbd781122d715d5d5, 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0xbd73084a0e757574, 0xbd6bfee28baa2a28, 0xbd6bfee28baa2a28, + 0xbd6bfee28baa2a28, 0x3d72008eba2aeaec, 0xbd6bfee28baa2a28, 0xbd61ed30fa696967, 0xbd61ed30fa696967, 0xbd61ed30fa696967, 0x3d77096782cb4b4c, 0xbd61ed30fa696967, + 0xbd4f6dfda4a2a299, 0xbd4f6dfda4a2a299, 0xbd4f6dfda4a2a299, 0x3d7c12404b6babad, 0xbd4f6dfda4a2a299, 0x3d31b19140c0c0d5, 0x3d31b19140c0c0d5, 0x3d31b19140c0c0d5, + 0x3d808d8c8a060607, 0xbd7ee4e6ebf3f3f3, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0xbd79dc0e23539392, 0x3d6659954a99999c, +] )) ), +] +sin_float32_t = [ + +################ chunk 0 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x441d1463, 0x441d1463, 0x441d1463, + 0x441d1463, 0x441d1463, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x449d1463, + 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x44c4597c, 0x44c4597c, 0x44c4597c, 0x44c4597c, + 0x44c4597c, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x450971d6, 0x450971d6, + 0x450971d6, 0x450971d6, 0x450971d6, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, + 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4544597c, 0x4544597c, 0x4544597c, + 0x4544597c, 0x4544597c, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x456b9e94, + 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x457f4121, 0x457f4121, 0x457f4121, 0x457f4121, + 0x457f4121, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x4593431d, 0x4593431d, + 0x4593431d, 0x4593431d, 0x4593431d, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, + 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45b0b6ef, 0x45b0b6ef, 0x45b0b6ef, + 0x45b0b6ef, 0x45b0b6ef, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45c4597c, + 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, + 0x45ce2ac2, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45e1cd4e, 0x45e1cd4e, + 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, + 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45ff4121, 0x45ff4121, 0x45ff4121, + 0x45ff4121, 0x45ff4121, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x460971d6, + 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, + 0x460e5a7a, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x46182bc0, 0x46182bc0, + 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, + 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4626e5a9, 0x4626e5a9, 0x4626e5a9, + 0x4626e5a9, 0x4626e5a9, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x4630b6ef, + 0x4630b6ef, 0x4630b6ef, 0x4630b6ef, 0x4630b6ef, 0x46359f92, 0x46359f92, 0x46359f92, 0x46359f92, + 0x46359f92, 0x463a8835, 0x463a8835, 0x463a8835, 0x463a8835, 0x463a8835, 0x463f70d8, 0x463f70d8, + 0x463f70d8, 0x463f70d8, 0x463f70d8, 0x4644597c, 0x4644597c, 0x4644597c, 0x4644597c, 0x4644597c, + 0x4649421f, 0x4649421f, 0x4649421f, 0x4649421f, 0x4649421f, 0x464e2ac2, 0x464e2ac2, 0x464e2ac2, + 0x464e2ac2, 0x464e2ac2, 0x46531365, 0x46531365, 0x46531365, 0x46531365, 0x46531365, 0x4657fc08, + 0x4657fc08, 0x4657fc08, 0x4657fc08, 0x4657fc08, 0x465ce4ab, 0x465ce4ab, 0x465ce4ab, 0x465ce4ab, + 0x465ce4ab, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4666b5f1, 0x4666b5f1, + 0x4666b5f1, 0x4666b5f1, 0x4666b5f1, 0x466b9e94, 0x466b9e94, 0x466b9e94, 0x466b9e94, 0x466b9e94, + 0x46708737, 0x46708737, 0x46708737, 0x46708737, 0x46708737, 0x46756fda, 0x46756fda, 0x46756fda, + 0x46756fda, 0x46756fda, 0x467a587d, 0x467a587d, 0x467a587d, 0x467a587d, 0x467a587d, 0x467f4121, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x36c55799, 0x36c55799, 0x36c55799, 0x36c55799, 0x36c55799, 0x37455799, 0x37455799, 0x37455799, + 0x37455799, 0x37455799, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0x37c55799, + 0x37c55799, 0x37c55799, 0x37c55799, 0x37c55799, 0x387b56bf, 0x387b56bf, 0x387b56bf, 0x387b56bf, + 0x387b56bf, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb8e9a9ad, 0xb8e9a9ad, + 0xb8e9a9ad, 0xb8e9a9ad, 0xb8e9a9ad, 0x38455799, 0x38455799, 0x38455799, 0x38455799, 0x38455799, + 0xb821fd74, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0x38fb56bf, 0x38fb56bf, 0x38fb56bf, + 0x38fb56bf, 0x38fb56bf, 0x380f5872, 0x380f5872, 0x380f5872, 0x380f5872, 0x380f5872, 0xb857fc9b, + 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0x38e0572c, 0x38e0572c, 0x38e0572c, 0x38e0572c, + 0x38e0572c, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0x393c810f, 0x393c810f, + 0x393c810f, 0x393c810f, 0x393c810f, 0x38c55799, 0x38c55799, 0x38c55799, 0x38c55799, 0x38c55799, + 0x370d6891, 0x370d6891, 0x370d6891, 0x370d6891, 0x370d6891, 0xb8a1fd74, 0xb8a1fd74, 0xb8a1fd74, + 0xb8a1fd74, 0xb8a1fd74, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0x397b56bf, + 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x3921817c, 0x3921817c, 0x3921817c, 0x3921817c, + 0x3921817c, 0x388f5872, 0x388f5872, 0x388f5872, 0x388f5872, 0x388f5872, 0xb7914852, 0xb7914852, + 0xb7914852, 0xb7914852, 0xb7914852, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, + 0xb945d391, 0xb945d391, 0xb945d391, 0xb945d391, 0xb945d391, 0x3960572c, 0x3960572c, 0x3960572c, + 0x3960572c, 0x3960572c, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9e9a9ad, + 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0x39e96bb1, 0x39e96bb1, 0x39e96bb1, 0x39e96bb1, + 0x39e96bb1, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x398f966e, 0x398f966e, + 0x398f966e, 0x398f966e, 0x398f966e, 0x39455799, 0x39455799, 0x39455799, 0x39455799, 0x39455799, + 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x378d6891, 0x378d6891, 0x378d6891, + 0x378d6891, 0x378d6891, 0xb8905062, 0xb8905062, 0xb8905062, 0xb8905062, 0xb8905062, 0xb921fd74, + 0xb921fd74, 0xb921fd74, 0xb921fd74, 0xb921fd74, 0xb97bd2b7, 0xb97bd2b7, 0xb97bd2b7, 0xb97bd2b7, + 0xb97bd2b7, 0xb9aad3fd, 0xb9aad3fd, 0xb9aad3fd, 0xb9aad3fd, 0xb9aad3fd, 0xb9d7be9f, 0xb9d7be9f, + 0xb9d7be9f, 0xb9d7be9f, 0xb9d7be9f, 0x39fb56bf, 0x39fb56bf, 0x39fb56bf, 0x39fb56bf, 0x39fb56bf, + 0x39ce6c1d, 0x39ce6c1d, 0x39ce6c1d, 0x39ce6c1d, 0x39ce6c1d, 0x39a1817c, 0x39a1817c, 0x39a1817c, + 0x39a1817c, 0x39a1817c, 0x39692db5, 0x39692db5, 0x39692db5, 0x39692db5, 0x39692db5, 0x390f5872, + 0x390f5872, 0x390f5872, 0x390f5872, 0x390f5872, 0x38560cbb, 0x38560cbb, 0x38560cbb, 0x38560cbb, + 0x38560cbb, 0xb8114852, 0xb8114852, 0xb8114852, 0xb8114852, 0xb8114852, 0xb8fc4eb0, 0xb8fc4eb0, + 0xb8fc4eb0, 0xb8fc4eb0, 0xb8fc4eb0, 0xb957fc9b, 0xb957fc9b, 0xb957fc9b, 0xb957fc9b, 0xb957fc9b, + 0xb998e8ef, 0xb998e8ef, 0xb998e8ef, 0xb998e8ef, 0xb998e8ef, 0xb9c5d390, 0xb9c5d390, 0xb9c5d390, + 0xb9c5d390, 0xb9c5d390, 0xb9f2be32, 0xb9f2be32, 0xb9f2be32, 0xb9f2be32, 0xb9f2be32, 0x39e0572c, +] )) ), + +################ chunk 512 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x467f4121, 0x467f4121, 0x467f4121, 0x467f4121, 0x468214e2, 0x468214e2, 0x468214e2, 0x468214e2, + 0x468214e2, 0x46848933, 0x46848933, 0x46848933, 0x46848933, 0x46848933, 0x4686fd85, 0x4686fd85, + 0x4686fd85, 0x4686fd85, 0x4686fd85, 0x468971d6, 0x468971d6, 0x468971d6, 0x468971d6, 0x468971d6, + 0x468be628, 0x468be628, 0x468be628, 0x468be628, 0x468be628, 0x468e5a7a, 0x468e5a7a, 0x468e5a7a, + 0x468e5a7a, 0x468e5a7a, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4693431d, + 0x4693431d, 0x4693431d, 0x4693431d, 0x4693431d, 0x4695b76e, 0x4695b76e, 0x4695b76e, 0x4695b76e, + 0x4695b76e, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x469aa011, 0x469aa011, + 0x469aa011, 0x469aa011, 0x469aa011, 0x469d1463, 0x469d1463, 0x469d1463, 0x469d1463, 0x469d1463, + 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x46a1fd06, 0x46a1fd06, 0x46a1fd06, + 0x46a1fd06, 0x46a1fd06, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a6e5a9, + 0x46a6e5a9, 0x46a6e5a9, 0x46a6e5a9, 0x46a6e5a9, 0x46a959fb, 0x46a959fb, 0x46a959fb, 0x46a959fb, + 0x46a959fb, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46ae429e, 0x46ae429e, + 0x46ae429e, 0x46ae429e, 0x46ae429e, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, + 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b59f92, 0x46b59f92, 0x46b59f92, + 0x46b59f92, 0x46b59f92, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46ba8835, + 0x46ba8835, 0x46ba8835, 0x46ba8835, 0x46ba8835, 0x46bcfc87, 0x46bcfc87, 0x46bcfc87, 0x46bcfc87, + 0x46bcfc87, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46c1e52a, 0x46c1e52a, + 0x46c1e52a, 0x46c1e52a, 0x46c1e52a, 0x46c4597c, 0x46c4597c, 0x46c4597c, 0x46c4597c, 0x46c4597c, + 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c9421f, 0x46c9421f, 0x46c9421f, + 0x46c9421f, 0x46c9421f, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46ce2ac2, + 0x46ce2ac2, 0x46ce2ac2, 0x46ce2ac2, 0x46ce2ac2, 0x46d09f13, 0x46d09f13, 0x46d09f13, 0x46d09f13, + 0x46d09f13, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d587b6, 0x46d587b6, + 0x46d587b6, 0x46d587b6, 0x46d587b6, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, + 0x46da7059, 0x46da7059, 0x46da7059, 0x46da7059, 0x46da7059, 0x46dce4ab, 0x46dce4ab, 0x46dce4ab, + 0x46dce4ab, 0x46dce4ab, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46e1cd4e, + 0x46e1cd4e, 0x46e1cd4e, 0x46e1cd4e, 0x46e1cd4e, 0x46e441a0, 0x46e441a0, 0x46e441a0, 0x46e441a0, + 0x46e441a0, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e92a43, 0x46e92a43, + 0x46e92a43, 0x46e92a43, 0x46e92a43, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, + 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46f08737, 0x46f08737, 0x46f08737, + 0x46f08737, 0x46f08737, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f56fda, + 0x46f56fda, 0x46f56fda, 0x46f56fda, 0x46f56fda, 0x46f7e42c, 0x46f7e42c, 0x46f7e42c, 0x46f7e42c, + 0x46f7e42c, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fccccf, 0x46fccccf, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x39e0572c, 0x39e0572c, 0x39e0572c, 0x39e0572c, 0x39b36c8a, 0x39b36c8a, 0x39b36c8a, 0x39b36c8a, + 0x39b36c8a, 0xba3cbf0b, 0xba3cbf0b, 0xba3cbf0b, 0xba3cbf0b, 0xba3cbf0b, 0x39332e8e, 0x39332e8e, + 0x39332e8e, 0x39332e8e, 0x39332e8e, 0xba69a9ab, 0xba69a9ab, 0xba69a9ab, 0xba69a9ab, 0xba69a9ab, + 0xb4f7f042, 0xb4f7f042, 0xb4f7f042, 0xb4f7f042, 0xb4f7f042, 0x3a696baf, 0x3a696baf, 0x3a696baf, + 0x3a696baf, 0x3a696baf, 0xb934267f, 0xb934267f, 0xb934267f, 0xb934267f, 0xb934267f, 0x3a3c810e, + 0x3a3c810e, 0x3a3c810e, 0x3a3c810e, 0x3a3c810e, 0xb9b3e882, 0xb9b3e882, 0xb9b3e882, 0xb9b3e882, + 0xb9b3e882, 0x3a0f966d, 0x3a0f966d, 0x3a0f966d, 0x3a0f966d, 0x3a0f966d, 0xba06dee2, 0xba06dee2, + 0xba06dee2, 0xba06dee2, 0xba06dee2, 0x39c55798, 0x39c55798, 0x39c55798, 0x39c55798, 0x39c55798, + 0xba33c984, 0xba33c984, 0xba33c984, 0xba33c984, 0xba33c984, 0x395704ab, 0x395704ab, 0x395704ab, + 0x395704ab, 0x395704ab, 0xba60b424, 0xba60b424, 0xba60b424, 0xba60b424, 0xba60b424, 0x380d6891, + 0x380d6891, 0x380d6891, 0x380d6891, 0x380d6891, 0x3a726136, 0x3a726136, 0x3a726136, 0x3a726136, + 0x3a726136, 0xb9105062, 0xb9105062, 0xb9105062, 0xb9105062, 0xb9105062, 0x3a457695, 0x3a457695, + 0x3a457695, 0x3a457695, 0x3a457695, 0xb9a1fd74, 0xb9a1fd74, 0xb9a1fd74, 0xb9a1fd74, 0xb9a1fd74, + 0x3a188bf4, 0x3a188bf4, 0x3a188bf4, 0x3a188bf4, 0x3a188bf4, 0xb9fbd2b7, 0xb9fbd2b7, 0xb9fbd2b7, + 0xb9fbd2b7, 0xb9fbd2b7, 0x39d742a6, 0x39d742a6, 0x39d742a6, 0x39d742a6, 0x39d742a6, 0xba2ad3fd, + 0xba2ad3fd, 0xba2ad3fd, 0xba2ad3fd, 0xba2ad3fd, 0x397adac7, 0x397adac7, 0x397adac7, 0x397adac7, + 0x397adac7, 0xba57be9d, 0xba57be9d, 0xba57be9d, 0xba57be9d, 0xba57be9d, 0x388e6082, 0x388e6082, + 0x388e6082, 0x388e6082, 0x388e6082, 0x3a7b56bd, 0x3a7b56bd, 0x3a7b56bd, 0x3a7b56bd, 0x3a7b56bd, + 0xb8d8f48b, 0xb8d8f48b, 0xb8d8f48b, 0xb8d8f48b, 0xb8d8f48b, 0x3a4e6c1c, 0x3a4e6c1c, 0x3a4e6c1c, + 0x3a4e6c1c, 0x3a4e6c1c, 0xb9901266, 0xb9901266, 0xb9901266, 0xb9901266, 0xb9901266, 0x3a21817b, + 0x3a21817b, 0x3a21817b, 0x3a21817b, 0x3a21817b, 0xb9e9e7a9, 0xb9e9e7a9, 0xb9e9e7a9, 0xb9e9e7a9, + 0xb9e9e7a9, 0x39e92db5, 0x39e92db5, 0x39e92db5, 0x39e92db5, 0x39e92db5, 0xba21de76, 0xba21de76, + 0xba21de76, 0xba21de76, 0xba21de76, 0x398f5872, 0x398f5872, 0x398f5872, 0x398f5872, 0x398f5872, + 0xba4ec916, 0xba4ec916, 0xba4ec916, 0xba4ec916, 0xba4ec916, 0x38d60cbb, 0x38d60cbb, 0x38d60cbb, + 0x38d60cbb, 0x38d60cbb, 0xba7bb3b7, 0xba7bb3b7, 0xba7bb3b7, 0xba7bb3b7, 0xba7bb3b7, 0xb8914852, + 0xb8914852, 0xb8914852, 0xb8914852, 0xb8914852, 0x3a5761a3, 0x3a5761a3, 0x3a5761a3, 0x3a5761a3, + 0x3a5761a3, 0xb97c4eaf, 0xb97c4eaf, 0xb97c4eaf, 0xb97c4eaf, 0xb97c4eaf, 0x3a2a7702, 0x3a2a7702, + 0x3a2a7702, 0x3a2a7702, 0x3a2a7702, 0xb9d7fc9b, 0xb9d7fc9b, 0xb9d7fc9b, 0xb9d7fc9b, 0xb9d7fc9b, + 0x39fb18c3, 0x39fb18c3, 0x39fb18c3, 0x39fb18c3, 0x39fb18c3, 0xba18e8ef, 0xba18e8ef, 0xba18e8ef, + 0xba18e8ef, 0xba18e8ef, 0x39a14380, 0x39a14380, 0x39a14380, 0x39a14380, 0x39a14380, 0xba45d390, + 0xba45d390, 0xba45d390, 0xba45d390, 0xba45d390, 0x390edc7a, 0x390edc7a, 0x390edc7a, 0x390edc7a, + 0x390edc7a, 0xba72be30, 0xba72be30, 0xba72be30, 0xba72be30, 0xba72be30, 0xb8133833, 0xb8133833, +] )) ), + +################ chunk 1024 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x46fccccf, 0x46fccccf, 0x46fccccf, 0x46ff4121, 0x46ff4121, 0x46ff4121, 0x46ff4121, 0x46ff4121, + 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x470214e2, 0x470214e2, 0x470214e2, + 0x470214e2, 0x470214e2, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47048933, + 0x47048933, 0x47048933, 0x47048933, 0x47048933, 0x4705c35c, 0x4705c35c, 0x4705c35c, 0x4705c35c, + 0x4705c35c, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x470837ae, 0x470837ae, + 0x470837ae, 0x470837ae, 0x470837ae, 0x470971d6, 0x470971d6, 0x470971d6, 0x470971d6, 0x470971d6, + 0x470aabff, 0x470aabff, 0x470aabff, 0x470aabff, 0x470aabff, 0x470be628, 0x470be628, 0x470be628, + 0x470be628, 0x470be628, 0x470d2051, 0x470d2051, 0x470d2051, 0x470d2051, 0x470d2051, 0x470e5a7a, + 0x470e5a7a, 0x470e5a7a, 0x470e5a7a, 0x470e5a7a, 0x470f94a2, 0x470f94a2, 0x470f94a2, 0x470f94a2, + 0x470f94a2, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x471208f4, 0x471208f4, + 0x471208f4, 0x471208f4, 0x471208f4, 0x4713431d, 0x4713431d, 0x4713431d, 0x4713431d, 0x4713431d, + 0x47147d45, 0x47147d45, 0x47147d45, 0x47147d45, 0x47147d45, 0x4715b76e, 0x4715b76e, 0x4715b76e, + 0x4715b76e, 0x4715b76e, 0x4716f197, 0x4716f197, 0x4716f197, 0x4716f197, 0x4716f197, 0x47182bc0, + 0x47182bc0, 0x47182bc0, 0x47182bc0, 0x47182bc0, 0x471965e8, 0x471965e8, 0x471965e8, 0x471965e8, + 0x471965e8, 0x471aa011, 0x471aa011, 0x471aa011, 0x471aa011, 0x471aa011, 0x471bda3a, 0x471bda3a, + 0x471bda3a, 0x471bda3a, 0x471bda3a, 0x471d1463, 0x471d1463, 0x471d1463, 0x471d1463, 0x471d1463, + 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471f88b4, 0x471f88b4, 0x471f88b4, + 0x471f88b4, 0x471f88b4, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4721fd06, + 0x4721fd06, 0x4721fd06, 0x4721fd06, 0x4721fd06, 0x4723372f, 0x4723372f, 0x4723372f, 0x4723372f, + 0x4723372f, 0x47247157, 0x47247157, 0x47247157, 0x47247157, 0x47247157, 0x4725ab80, 0x4725ab80, + 0x4725ab80, 0x4725ab80, 0x4725ab80, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, + 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x472959fb, 0x472959fb, 0x472959fb, + 0x472959fb, 0x472959fb, 0x472a9423, 0x472a9423, 0x472a9423, 0x472a9423, 0x472a9423, 0x472bce4c, + 0x472bce4c, 0x472bce4c, 0x472bce4c, 0x472bce4c, 0x472d0875, 0x472d0875, 0x472d0875, 0x472d0875, + 0x472d0875, 0x472e429e, 0x472e429e, 0x472e429e, 0x472e429e, 0x472e429e, 0x472f7cc6, 0x472f7cc6, + 0x472f7cc6, 0x472f7cc6, 0x472f7cc6, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, + 0x4731f118, 0x4731f118, 0x4731f118, 0x4731f118, 0x4731f118, 0x47332b41, 0x47332b41, 0x47332b41, + 0x47332b41, 0x47332b41, 0x47346569, 0x47346569, 0x47346569, 0x47346569, 0x47346569, 0x47359f92, + 0x47359f92, 0x47359f92, 0x47359f92, 0x47359f92, 0x4736d9bb, 0x4736d9bb, 0x4736d9bb, 0x4736d9bb, + 0x4736d9bb, 0x473813e4, 0x473813e4, 0x473813e4, 0x473813e4, 0x473813e4, 0x47394e0d, 0x47394e0d, + 0x47394e0d, 0x47394e0d, 0x47394e0d, 0x473a8835, 0x473a8835, 0x473a8835, 0x473a8835, 0x473a8835, + 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473cfc87, 0x473cfc87, 0x473cfc87, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xb8133833, 0xb8133833, 0xb8133833, 0x3a60572a, 0x3a60572a, 0x3a60572a, 0x3a60572a, 0x3a60572a, + 0xb9587893, 0xb9587893, 0xb9587893, 0xb9587893, 0xb9587893, 0x3a336c89, 0x3a336c89, 0x3a336c89, + 0x3a336c89, 0x3a336c89, 0x3ace7b97, 0x3ace7b97, 0x3ace7b97, 0x3ace7b97, 0x3ace7b97, 0xbabcbf07, + 0xbabcbf07, 0xbabcbf07, 0xbabcbf07, 0xbabcbf07, 0xba0ff368, 0xba0ff368, 0xba0ff368, 0xba0ff368, + 0xba0ff368, 0x39b32e8e, 0x39b32e8e, 0x39b32e8e, 0x39b32e8e, 0x39b32e8e, 0x3aa190f8, 0x3aa190f8, + 0x3aa190f8, 0x3aa190f8, 0x3aa190f8, 0xbae9a9a5, 0xbae9a9a5, 0xbae9a9a5, 0xbae9a9a5, 0xbae9a9a5, + 0xba69c8a9, 0xba69c8a9, 0xba69c8a9, 0xba69c8a9, 0xba69c8a9, 0xb577f042, 0xb577f042, 0xb577f042, + 0xb577f042, 0xb577f042, 0x3a694cb1, 0x3a694cb1, 0x3a694cb1, 0x3a694cb1, 0x3a694cb1, 0x3ae96ba9, + 0x3ae96ba9, 0x3ae96ba9, 0x3ae96ba9, 0x3ae96ba9, 0xbaa1cef5, 0xbaa1cef5, 0xbaa1cef5, 0xbaa1cef5, + 0xbaa1cef5, 0xb9b4267e, 0xb9b4267e, 0xb9b4267e, 0xb9b4267e, 0xb9b4267e, 0x3a0f776f, 0x3a0f776f, + 0x3a0f776f, 0x3a0f776f, 0x3a0f776f, 0x3abc810b, 0x3abc810b, 0x3abc810b, 0x3abc810b, 0x3abc810b, + 0xbaceb993, 0xbaceb993, 0xbaceb993, 0xbaceb993, 0xbaceb993, 0xba33e882, 0xba33e882, 0xba33e882, + 0xba33e882, 0xba33e882, 0x395688b3, 0x395688b3, 0x395688b3, 0x395688b3, 0x395688b3, 0x3a8f966c, + 0x3a8f966c, 0x3a8f966c, 0x3a8f966c, 0x3a8f966c, 0xbafba430, 0xbafba430, 0xbafba430, 0xbafba430, + 0xbafba430, 0xba86dee1, 0xba86dee1, 0xba86dee1, 0xba86dee1, 0xba86dee1, 0xb910cc5a, 0xb910cc5a, + 0xb910cc5a, 0xb910cc5a, 0xb910cc5a, 0x3a455797, 0x3a455797, 0x3a455797, 0x3a455797, 0x3a455797, + 0x3ad7711e, 0x3ad7711e, 0x3ad7711e, 0x3ad7711e, 0x3ad7711e, 0xbab3c981, 0xbab3c981, 0xbab3c981, + 0xbab3c981, 0xbab3c981, 0xb9fc10b3, 0xb9fc10b3, 0xb9fc10b3, 0xb9fc10b3, 0xb9fc10b3, 0x39d704aa, + 0x39d704aa, 0x39d704aa, 0x39d704aa, 0x39d704aa, 0x3aaa867f, 0x3aaa867f, 0x3aaa867f, 0x3aaa867f, + 0x3aaa867f, 0xbae0b41f, 0xbae0b41f, 0xbae0b41f, 0xbae0b41f, 0xbae0b41f, 0xba57dd9b, 0xba57dd9b, + 0xba57dd9b, 0xba57dd9b, 0xba57dd9b, 0x388d6891, 0x388d6891, 0x388d6891, 0x388d6891, 0x388d6891, + 0x3a7b37bf, 0x3a7b37bf, 0x3a7b37bf, 0x3a7b37bf, 0x3a7b37bf, 0x3af2612f, 0x3af2612f, 0x3af2612f, + 0x3af2612f, 0x3af2612f, 0xba98d96e, 0xba98d96e, 0xba98d96e, 0xba98d96e, 0xba98d96e, 0xb9905062, + 0xb9905062, 0xb9905062, 0xb9905062, 0xb9905062, 0x3a21627d, 0x3a21627d, 0x3a21627d, 0x3a21627d, + 0x3a21627d, 0x3ac57692, 0x3ac57692, 0x3ac57692, 0x3ac57692, 0x3ac57692, 0xbac5c40d, 0xbac5c40d, + 0xbac5c40d, 0xbac5c40d, 0xbac5c40d, 0xba21fd74, 0xba21fd74, 0xba21fd74, 0xba21fd74, 0xba21fd74, + 0x398f1a76, 0x398f1a76, 0x398f1a76, 0x398f1a76, 0x398f1a76, 0x3a988bf3, 0x3a988bf3, 0x3a988bf3, + 0x3a988bf3, 0x3a988bf3, 0xbaf2aeaa, 0xbaf2aeaa, 0xbaf2aeaa, 0xbaf2aeaa, 0xbaf2aeaa, 0xba7bd2b5, + 0xba7bd2b5, 0xba7bd2b5, 0xba7bd2b5, 0xba7bd2b5, 0xb8924043, 0xb8924043, 0xb8924043, 0xb8924043, + 0xb8924043, 0x3a5742a5, 0x3a5742a5, 0x3a5742a5, 0x3a5742a5, 0x3a5742a5, 0x3ae066a4, 0x3ae066a4, + 0x3ae066a4, 0x3ae066a4, 0x3ae066a4, 0xbaaad3fa, 0xbaaad3fa, 0xbaaad3fa, 0xbaaad3fa, 0xbaaad3fa, + 0xb9d83a97, 0xb9d83a97, 0xb9d83a97, 0xb9d83a97, 0xb9d83a97, 0x39fadac7, 0x39fadac7, 0x39fadac7, +] )) ), + +################ chunk 1536 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x473cfc87, 0x473cfc87, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473f70d8, + 0x473f70d8, 0x473f70d8, 0x473f70d8, 0x473f70d8, 0x4740ab01, 0x4740ab01, 0x4740ab01, 0x4740ab01, + 0x4740ab01, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x47431f53, 0x47431f53, + 0x47431f53, 0x47431f53, 0x47431f53, 0x4744597c, 0x4744597c, 0x4744597c, 0x4744597c, 0x4744597c, + 0x474593a4, 0x474593a4, 0x474593a4, 0x474593a4, 0x474593a4, 0x4746cdcd, 0x4746cdcd, 0x4746cdcd, + 0x4746cdcd, 0x4746cdcd, 0x474807f6, 0x474807f6, 0x474807f6, 0x474807f6, 0x474807f6, 0x4749421f, + 0x4749421f, 0x4749421f, 0x4749421f, 0x4749421f, 0x474a7c47, 0x474a7c47, 0x474a7c47, 0x474a7c47, + 0x474a7c47, 0x474bb670, 0x474bb670, 0x474bb670, 0x474bb670, 0x474bb670, 0x474cf099, 0x474cf099, + 0x474cf099, 0x474cf099, 0x474cf099, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, + 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x47509f13, 0x47509f13, 0x47509f13, + 0x47509f13, 0x47509f13, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x47531365, + 0x47531365, 0x47531365, 0x47531365, 0x47531365, 0x47544d8e, 0x47544d8e, 0x47544d8e, 0x47544d8e, + 0x47544d8e, 0x475587b6, 0x475587b6, 0x475587b6, 0x475587b6, 0x475587b6, 0x4756c1df, 0x4756c1df, + 0x4756c1df, 0x4756c1df, 0x4756c1df, 0x4757fc08, 0x4757fc08, 0x4757fc08, 0x4757fc08, 0x4757fc08, + 0x47593631, 0x47593631, 0x47593631, 0x47593631, 0x47593631, 0x475a7059, 0x475a7059, 0x475a7059, + 0x475a7059, 0x475a7059, 0x475baa82, 0x475baa82, 0x475baa82, 0x475baa82, 0x475baa82, 0x475ce4ab, + 0x475ce4ab, 0x475ce4ab, 0x475ce4ab, 0x475ce4ab, 0x475e1ed4, 0x475e1ed4, 0x475e1ed4, 0x475e1ed4, + 0x475e1ed4, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x47609325, 0x47609325, + 0x47609325, 0x47609325, 0x47609325, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, + 0x47630777, 0x47630777, 0x47630777, 0x47630777, 0x47630777, 0x476441a0, 0x476441a0, 0x476441a0, + 0x476441a0, 0x476441a0, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x4766b5f1, + 0x4766b5f1, 0x4766b5f1, 0x4766b5f1, 0x4766b5f1, 0x4767f01a, 0x4767f01a, 0x4767f01a, 0x4767f01a, + 0x4767f01a, 0x47692a43, 0x47692a43, 0x47692a43, 0x47692a43, 0x47692a43, 0x476a646b, 0x476a646b, + 0x476a646b, 0x476a646b, 0x476a646b, 0x476b9e94, 0x476b9e94, 0x476b9e94, 0x476b9e94, 0x476b9e94, + 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476e12e6, 0x476e12e6, 0x476e12e6, + 0x476e12e6, 0x476e12e6, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x47708737, + 0x47708737, 0x47708737, 0x47708737, 0x47708737, 0x4771c160, 0x4771c160, 0x4771c160, 0x4771c160, + 0x4771c160, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x477435b2, 0x477435b2, + 0x477435b2, 0x477435b2, 0x477435b2, 0x47756fda, 0x47756fda, 0x47756fda, 0x47756fda, 0x47756fda, + 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4777e42c, 0x4777e42c, 0x4777e42c, + 0x4777e42c, 0x4777e42c, 0x47791e55, 0x47791e55, 0x47791e55, 0x47791e55, 0x47791e55, 0x477a587d, + 0x477a587d, 0x477a587d, 0x477a587d, 0x477a587d, 0x477b92a6, 0x477b92a6, 0x477b92a6, 0x477b92a6, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x39fadac7, 0x39fadac7, 0x3ab37c06, 0x3ab37c06, 0x3ab37c06, 0x3ab37c06, 0x3ab37c06, 0xbad7be99, + 0xbad7be99, 0xbad7be99, 0xbad7be99, 0xbad7be99, 0xba45f28e, 0xba45f28e, 0xba45f28e, 0xba45f28e, + 0xba45f28e, 0x390e6082, 0x390e6082, 0x390e6082, 0x390e6082, 0x390e6082, 0x3a869166, 0x3a869166, + 0x3a869166, 0x3a869166, 0x3a869166, 0x3afb56b5, 0x3afb56b5, 0x3afb56b5, 0x3afb56b5, 0x3afb56b5, + 0xba8fe3e7, 0xba8fe3e7, 0xba8fe3e7, 0xba8fe3e7, 0xba8fe3e7, 0xb958f48b, 0xb958f48b, 0xb958f48b, + 0xb958f48b, 0xb958f48b, 0x3a334d8b, 0x3a334d8b, 0x3a334d8b, 0x3a334d8b, 0x3a334d8b, 0x3ace6c18, + 0x3ace6c18, 0x3ace6c18, 0x3ace6c18, 0x3ace6c18, 0xbabcce86, 0xbabcce86, 0xbabcce86, 0xbabcce86, + 0xbabcce86, 0xba101266, 0xba101266, 0xba101266, 0xba101266, 0xba101266, 0x39b2f092, 0x39b2f092, + 0x39b2f092, 0x39b2f092, 0x39b2f092, 0x3aa18179, 0x3aa18179, 0x3aa18179, 0x3aa18179, 0x3aa18179, + 0xbae9b924, 0xbae9b924, 0xbae9b924, 0xbae9b924, 0xbae9b924, 0xba69e7a7, 0xba69e7a7, 0xba69e7a7, + 0xba69e7a7, 0xba69e7a7, 0xb5b9f432, 0xb5b9f432, 0xb5b9f432, 0xb5b9f432, 0xb5b9f432, 0x3a692db3, + 0x3a692db3, 0x3a692db3, 0x3a692db3, 0x3a692db3, 0x3ae95c2a, 0x3ae95c2a, 0x3ae95c2a, 0x3ae95c2a, + 0x3ae95c2a, 0xbaa1de74, 0xbaa1de74, 0xbaa1de74, 0xbaa1de74, 0xbaa1de74, 0xb9b4647a, 0xb9b4647a, + 0xb9b4647a, 0xb9b4647a, 0xb9b4647a, 0x3a0f5871, 0x3a0f5871, 0x3a0f5871, 0x3a0f5871, 0x3a0f5871, + 0x3abc718c, 0x3abc718c, 0x3abc718c, 0x3abc718c, 0x3abc718c, 0xbacec912, 0xbacec912, 0xbacec912, + 0xbacec912, 0xbacec912, 0xba340780, 0xba340780, 0xba340780, 0xba340780, 0xba340780, 0x39560cba, + 0x39560cba, 0x39560cba, 0x39560cba, 0x39560cba, 0x3a8f86ed, 0x3a8f86ed, 0x3a8f86ed, 0x3a8f86ed, + 0x3a8f86ed, 0xbafbb3af, 0xbafbb3af, 0xbafbb3af, 0xbafbb3af, 0xbafbb3af, 0xba86ee60, 0xba86ee60, + 0xba86ee60, 0xba86ee60, 0xba86ee60, 0xb9114852, 0xb9114852, 0xb9114852, 0xb9114852, 0xb9114852, + 0x3a453899, 0x3a453899, 0x3a453899, 0x3a453899, 0x3a453899, 0x3ad7619f, 0x3ad7619f, 0x3ad7619f, + 0x3ad7619f, 0x3ad7619f, 0xbab3d900, 0xbab3d900, 0xbab3d900, 0xbab3d900, 0xbab3d900, 0xb9fc4eaf, + 0xb9fc4eaf, 0xb9fc4eaf, 0xb9fc4eaf, 0xb9fc4eaf, 0x39d6c6ae, 0x39d6c6ae, 0x39d6c6ae, 0x39d6c6ae, + 0x39d6c6ae, 0x3aaa7700, 0x3aaa7700, 0x3aaa7700, 0x3aaa7700, 0x3aaa7700, 0xbae0c39e, 0xbae0c39e, + 0xbae0c39e, 0xbae0c39e, 0xbae0c39e, 0xba57fc99, 0xba57fc99, 0xba57fc99, 0xba57fc99, 0xba57fc99, + 0x388c70a1, 0x388c70a1, 0x388c70a1, 0x388c70a1, 0x388c70a1, 0x3a7b18c1, 0x3a7b18c1, 0x3a7b18c1, + 0x3a7b18c1, 0x3a7b18c1, 0x3af251b0, 0x3af251b0, 0x3af251b0, 0x3af251b0, 0x3af251b0, 0xba98e8ed, + 0xba98e8ed, 0xba98e8ed, 0xba98e8ed, 0xba98e8ed, 0xb9908e5e, 0xb9908e5e, 0xb9908e5e, 0xb9908e5e, + 0xb9908e5e, 0x3a21437f, 0x3a21437f, 0x3a21437f, 0x3a21437f, 0x3a21437f, 0x3ac56713, 0x3ac56713, + 0x3ac56713, 0x3ac56713, 0x3ac56713, 0xbac5d38c, 0xbac5d38c, 0xbac5d38c, 0xbac5d38c, 0xbac5d38c, + 0xba221c72, 0xba221c72, 0xba221c72, 0xba221c72, 0xba221c72, 0x398edc7a, 0x398edc7a, 0x398edc7a, + 0x398edc7a, 0x398edc7a, 0x3a987c74, 0x3a987c74, 0x3a987c74, 0x3a987c74, 0x3a987c74, 0xbaf2be29, + 0xbaf2be29, 0xbaf2be29, 0xbaf2be29, 0xbaf2be29, 0xba7bf1b3, 0xba7bf1b3, 0xba7bf1b3, 0xba7bf1b3, +] )) ), + +################ chunk 2048 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x477b92a6, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477e06f8, 0x477e06f8, + 0x477e06f8, 0x477e06f8, 0x477e06f8, 0x477f4121, 0x477f4121, 0x477f4121, 0x477f4121, 0x477f4121, + 0x47803da5, 0x47803da5, 0x47803da5, 0x47803da5, 0x47803da5, 0x4780dab9, 0x4780dab9, 0x4780dab9, + 0x4780dab9, 0x4780dab9, 0x478177cd, 0x478177cd, 0x478177cd, 0x478177cd, 0x478177cd, 0x478214e2, + 0x478214e2, 0x478214e2, 0x478214e2, 0x478214e2, 0x4782b1f6, 0x4782b1f6, 0x4782b1f6, 0x4782b1f6, + 0x4782b1f6, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x4783ec1f, 0x4783ec1f, + 0x4783ec1f, 0x4783ec1f, 0x4783ec1f, 0x47848933, 0x47848933, 0x47848933, 0x47848933, 0x47848933, + 0x47852648, 0x47852648, 0x47852648, 0x47852648, 0x47852648, 0x4785c35c, 0x4785c35c, 0x4785c35c, + 0x4785c35c, 0x4785c35c, 0x47866071, 0x47866071, 0x47866071, 0x47866071, 0x47866071, 0x4786fd85, + 0x4786fd85, 0x4786fd85, 0x4786fd85, 0x4786fd85, 0x47879a99, 0x47879a99, 0x47879a99, 0x47879a99, + 0x47879a99, 0x478837ae, 0x478837ae, 0x478837ae, 0x478837ae, 0x478837ae, 0x4788d4c2, 0x4788d4c2, + 0x4788d4c2, 0x4788d4c2, 0x4788d4c2, 0x478971d6, 0x478971d6, 0x478971d6, 0x478971d6, 0x478971d6, + 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478aabff, 0x478aabff, 0x478aabff, + 0x478aabff, 0x478aabff, 0x478b4914, 0x478b4914, 0x478b4914, 0x478b4914, 0x478b4914, 0x478be628, + 0x478be628, 0x478be628, 0x478be628, 0x478be628, 0x478c833c, 0x478c833c, 0x478c833c, 0x478c833c, + 0x478c833c, 0x478d2051, 0x478d2051, 0x478d2051, 0x478d2051, 0x478d2051, 0x478dbd65, 0x478dbd65, + 0x478dbd65, 0x478dbd65, 0x478dbd65, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, + 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478f94a2, 0x478f94a2, 0x478f94a2, + 0x478f94a2, 0x478f94a2, 0x479031b7, 0x479031b7, 0x479031b7, 0x479031b7, 0x479031b7, 0x4790cecb, + 0x4790cecb, 0x4790cecb, 0x4790cecb, 0x4790cecb, 0x47916bdf, 0x47916bdf, 0x47916bdf, 0x47916bdf, + 0x47916bdf, 0x479208f4, 0x479208f4, 0x479208f4, 0x479208f4, 0x479208f4, 0x4792a608, 0x4792a608, + 0x4792a608, 0x4792a608, 0x4792a608, 0x4793431d, 0x4793431d, 0x4793431d, 0x4793431d, 0x4793431d, + 0x4793e031, 0x4793e031, 0x4793e031, 0x4793e031, 0x4793e031, 0x47947d45, 0x47947d45, 0x47947d45, + 0x47947d45, 0x47947d45, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x4795b76e, + 0x4795b76e, 0x4795b76e, 0x4795b76e, 0x4795b76e, 0x47965483, 0x47965483, 0x47965483, 0x47965483, + 0x47965483, 0x4796f197, 0x4796f197, 0x4796f197, 0x4796f197, 0x4796f197, 0x47978eab, 0x47978eab, + 0x47978eab, 0x47978eab, 0x47978eab, 0x47982bc0, 0x47982bc0, 0x47982bc0, 0x47982bc0, 0x47982bc0, + 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x479965e8, 0x479965e8, 0x479965e8, + 0x479965e8, 0x479965e8, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479aa011, + 0x479aa011, 0x479aa011, 0x479aa011, 0x479aa011, 0x479b3d26, 0x479b3d26, 0x479b3d26, 0x479b3d26, + 0x479b3d26, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479c774e, 0x479c774e, + 0x479c774e, 0x479c774e, 0x479c774e, 0x479d1463, 0x479d1463, 0x479d1463, 0x479d1463, 0x479d1463, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xba7bf1b3, 0xb8933833, 0xb8933833, 0xb8933833, 0xb8933833, 0xb8933833, 0x3a5723a7, 0x3a5723a7, + 0x3a5723a7, 0x3a5723a7, 0x3a5723a7, 0x3ae05725, 0x3ae05725, 0x3ae05725, 0x3ae05725, 0x3ae05725, + 0x3b2a8e35, 0x3b2a8e35, 0x3b2a8e35, 0x3b2a8e35, 0x3b2a8e35, 0xb9d87893, 0xb9d87893, 0xb9d87893, + 0xb9d87893, 0xb9d87893, 0xbb60ac4a, 0xbb60ac4a, 0xbb60ac4a, 0xbb60ac4a, 0xbb60ac4a, 0x3ab36c87, + 0x3ab36c87, 0x3ab36c87, 0x3ab36c87, 0x3ab36c87, 0xbad7ce18, 0xbad7ce18, 0xbad7ce18, 0xbad7ce18, + 0xbad7ce18, 0x3b4e7b86, 0x3b4e7b86, 0x3b4e7b86, 0x3b4e7b86, 0x3b4e7b86, 0x390de489, 0x390de489, + 0x390de489, 0x390de489, 0x390de489, 0xbb3cbefb, 0xbb3cbefb, 0xbb3cbefb, 0xbb3cbefb, 0xbb3cbefb, + 0x3afb4736, 0x3afb4736, 0x3afb4736, 0x3afb4736, 0x3afb4736, 0xba8ff366, 0xba8ff366, 0xba8ff366, + 0xba8ff366, 0xba8ff366, 0x3b7268d4, 0x3b7268d4, 0x3b7268d4, 0x3b7268d4, 0x3b7268d4, 0x3a332e8d, + 0x3a332e8d, 0x3a332e8d, 0x3a332e8d, 0x3a332e8d, 0xbb18d1a8, 0xbb18d1a8, 0xbb18d1a8, 0xbb18d1a8, + 0xbb18d1a8, 0x3b2190f0, 0x3b2190f0, 0x3b2190f0, 0x3b2190f0, 0x3b2190f0, 0xba103164, 0xba103164, + 0xba103164, 0xba103164, 0xba103164, 0xbb69a98d, 0xbb69a98d, 0xbb69a98d, 0xbb69a98d, 0xbb69a98d, + 0x3aa171fa, 0x3aa171fa, 0x3aa171fa, 0x3aa171fa, 0x3aa171fa, 0xbae9c8a3, 0xbae9c8a3, 0xbae9c8a3, + 0xbae9c8a3, 0xbae9c8a3, 0x3b457e43, 0x3b457e43, 0x3b457e43, 0x3b457e43, 0x3b457e43, 0xb5f7f042, + 0xb5f7f042, 0xb5f7f042, 0xb5f7f042, 0xb5f7f042, 0xbb45bc3f, 0xbb45bc3f, 0xbb45bc3f, 0xbb45bc3f, + 0xbb45bc3f, 0x3ae94cab, 0x3ae94cab, 0x3ae94cab, 0x3ae94cab, 0x3ae94cab, 0xbaa1edf3, 0xbaa1edf3, + 0xbaa1edf3, 0xbaa1edf3, 0xbaa1edf3, 0x3b696b91, 0x3b696b91, 0x3b696b91, 0x3b696b91, 0x3b696b91, + 0x3a0f3973, 0x3a0f3973, 0x3a0f3973, 0x3a0f3973, 0x3a0f3973, 0xbb21ceec, 0xbb21ceec, 0xbb21ceec, + 0xbb21ceec, 0xbb21ceec, 0x3b1893ac, 0x3b1893ac, 0x3b1893ac, 0x3b1893ac, 0x3b1893ac, 0xba34267e, + 0xba34267e, 0xba34267e, 0xba34267e, 0xba34267e, 0xbb72a6d0, 0xbb72a6d0, 0xbb72a6d0, 0xbb72a6d0, + 0xbb72a6d0, 0x3a8f776e, 0x3a8f776e, 0x3a8f776e, 0x3a8f776e, 0x3a8f776e, 0xbafbc32e, 0xbafbc32e, + 0xbafbc32e, 0xbafbc32e, 0xbafbc32e, 0x3b3c80ff, 0x3b3c80ff, 0x3b3c80ff, 0x3b3c80ff, 0x3b3c80ff, + 0xb911c44a, 0xb911c44a, 0xb911c44a, 0xb911c44a, 0xb911c44a, 0xbb4eb982, 0xbb4eb982, 0xbb4eb982, + 0xbb4eb982, 0xbb4eb982, 0x3ad75220, 0x3ad75220, 0x3ad75220, 0x3ad75220, 0x3ad75220, 0xbab3e87f, + 0xbab3e87f, 0xbab3e87f, 0xbab3e87f, 0xbab3e87f, 0x3b606e4e, 0x3b606e4e, 0x3b606e4e, 0x3b606e4e, + 0x3b606e4e, 0x39d688b2, 0x39d688b2, 0x39d688b2, 0x39d688b2, 0x39d688b2, 0xbb2acc31, 0xbb2acc31, + 0xbb2acc31, 0xbb2acc31, 0xbb2acc31, 0x3b0f9666, 0x3b0f9666, 0x3b0f9666, 0x3b0f9666, 0x3b0f9666, + 0xba581b97, 0xba581b97, 0xba581b97, 0xba581b97, 0xba581b97, 0xbb7ba412, 0xbb7ba412, 0xbb7ba412, + 0xbb7ba412, 0xbb7ba412, 0x3a7af9c3, 0x3a7af9c3, 0x3a7af9c3, 0x3a7af9c3, 0x3a7af9c3, 0xbb06dedd, + 0xbb06dedd, 0xbb06dedd, 0xbb06dedd, 0xbb06dedd, 0x3b3383ba, 0x3b3383ba, 0x3b3383ba, 0x3b3383ba, + 0x3b3383ba, 0xb990cc5a, 0xb990cc5a, 0xb990cc5a, 0xb990cc5a, 0xb990cc5a, 0xbb57b6c6, 0xbb57b6c6, + 0xbb57b6c6, 0xbb57b6c6, 0xbb57b6c6, 0x3ac55794, 0x3ac55794, 0x3ac55794, 0x3ac55794, 0x3ac55794, +] )) ), + +################ chunk 2560 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x479db177, 0x479db177, 0x479db177, 0x479db177, 0x479db177, 0x479e4e8c, 0x479e4e8c, 0x479e4e8c, + 0x479e4e8c, 0x479e4e8c, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479f88b4, + 0x479f88b4, 0x479f88b4, 0x479f88b4, 0x479f88b4, 0x47a025c9, 0x47a025c9, 0x47a025c9, 0x47a025c9, + 0x47a025c9, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a15ff2, 0x47a15ff2, + 0x47a15ff2, 0x47a15ff2, 0x47a15ff2, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, + 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a3372f, 0x47a3372f, 0x47a3372f, + 0x47a3372f, 0x47a3372f, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a47157, + 0x47a47157, 0x47a47157, 0x47a47157, 0x47a47157, 0x47a50e6c, 0x47a50e6c, 0x47a50e6c, 0x47a50e6c, + 0x47a50e6c, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a64895, 0x47a64895, + 0x47a64895, 0x47a64895, 0x47a64895, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, + 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a81fd2, 0x47a81fd2, 0x47a81fd2, + 0x47a81fd2, 0x47a81fd2, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a959fb, + 0x47a959fb, 0x47a959fb, 0x47a959fb, 0x47a959fb, 0x47a9f70f, 0x47a9f70f, 0x47a9f70f, 0x47a9f70f, + 0x47a9f70f, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47ab3138, 0x47ab3138, + 0x47ab3138, 0x47ab3138, 0x47ab3138, 0x47abce4c, 0x47abce4c, 0x47abce4c, 0x47abce4c, 0x47abce4c, + 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ad0875, 0x47ad0875, 0x47ad0875, + 0x47ad0875, 0x47ad0875, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ae429e, + 0x47ae429e, 0x47ae429e, 0x47ae429e, 0x47ae429e, 0x47aedfb2, 0x47aedfb2, 0x47aedfb2, 0x47aedfb2, + 0x47aedfb2, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47b019db, 0x47b019db, + 0x47b019db, 0x47b019db, 0x47b019db, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, + 0x47b15404, 0x47b15404, 0x47b15404, 0x47b15404, 0x47b15404, 0x47b1f118, 0x47b1f118, 0x47b1f118, + 0x47b1f118, 0x47b1f118, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b32b41, + 0x47b32b41, 0x47b32b41, 0x47b32b41, 0x47b32b41, 0x47b3c855, 0x47b3c855, 0x47b3c855, 0x47b3c855, + 0x47b3c855, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b5027e, 0x47b5027e, + 0x47b5027e, 0x47b5027e, 0x47b5027e, 0x47b59f92, 0x47b59f92, 0x47b59f92, 0x47b59f92, 0x47b59f92, + 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b6d9bb, 0x47b6d9bb, 0x47b6d9bb, + 0x47b6d9bb, 0x47b6d9bb, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b813e4, + 0x47b813e4, 0x47b813e4, 0x47b813e4, 0x47b813e4, 0x47b8b0f8, 0x47b8b0f8, 0x47b8b0f8, 0x47b8b0f8, + 0x47b8b0f8, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b9eb21, 0x47b9eb21, + 0x47b9eb21, 0x47b9eb21, 0x47b9eb21, 0x47ba8835, 0x47ba8835, 0x47ba8835, 0x47ba8835, 0x47ba8835, + 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bbc25e, 0x47bbc25e, 0x47bbc25e, + 0x47bbc25e, 0x47bbc25e, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bcfc87, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbac5e30b, 0xbac5e30b, 0xbac5e30b, 0xbac5e30b, 0xbac5e30b, 0x3b57710a, 0x3b57710a, 0x3b57710a, + 0x3b57710a, 0x3b57710a, 0x398e9e7e, 0x398e9e7e, 0x398e9e7e, 0x398e9e7e, 0x398e9e7e, 0xbb33c976, + 0xbb33c976, 0xbb33c976, 0xbb33c976, 0xbb33c976, 0x3b069921, 0x3b069921, 0x3b069921, 0x3b069921, + 0x3b069921, 0xba7c10b1, 0xba7c10b1, 0xba7c10b1, 0xba7c10b1, 0xba7c10b1, 0x3b7b5e57, 0x3b7b5e57, + 0x3b7b5e57, 0x3b7b5e57, 0x3b7b5e57, 0x3a5704a9, 0x3a5704a9, 0x3a5704a9, 0x3a5704a9, 0x3a5704a9, + 0xbb0fdc22, 0xbb0fdc22, 0xbb0fdc22, 0xbb0fdc22, 0xbb0fdc22, 0x3b2a8676, 0x3b2a8676, 0x3b2a8676, + 0x3b2a8676, 0x3b2a8676, 0xb9d8b68f, 0xb9d8b68f, 0xb9d8b68f, 0xb9d8b68f, 0xb9d8b68f, 0xbb60b409, + 0xbb60b409, 0xbb60b409, 0xbb60b409, 0xbb60b409, 0x3ab35d08, 0x3ab35d08, 0x3ab35d08, 0x3ab35d08, + 0x3ab35d08, 0xbad7dd97, 0xbad7dd97, 0xbad7dd97, 0xbad7dd97, 0xbad7dd97, 0x3b4e73c7, 0x3b4e73c7, + 0x3b4e73c7, 0x3b4e73c7, 0x3b4e73c7, 0x390d6891, 0x390d6891, 0x390d6891, 0x390d6891, 0x390d6891, + 0xbb3cc6ba, 0xbb3cc6ba, 0xbb3cc6ba, 0xbb3cc6ba, 0xbb3cc6ba, 0x3afb37b7, 0x3afb37b7, 0x3afb37b7, + 0x3afb37b7, 0x3afb37b7, 0xba9002e5, 0xba9002e5, 0xba9002e5, 0xba9002e5, 0xba9002e5, 0x3b726114, + 0x3b726114, 0x3b726114, 0x3b726114, 0x3b726114, 0x3a330f8f, 0x3a330f8f, 0x3a330f8f, 0x3a330f8f, + 0x3a330f8f, 0xbb18d967, 0xbb18d967, 0xbb18d967, 0xbb18d967, 0xbb18d967, 0x3b218931, 0x3b218931, + 0x3b218931, 0x3b218931, 0x3b218931, 0xba105062, 0xba105062, 0xba105062, 0xba105062, 0xba105062, + 0xbb69b14c, 0xbb69b14c, 0xbb69b14c, 0xbb69b14c, 0xbb69b14c, 0x3aa1627b, 0x3aa1627b, 0x3aa1627b, + 0x3aa1627b, 0x3aa1627b, 0xbae9d822, 0xbae9d822, 0xbae9d822, 0xbae9d822, 0xbae9d822, 0x3b457683, + 0x3b457683, 0x3b457683, 0x3b457683, 0x3b457683, 0xb61af629, 0xb61af629, 0xb61af629, 0xb61af629, + 0xb61af629, 0xbb45c3fe, 0xbb45c3fe, 0xbb45c3fe, 0xbb45c3fe, 0xbb45c3fe, 0x3ae93d2c, 0x3ae93d2c, + 0x3ae93d2c, 0x3ae93d2c, 0x3ae93d2c, 0xbaa1fd72, 0xbaa1fd72, 0xbaa1fd72, 0xbaa1fd72, 0xbaa1fd72, + 0x3b6963d1, 0x3b6963d1, 0x3b6963d1, 0x3b6963d1, 0x3b6963d1, 0x3a0f1a75, 0x3a0f1a75, 0x3a0f1a75, + 0x3a0f1a75, 0x3a0f1a75, 0xbb21d6ac, 0xbb21d6ac, 0xbb21d6ac, 0xbb21d6ac, 0xbb21d6ac, 0x3b188bec, + 0x3b188bec, 0x3b188bec, 0x3b188bec, 0x3b188bec, 0xba34457c, 0xba34457c, 0xba34457c, 0xba34457c, + 0xba34457c, 0xbb72ae8f, 0xbb72ae8f, 0xbb72ae8f, 0xbb72ae8f, 0xbb72ae8f, 0x3a8f67ef, 0x3a8f67ef, + 0x3a8f67ef, 0x3a8f67ef, 0x3a8f67ef, 0xbafbd2ad, 0xbafbd2ad, 0xbafbd2ad, 0xbafbd2ad, 0xbafbd2ad, + 0x3b3c793f, 0x3b3c793f, 0x3b3c793f, 0x3b3c793f, 0x3b3c793f, 0xb9124043, 0xb9124043, 0xb9124043, + 0xb9124043, 0xb9124043, 0xbb4ec142, 0xbb4ec142, 0xbb4ec142, 0xbb4ec142, 0xbb4ec142, 0x3ad742a1, + 0x3ad742a1, 0x3ad742a1, 0x3ad742a1, 0x3ad742a1, 0xbab3f7fe, 0xbab3f7fe, 0xbab3f7fe, 0xbab3f7fe, + 0xbab3f7fe, 0x3b60668e, 0x3b60668e, 0x3b60668e, 0x3b60668e, 0x3b60668e, 0x39d64ab6, 0x39d64ab6, + 0x39d64ab6, 0x39d64ab6, 0x39d64ab6, 0xbb2ad3f1, 0xbb2ad3f1, 0xbb2ad3f1, 0xbb2ad3f1, 0xbb2ad3f1, + 0x3b0f8ea7, 0x3b0f8ea7, 0x3b0f8ea7, 0x3b0f8ea7, 0x3b0f8ea7, 0xba583a96, 0xba583a96, 0xba583a96, + 0xba583a96, 0xba583a96, 0xbb7babd1, 0xbb7babd1, 0xbb7babd1, 0xbb7babd1, 0xbb7babd1, 0x3a7adac5, +] )) ), + +################ chunk 3072 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47bcfc87, 0x47bcfc87, 0x47bcfc87, 0x47bcfc87, 0x47bd999b, 0x47bd999b, 0x47bd999b, 0x47bd999b, + 0x47bd999b, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47bed3c4, 0x47bed3c4, + 0x47bed3c4, 0x47bed3c4, 0x47bed3c4, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, + 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c0ab01, 0x47c0ab01, 0x47c0ab01, + 0x47c0ab01, 0x47c0ab01, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c1e52a, + 0x47c1e52a, 0x47c1e52a, 0x47c1e52a, 0x47c1e52a, 0x47c2823e, 0x47c2823e, 0x47c2823e, 0x47c2823e, + 0x47c2823e, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c3bc67, 0x47c3bc67, + 0x47c3bc67, 0x47c3bc67, 0x47c3bc67, 0x47c4597c, 0x47c4597c, 0x47c4597c, 0x47c4597c, 0x47c4597c, + 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c593a4, 0x47c593a4, 0x47c593a4, + 0x47c593a4, 0x47c593a4, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c6cdcd, + 0x47c6cdcd, 0x47c6cdcd, 0x47c6cdcd, 0x47c6cdcd, 0x47c76ae1, 0x47c76ae1, 0x47c76ae1, 0x47c76ae1, + 0x47c76ae1, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c8a50a, 0x47c8a50a, + 0x47c8a50a, 0x47c8a50a, 0x47c8a50a, 0x47c9421f, 0x47c9421f, 0x47c9421f, 0x47c9421f, 0x47c9421f, + 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47ca7c47, 0x47ca7c47, 0x47ca7c47, + 0x47ca7c47, 0x47ca7c47, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cbb670, + 0x47cbb670, 0x47cbb670, 0x47cbb670, 0x47cbb670, 0x47cc5385, 0x47cc5385, 0x47cc5385, 0x47cc5385, + 0x47cc5385, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47cd8dad, 0x47cd8dad, + 0x47cd8dad, 0x47cd8dad, 0x47cd8dad, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, + 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cf64ea, 0x47cf64ea, 0x47cf64ea, + 0x47cf64ea, 0x47cf64ea, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d09f13, + 0x47d09f13, 0x47d09f13, 0x47d09f13, 0x47d09f13, 0x47d13c28, 0x47d13c28, 0x47d13c28, 0x47d13c28, + 0x47d13c28, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d27650, 0x47d27650, + 0x47d27650, 0x47d27650, 0x47d27650, 0x47d31365, 0x47d31365, 0x47d31365, 0x47d31365, 0x47d31365, + 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d44d8e, 0x47d44d8e, 0x47d44d8e, + 0x47d44d8e, 0x47d44d8e, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d587b6, + 0x47d587b6, 0x47d587b6, 0x47d587b6, 0x47d587b6, 0x47d624cb, 0x47d624cb, 0x47d624cb, 0x47d624cb, + 0x47d624cb, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d75ef3, 0x47d75ef3, + 0x47d75ef3, 0x47d75ef3, 0x47d75ef3, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, + 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d93631, 0x47d93631, 0x47d93631, + 0x47d93631, 0x47d93631, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47da7059, + 0x47da7059, 0x47da7059, 0x47da7059, 0x47da7059, 0x47db0d6e, 0x47db0d6e, 0x47db0d6e, 0x47db0d6e, + 0x47db0d6e, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dc4797, 0x47dc4797, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3a7adac5, 0x3a7adac5, 0x3a7adac5, 0x3a7adac5, 0xbb06e69c, 0xbb06e69c, 0xbb06e69c, 0xbb06e69c, + 0xbb06e69c, 0x3b337bfb, 0x3b337bfb, 0x3b337bfb, 0x3b337bfb, 0x3b337bfb, 0xb9910a56, 0xb9910a56, + 0xb9910a56, 0xb9910a56, 0xb9910a56, 0xbb57be85, 0xbb57be85, 0xbb57be85, 0xbb57be85, 0xbb57be85, + 0x3ac54815, 0x3ac54815, 0x3ac54815, 0x3ac54815, 0x3ac54815, 0xbac5f28a, 0xbac5f28a, 0xbac5f28a, + 0xbac5f28a, 0xbac5f28a, 0x3b57694b, 0x3b57694b, 0x3b57694b, 0x3b57694b, 0x3b57694b, 0x398e6081, + 0x398e6081, 0x398e6081, 0x398e6081, 0x398e6081, 0xbb33d135, 0xbb33d135, 0xbb33d135, 0xbb33d135, + 0xbb33d135, 0x3b069162, 0x3b069162, 0x3b069162, 0x3b069162, 0x3b069162, 0xba7c2faf, 0xba7c2faf, + 0xba7c2faf, 0xba7c2faf, 0xba7c2faf, 0x3b7b5697, 0x3b7b5697, 0x3b7b5697, 0x3b7b5697, 0x3b7b5697, + 0x3a56e5ab, 0x3a56e5ab, 0x3a56e5ab, 0x3a56e5ab, 0x3a56e5ab, 0xbb0fe3e1, 0xbb0fe3e1, 0xbb0fe3e1, + 0xbb0fe3e1, 0xbb0fe3e1, 0x3b2a7eb6, 0x3b2a7eb6, 0x3b2a7eb6, 0x3b2a7eb6, 0x3b2a7eb6, 0xb9d8f48b, + 0xb9d8f48b, 0xb9d8f48b, 0xb9d8f48b, 0xb9d8f48b, 0xbb60bbc9, 0xbb60bbc9, 0xbb60bbc9, 0xbb60bbc9, + 0xbb60bbc9, 0x3ab34d89, 0x3ab34d89, 0x3ab34d89, 0x3ab34d89, 0x3ab34d89, 0xbad7ed16, 0xbad7ed16, + 0xbad7ed16, 0xbad7ed16, 0xbad7ed16, 0x3b4e6c07, 0x3b4e6c07, 0x3b4e6c07, 0x3b4e6c07, 0x3b4e6c07, + 0x390cec99, 0x390cec99, 0x390cec99, 0x390cec99, 0x390cec99, 0xbb3cce7a, 0xbb3cce7a, 0xbb3cce7a, + 0xbb3cce7a, 0xbb3cce7a, 0x3afb2838, 0x3afb2838, 0x3afb2838, 0x3afb2838, 0x3afb2838, 0xba901264, + 0xba901264, 0xba901264, 0xba901264, 0xba901264, 0x3b725955, 0x3b725955, 0x3b725955, 0x3b725955, + 0x3b725955, 0x3a32f091, 0x3a32f091, 0x3a32f091, 0x3a32f091, 0x3a32f091, 0xbb18e127, 0xbb18e127, + 0xbb18e127, 0xbb18e127, 0xbb18e127, 0x3b218171, 0x3b218171, 0x3b218171, 0x3b218171, 0x3b218171, + 0xba106f60, 0xba106f60, 0xba106f60, 0xba106f60, 0xba106f60, 0xbb69b90c, 0xbb69b90c, 0xbb69b90c, + 0xbb69b90c, 0xbb69b90c, 0x3aa152fc, 0x3aa152fc, 0x3aa152fc, 0x3aa152fc, 0x3aa152fc, 0xbae9e7a1, + 0xbae9e7a1, 0xbae9e7a1, 0xbae9e7a1, 0xbae9e7a1, 0x3b456ec4, 0x3b456ec4, 0x3b456ec4, 0x3b456ec4, + 0x3b456ec4, 0xb639f432, 0xb639f432, 0xb639f432, 0xb639f432, 0xb639f432, 0xbb45cbbe, 0xbb45cbbe, + 0xbb45cbbe, 0xbb45cbbe, 0xbb45cbbe, 0x3ae92dad, 0x3ae92dad, 0x3ae92dad, 0x3ae92dad, 0x3ae92dad, + 0xbaa20cf1, 0xbaa20cf1, 0xbaa20cf1, 0xbaa20cf1, 0xbaa20cf1, 0x3b695c12, 0x3b695c12, 0x3b695c12, + 0x3b695c12, 0x3b695c12, 0x3a0efb77, 0x3a0efb77, 0x3a0efb77, 0x3a0efb77, 0x3a0efb77, 0xbb21de6b, + 0xbb21de6b, 0xbb21de6b, 0xbb21de6b, 0xbb21de6b, 0x3b18842d, 0x3b18842d, 0x3b18842d, 0x3b18842d, + 0x3b18842d, 0xba34647a, 0xba34647a, 0xba34647a, 0xba34647a, 0xba34647a, 0xbb72b64f, 0xbb72b64f, + 0xbb72b64f, 0xbb72b64f, 0xbb72b64f, 0x3a8f5870, 0x3a8f5870, 0x3a8f5870, 0x3a8f5870, 0x3a8f5870, + 0xbafbe22c, 0xbafbe22c, 0xbafbe22c, 0xbafbe22c, 0xbafbe22c, 0x3b3c7180, 0x3b3c7180, 0x3b3c7180, + 0x3b3c7180, 0x3b3c7180, 0xb912bc3b, 0xb912bc3b, 0xb912bc3b, 0xb912bc3b, 0xb912bc3b, 0xbb4ec901, + 0xbb4ec901, 0xbb4ec901, 0xbb4ec901, 0xbb4ec901, 0x3ad73322, 0x3ad73322, 0x3ad73322, 0x3ad73322, + 0x3ad73322, 0xbab4077d, 0xbab4077d, 0xbab4077d, 0xbab4077d, 0xbab4077d, 0x3b605ecf, 0x3b605ecf, +] )) ), + +################ chunk 3584 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47dc4797, 0x47dc4797, 0x47dc4797, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, + 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47de1ed4, 0x47de1ed4, 0x47de1ed4, + 0x47de1ed4, 0x47de1ed4, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47df58fc, + 0x47df58fc, 0x47df58fc, 0x47df58fc, 0x47df58fc, 0x47dff611, 0x47dff611, 0x47dff611, 0x47dff611, + 0x47dff611, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e1303a, 0x47e1303a, + 0x47e1303a, 0x47e1303a, 0x47e1303a, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, + 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e30777, 0x47e30777, 0x47e30777, + 0x47e30777, 0x47e30777, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e441a0, + 0x47e441a0, 0x47e441a0, 0x47e441a0, 0x47e441a0, 0x47e4deb4, 0x47e4deb4, 0x47e4deb4, 0x47e4deb4, + 0x47e4deb4, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e618dd, 0x47e618dd, + 0x47e618dd, 0x47e618dd, 0x47e618dd, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, + 0x47e75306, 0x47e75306, 0x47e75306, 0x47e75306, 0x47e75306, 0x47e7f01a, 0x47e7f01a, 0x47e7f01a, + 0x47e7f01a, 0x47e7f01a, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e92a43, + 0x47e92a43, 0x47e92a43, 0x47e92a43, 0x47e92a43, 0x47e9c757, 0x47e9c757, 0x47e9c757, 0x47e9c757, + 0x47e9c757, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47eb0180, 0x47eb0180, + 0x47eb0180, 0x47eb0180, 0x47eb0180, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, + 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ecd8bd, 0x47ecd8bd, 0x47ecd8bd, + 0x47ecd8bd, 0x47ecd8bd, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ee12e6, + 0x47ee12e6, 0x47ee12e6, 0x47ee12e6, 0x47ee12e6, 0x47eeaffa, 0x47eeaffa, 0x47eeaffa, 0x47eeaffa, + 0x47eeaffa, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47efea23, 0x47efea23, + 0x47efea23, 0x47efea23, 0x47efea23, 0x47f08737, 0x47f08737, 0x47f08737, 0x47f08737, 0x47f08737, + 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1c160, 0x47f1c160, 0x47f1c160, + 0x47f1c160, 0x47f1c160, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f2fb89, + 0x47f2fb89, 0x47f2fb89, 0x47f2fb89, 0x47f2fb89, 0x47f3989d, 0x47f3989d, 0x47f3989d, 0x47f3989d, + 0x47f3989d, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f4d2c6, 0x47f4d2c6, + 0x47f4d2c6, 0x47f4d2c6, 0x47f4d2c6, 0x47f56fda, 0x47f56fda, 0x47f56fda, 0x47f56fda, 0x47f56fda, + 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f6aa03, 0x47f6aa03, 0x47f6aa03, + 0x47f6aa03, 0x47f6aa03, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f7e42c, + 0x47f7e42c, 0x47f7e42c, 0x47f7e42c, 0x47f7e42c, 0x47f88140, 0x47f88140, 0x47f88140, 0x47f88140, + 0x47f88140, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f9bb69, 0x47f9bb69, + 0x47f9bb69, 0x47f9bb69, 0x47f9bb69, 0x47fa587d, 0x47fa587d, 0x47fa587d, 0x47fa587d, 0x47fa587d, + 0x47faf592, 0x47faf592, 0x47faf592, 0x47faf592, 0x47faf592, 0x47fb92a6, 0x47fb92a6, 0x47fb92a6, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3b605ecf, 0x3b605ecf, 0x3b605ecf, 0x39d60cba, 0x39d60cba, 0x39d60cba, 0x39d60cba, 0x39d60cba, + 0xbb2adbb0, 0xbb2adbb0, 0xbb2adbb0, 0xbb2adbb0, 0xbb2adbb0, 0x3b0f86e7, 0x3b0f86e7, 0x3b0f86e7, + 0x3b0f86e7, 0x3b0f86e7, 0xba585994, 0xba585994, 0xba585994, 0xba585994, 0xba585994, 0xbb7bb391, + 0xbb7bb391, 0xbb7bb391, 0xbb7bb391, 0xbb7bb391, 0x3a7abbc7, 0x3a7abbc7, 0x3a7abbc7, 0x3a7abbc7, + 0x3a7abbc7, 0xbb06ee5c, 0xbb06ee5c, 0xbb06ee5c, 0xbb06ee5c, 0xbb06ee5c, 0x3b33743b, 0x3b33743b, + 0x3b33743b, 0x3b33743b, 0x3b33743b, 0xb9914852, 0xb9914852, 0xb9914852, 0xb9914852, 0xb9914852, + 0xbb57c645, 0xbb57c645, 0xbb57c645, 0xbb57c645, 0xbb57c645, 0x3ac53896, 0x3ac53896, 0x3ac53896, + 0x3ac53896, 0x3ac53896, 0xbac60209, 0xbac60209, 0xbac60209, 0xbac60209, 0xbac60209, 0x3b57618b, + 0x3b57618b, 0x3b57618b, 0x3b57618b, 0x3b57618b, 0x398e2285, 0x398e2285, 0x398e2285, 0x398e2285, + 0x398e2285, 0xbb33d8f5, 0xbb33d8f5, 0xbb33d8f5, 0xbb33d8f5, 0xbb33d8f5, 0x3b0689a2, 0x3b0689a2, + 0x3b0689a2, 0x3b0689a2, 0x3b0689a2, 0xba7c4ead, 0xba7c4ead, 0xba7c4ead, 0xba7c4ead, 0xba7c4ead, + 0x3b7b4ed8, 0x3b7b4ed8, 0x3b7b4ed8, 0x3b7b4ed8, 0x3b7b4ed8, 0x3a56c6ad, 0x3a56c6ad, 0x3a56c6ad, + 0x3a56c6ad, 0x3a56c6ad, 0xbb0feba1, 0xbb0feba1, 0xbb0feba1, 0xbb0feba1, 0xbb0feba1, 0x3b2a76f7, + 0x3b2a76f7, 0x3b2a76f7, 0x3b2a76f7, 0x3b2a76f7, 0xb9d93287, 0xb9d93287, 0xb9d93287, 0xb9d93287, + 0xb9d93287, 0xbb60c388, 0xbb60c388, 0xbb60c388, 0xbb60c388, 0xbb60c388, 0x3ab33e0a, 0x3ab33e0a, + 0x3ab33e0a, 0x3ab33e0a, 0x3ab33e0a, 0xbad7fc95, 0xbad7fc95, 0xbad7fc95, 0xbad7fc95, 0xbad7fc95, + 0x3b4e6448, 0x3b4e6448, 0x3b4e6448, 0x3b4e6448, 0x3b4e6448, 0x390c70a1, 0x390c70a1, 0x390c70a1, + 0x390c70a1, 0x390c70a1, 0xbb3cd639, 0xbb3cd639, 0xbb3cd639, 0xbb3cd639, 0xbb3cd639, 0x3afb18b9, + 0x3afb18b9, 0x3afb18b9, 0x3afb18b9, 0x3afb18b9, 0xba9021e3, 0xba9021e3, 0xba9021e3, 0xba9021e3, + 0xba9021e3, 0x3b725195, 0x3b725195, 0x3b725195, 0x3b725195, 0x3b725195, 0x3a32d193, 0x3a32d193, + 0x3a32d193, 0x3a32d193, 0x3a32d193, 0xbb18e8e6, 0xbb18e8e6, 0xbb18e8e6, 0xbb18e8e6, 0xbb18e8e6, + 0x3b2179b2, 0x3b2179b2, 0x3b2179b2, 0x3b2179b2, 0x3b2179b2, 0xba108e5e, 0xba108e5e, 0xba108e5e, + 0xba108e5e, 0xba108e5e, 0xbb69c0cb, 0xbb69c0cb, 0xbb69c0cb, 0xbb69c0cb, 0xbb69c0cb, 0x3aa1437d, + 0x3aa1437d, 0x3aa1437d, 0x3aa1437d, 0x3aa1437d, 0xbae9f720, 0xbae9f720, 0xbae9f720, 0xbae9f720, + 0xbae9f720, 0x3b456704, 0x3b456704, 0x3b456704, 0x3b456704, 0x3b456704, 0xb658f23a, 0xb658f23a, + 0xb658f23a, 0xb658f23a, 0xb658f23a, 0xbb45d37d, 0xbb45d37d, 0xbb45d37d, 0xbb45d37d, 0xbb45d37d, + 0x3ae91e2e, 0x3ae91e2e, 0x3ae91e2e, 0x3ae91e2e, 0x3ae91e2e, 0xbaa21c70, 0xbaa21c70, 0xbaa21c70, + 0xbaa21c70, 0xbaa21c70, 0x3b695452, 0x3b695452, 0x3b695452, 0x3b695452, 0x3b695452, 0x3a0edc79, + 0x3a0edc79, 0x3a0edc79, 0x3a0edc79, 0x3a0edc79, 0xbb21e62b, 0xbb21e62b, 0xbb21e62b, 0xbb21e62b, + 0xbb21e62b, 0x3b187c6d, 0x3b187c6d, 0x3b187c6d, 0x3b187c6d, 0x3b187c6d, 0xba348378, 0xba348378, + 0xba348378, 0xba348378, 0xba348378, 0xbb72be0e, 0xbb72be0e, 0xbb72be0e, 0xbb72be0e, 0xbb72be0e, + 0x3a8f48f1, 0x3a8f48f1, 0x3a8f48f1, 0x3a8f48f1, 0x3a8f48f1, 0xbafbf1ab, 0xbafbf1ab, 0xbafbf1ab, +] )) ), + +################ chunk 4096 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47fb92a6, 0x47fb92a6, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fccccf, + 0x47fccccf, 0x47fccccf, 0x47fccccf, 0x47fccccf, 0x47fd69e3, 0x47fd69e3, 0x47fd69e3, 0x47fd69e3, + 0x47fd69e3, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fea40c, 0x47fea40c, + 0x47fea40c, 0x47fea40c, 0x47fea40c, 0x47ff4121, 0x47ff4121, 0x47ff4121, 0x47ff4121, 0x47ff4121, + 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x48003da5, 0x48003da5, 0x48003da5, + 0x48003da5, 0x48003da5, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x4800dab9, + 0x4800dab9, 0x4800dab9, 0x4800dab9, 0x4800dab9, 0x48012943, 0x48012943, 0x48012943, 0x48012943, + 0x48012943, 0x480177cd, 0x480177cd, 0x480177cd, 0x480177cd, 0x480177cd, 0x4801c658, 0x4801c658, + 0x4801c658, 0x4801c658, 0x4801c658, 0x480214e2, 0x480214e2, 0x480214e2, 0x480214e2, 0x480214e2, + 0x4802636c, 0x4802636c, 0x4802636c, 0x4802636c, 0x4802636c, 0x4802b1f6, 0x4802b1f6, 0x4802b1f6, + 0x4802b1f6, 0x4802b1f6, 0x48030080, 0x48030080, 0x48030080, 0x48030080, 0x48030080, 0x48034f0b, + 0x48034f0b, 0x48034f0b, 0x48034f0b, 0x48034f0b, 0x48039d95, 0x48039d95, 0x48039d95, 0x48039d95, + 0x48039d95, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x48043aa9, 0x48043aa9, + 0x48043aa9, 0x48043aa9, 0x48043aa9, 0x48048933, 0x48048933, 0x48048933, 0x48048933, 0x48048933, + 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x48052648, 0x48052648, 0x48052648, + 0x48052648, 0x48052648, 0x480574d2, 0x480574d2, 0x480574d2, 0x480574d2, 0x480574d2, 0x4805c35c, + 0x4805c35c, 0x4805c35c, 0x4805c35c, 0x4805c35c, 0x480611e6, 0x480611e6, 0x480611e6, 0x480611e6, + 0x480611e6, 0x48066071, 0x48066071, 0x48066071, 0x48066071, 0x48066071, 0x4806aefb, 0x4806aefb, + 0x4806aefb, 0x4806aefb, 0x4806aefb, 0x4806fd85, 0x4806fd85, 0x4806fd85, 0x4806fd85, 0x4806fd85, + 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48079a99, 0x48079a99, 0x48079a99, + 0x48079a99, 0x48079a99, 0x4807e923, 0x4807e923, 0x4807e923, 0x4807e923, 0x4807e923, 0x480837ae, + 0x480837ae, 0x480837ae, 0x480837ae, 0x480837ae, 0x48088638, 0x48088638, 0x48088638, 0x48088638, + 0x48088638, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4809234c, 0x4809234c, + 0x4809234c, 0x4809234c, 0x4809234c, 0x480971d6, 0x480971d6, 0x480971d6, 0x480971d6, 0x480971d6, + 0x4809c061, 0x4809c061, 0x4809c061, 0x4809c061, 0x4809c061, 0x480a0eeb, 0x480a0eeb, 0x480a0eeb, + 0x480a0eeb, 0x480a0eeb, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480aabff, + 0x480aabff, 0x480aabff, 0x480aabff, 0x480aabff, 0x480afa89, 0x480afa89, 0x480afa89, 0x480afa89, + 0x480afa89, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b979e, 0x480b979e, + 0x480b979e, 0x480b979e, 0x480b979e, 0x480be628, 0x480be628, 0x480be628, 0x480be628, 0x480be628, + 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c833c, 0x480c833c, 0x480c833c, + 0x480c833c, 0x480c833c, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480d2051, + 0x480d2051, 0x480d2051, 0x480d2051, 0x480d2051, 0x480d6edb, 0x480d6edb, 0x480d6edb, 0x480d6edb, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbafbf1ab, 0xbafbf1ab, 0x3b3c69c0, 0x3b3c69c0, 0x3b3c69c0, 0x3b3c69c0, 0x3b3c69c0, 0xb9133833, + 0xb9133833, 0xb9133833, 0xb9133833, 0xb9133833, 0xbb4ed0c1, 0xbb4ed0c1, 0xbb4ed0c1, 0xbb4ed0c1, + 0xbb4ed0c1, 0x3ad723a2, 0x3ad723a2, 0x3ad723a2, 0x3ad723a2, 0x3ad723a2, 0xbab416fc, 0xbab416fc, + 0xbab416fc, 0xbab416fc, 0xbab416fc, 0x3b60570f, 0x3b60570f, 0x3b60570f, 0x3b60570f, 0x3b60570f, + 0x39d5cebe, 0x39d5cebe, 0x39d5cebe, 0x39d5cebe, 0x39d5cebe, 0x3baa8e0f, 0x3baa8e0f, 0x3baa8e0f, + 0x3baa8e0f, 0x3baa8e0f, 0x3b0f7f28, 0x3b0f7f28, 0x3b0f7f28, 0x3b0f7f28, 0x3b0f7f28, 0xba587892, + 0xba587892, 0xba587892, 0xba587892, 0xba587892, 0xbb7bbb50, 0xbb7bbb50, 0xbb7bbb50, 0xbb7bbb50, + 0xbb7bbb50, 0xbbe0abf3, 0xbbe0abf3, 0xbbe0abf3, 0xbbe0abf3, 0xbbe0abf3, 0x3bbc84ab, 0x3bbc84ab, + 0x3bbc84ab, 0x3bbc84ab, 0x3bbc84ab, 0x3b336c7c, 0x3b336c7c, 0x3b336c7c, 0x3b336c7c, 0x3b336c7c, + 0xb991864e, 0xb991864e, 0xb991864e, 0xb991864e, 0xb991864e, 0xbb57ce04, 0xbb57ce04, 0xbb57ce04, + 0xbb57ce04, 0xbb57ce04, 0xbbceb55f, 0xbbceb55f, 0xbbceb55f, 0xbbceb55f, 0xbbceb55f, 0x3bce7b43, + 0x3bce7b43, 0x3bce7b43, 0x3bce7b43, 0x3bce7b43, 0x3b5759cc, 0x3b5759cc, 0x3b5759cc, 0x3b5759cc, + 0x3b5759cc, 0x398de489, 0x398de489, 0x398de489, 0x398de489, 0x398de489, 0xbb33e0b4, 0xbb33e0b4, + 0xbb33e0b4, 0xbb33e0b4, 0xbb33e0b4, 0xbbbcbec7, 0xbbbcbec7, 0xbbbcbec7, 0xbbbcbec7, 0xbbbcbec7, + 0x3be071d7, 0x3be071d7, 0x3be071d7, 0x3be071d7, 0x3be071d7, 0x3b7b4718, 0x3b7b4718, 0x3b7b4718, + 0x3b7b4718, 0x3b7b4718, 0x3a56a7af, 0x3a56a7af, 0x3a56a7af, 0x3a56a7af, 0x3a56a7af, 0xbb0ff360, + 0xbb0ff360, 0xbb0ff360, 0xbb0ff360, 0xbb0ff360, 0xbbaac82b, 0xbbaac82b, 0xbbaac82b, 0xbbaac82b, + 0xbbaac82b, 0x3bf26867, 0x3bf26867, 0x3bf26867, 0x3bf26867, 0x3bf26867, 0x3b8f9a30, 0x3b8f9a30, + 0x3b8f9a30, 0x3b8f9a30, 0x3b8f9a30, 0x3ab32e8b, 0x3ab32e8b, 0x3ab32e8b, 0x3ab32e8b, 0x3ab32e8b, + 0xbad80c14, 0xbad80c14, 0xbad80c14, 0xbad80c14, 0xbad80c14, 0xbb98d18c, 0xbb98d18c, 0xbb98d18c, + 0xbb98d18c, 0xbb98d18c, 0xbbfb9fb9, 0xbbfb9fb9, 0xbbfb9fb9, 0xbbfb9fb9, 0xbbfb9fb9, 0x3ba190d0, + 0x3ba190d0, 0x3ba190d0, 0x3ba190d0, 0x3ba190d0, 0x3afb093a, 0x3afb093a, 0x3afb093a, 0x3afb093a, + 0x3afb093a, 0xba903162, 0xba903162, 0xba903162, 0xba903162, 0xba903162, 0xbb86daea, 0xbb86daea, + 0xbb86daea, 0xbb86daea, 0xbb86daea, 0xbbe9a92b, 0xbbe9a92b, 0xbbe9a92b, 0xbbe9a92b, 0xbbe9a92b, + 0x3bb3876e, 0x3bb3876e, 0x3bb3876e, 0x3bb3876e, 0x3bb3876e, 0x3b2171f2, 0x3b2171f2, 0x3b2171f2, + 0x3b2171f2, 0x3b2171f2, 0xba10ad5c, 0xba10ad5c, 0xba10ad5c, 0xba10ad5c, 0xba10ad5c, 0xbb69c88b, + 0xbb69c88b, 0xbb69c88b, 0xbb69c88b, 0xbb69c88b, 0xbbd7b29a, 0xbbd7b29a, 0xbbd7b29a, 0xbbd7b29a, + 0xbbd7b29a, 0x3bc57e08, 0x3bc57e08, 0x3bc57e08, 0x3bc57e08, 0x3bc57e08, 0x3b455f45, 0x3b455f45, + 0x3b455f45, 0x3b455f45, 0x3b455f45, 0xb677f042, 0xb677f042, 0xb677f042, 0xb677f042, 0xb677f042, + 0xbb45db3d, 0xbb45db3d, 0xbb45db3d, 0xbb45db3d, 0xbb45db3d, 0xbbc5bc04, 0xbbc5bc04, 0xbbc5bc04, + 0xbbc5bc04, 0xbbc5bc04, 0x3bd7749e, 0x3bd7749e, 0x3bd7749e, 0x3bd7749e, 0x3bd7749e, 0x3b694c93, + 0x3b694c93, 0x3b694c93, 0x3b694c93, 0x3b694c93, 0x3a0ebd7b, 0x3a0ebd7b, 0x3a0ebd7b, 0x3a0ebd7b, +] )) ), + +################ chunk 4608 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x480d6edb, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480e0bef, 0x480e0bef, + 0x480e0bef, 0x480e0bef, 0x480e0bef, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, + 0x480ea904, 0x480ea904, 0x480ea904, 0x480ea904, 0x480ea904, 0x480ef78e, 0x480ef78e, 0x480ef78e, + 0x480ef78e, 0x480ef78e, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f94a2, + 0x480f94a2, 0x480f94a2, 0x480f94a2, 0x480f94a2, 0x480fe32d, 0x480fe32d, 0x480fe32d, 0x480fe32d, + 0x480fe32d, 0x481031b7, 0x481031b7, 0x481031b7, 0x481031b7, 0x481031b7, 0x48108041, 0x48108041, + 0x48108041, 0x48108041, 0x48108041, 0x4810cecb, 0x4810cecb, 0x4810cecb, 0x4810cecb, 0x4810cecb, + 0x48111d55, 0x48111d55, 0x48111d55, 0x48111d55, 0x48111d55, 0x48116bdf, 0x48116bdf, 0x48116bdf, + 0x48116bdf, 0x48116bdf, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x481208f4, + 0x481208f4, 0x481208f4, 0x481208f4, 0x481208f4, 0x4812577e, 0x4812577e, 0x4812577e, 0x4812577e, + 0x4812577e, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812f492, 0x4812f492, + 0x4812f492, 0x4812f492, 0x4812f492, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, + 0x481391a7, 0x481391a7, 0x481391a7, 0x481391a7, 0x481391a7, 0x4813e031, 0x4813e031, 0x4813e031, + 0x4813e031, 0x4813e031, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48147d45, + 0x48147d45, 0x48147d45, 0x48147d45, 0x48147d45, 0x4814cbd0, 0x4814cbd0, 0x4814cbd0, 0x4814cbd0, + 0x4814cbd0, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x481568e4, 0x481568e4, + 0x481568e4, 0x481568e4, 0x481568e4, 0x4815b76e, 0x4815b76e, 0x4815b76e, 0x4815b76e, 0x4815b76e, + 0x481605f8, 0x481605f8, 0x481605f8, 0x481605f8, 0x481605f8, 0x48165483, 0x48165483, 0x48165483, + 0x48165483, 0x48165483, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816f197, + 0x4816f197, 0x4816f197, 0x4816f197, 0x4816f197, 0x48174021, 0x48174021, 0x48174021, 0x48174021, + 0x48174021, 0x48178eab, 0x48178eab, 0x48178eab, 0x48178eab, 0x48178eab, 0x4817dd36, 0x4817dd36, + 0x4817dd36, 0x4817dd36, 0x4817dd36, 0x48182bc0, 0x48182bc0, 0x48182bc0, 0x48182bc0, 0x48182bc0, + 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x4818c8d4, 0x4818c8d4, 0x4818c8d4, + 0x4818c8d4, 0x4818c8d4, 0x4819175e, 0x4819175e, 0x4819175e, 0x4819175e, 0x4819175e, 0x481965e8, + 0x481965e8, 0x481965e8, 0x481965e8, 0x481965e8, 0x4819b473, 0x4819b473, 0x4819b473, 0x4819b473, + 0x4819b473, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a5187, 0x481a5187, + 0x481a5187, 0x481a5187, 0x481a5187, 0x481aa011, 0x481aa011, 0x481aa011, 0x481aa011, 0x481aa011, + 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481b3d26, 0x481b3d26, 0x481b3d26, + 0x481b3d26, 0x481b3d26, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481bda3a, + 0x481bda3a, 0x481bda3a, 0x481bda3a, 0x481bda3a, 0x481c28c4, 0x481c28c4, 0x481c28c4, 0x481c28c4, + 0x481c28c4, 0x481c774e, 0x481c774e, 0x481c774e, 0x481c774e, 0x481c774e, 0x481cc5d9, 0x481cc5d9, + 0x481cc5d9, 0x481cc5d9, 0x481cc5d9, 0x481d1463, 0x481d1463, 0x481d1463, 0x481d1463, 0x481d1463, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3a0ebd7b, 0xbb21edea, 0xbb21edea, 0xbb21edea, 0xbb21edea, 0xbb21edea, 0xbbb3c56a, 0xbbb3c56a, + 0xbbb3c56a, 0xbbb3c56a, 0xbbb3c56a, 0x3be96b30, 0x3be96b30, 0x3be96b30, 0x3be96b30, 0x3be96b30, + 0x3b869cee, 0x3b869cee, 0x3b869cee, 0x3b869cee, 0x3b869cee, 0x3a8f3972, 0x3a8f3972, 0x3a8f3972, + 0x3a8f3972, 0x3a8f3972, 0xbafc012a, 0xbafc012a, 0xbafc012a, 0xbafc012a, 0xbafc012a, 0xbba1cecc, + 0xbba1cecc, 0xbba1cecc, 0xbba1cecc, 0xbba1cecc, 0x3bfb61bd, 0x3bfb61bd, 0x3bfb61bd, 0x3bfb61bd, + 0x3bfb61bd, 0x3b989390, 0x3b989390, 0x3b989390, 0x3b989390, 0x3b989390, 0x3ad71423, 0x3ad71423, + 0x3ad71423, 0x3ad71423, 0x3ad71423, 0xbab4267b, 0xbab4267b, 0xbab4267b, 0xbab4267b, 0xbab4267b, + 0xbb8fd82b, 0xbb8fd82b, 0xbb8fd82b, 0xbb8fd82b, 0xbb8fd82b, 0xbbf2a663, 0xbbf2a663, 0xbbf2a663, + 0xbbf2a663, 0xbbf2a663, 0x3baa8a30, 0x3baa8a30, 0x3baa8a30, 0x3baa8a30, 0x3baa8a30, 0x3b0f7768, + 0x3b0f7768, 0x3b0f7768, 0x3b0f7768, 0x3b0f7768, 0xba589790, 0xba589790, 0xba589790, 0xba589790, + 0xba589790, 0xbb7bc310, 0xbb7bc310, 0xbb7bc310, 0xbb7bc310, 0xbb7bc310, 0xbbe0afd3, 0xbbe0afd3, + 0xbbe0afd3, 0xbbe0afd3, 0xbbe0afd3, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, + 0x3b3364bc, 0x3b3364bc, 0x3b3364bc, 0x3b3364bc, 0x3b3364bc, 0xb991c44a, 0xb991c44a, 0xb991c44a, + 0xb991c44a, 0xb991c44a, 0xbb57d5c4, 0xbb57d5c4, 0xbb57d5c4, 0xbb57d5c4, 0xbb57d5c4, 0xbbceb93f, + 0xbbceb93f, 0xbbceb93f, 0xbbceb93f, 0xbbceb93f, 0x3bce7764, 0x3bce7764, 0x3bce7764, 0x3bce7764, + 0x3bce7764, 0x3b57520c, 0x3b57520c, 0x3b57520c, 0x3b57520c, 0x3b57520c, 0x398da68d, 0x398da68d, + 0x398da68d, 0x398da68d, 0x398da68d, 0xbb33e874, 0xbb33e874, 0xbb33e874, 0xbb33e874, 0xbb33e874, + 0xbbbcc2a7, 0xbbbcc2a7, 0xbbbcc2a7, 0xbbbcc2a7, 0xbbbcc2a7, 0x3be06df8, 0x3be06df8, 0x3be06df8, + 0x3be06df8, 0x3be06df8, 0x3b7b3f59, 0x3b7b3f59, 0x3b7b3f59, 0x3b7b3f59, 0x3b7b3f59, 0x3a5688b1, + 0x3a5688b1, 0x3a5688b1, 0x3a5688b1, 0x3a5688b1, 0xbb0ffb20, 0xbb0ffb20, 0xbb0ffb20, 0xbb0ffb20, + 0xbb0ffb20, 0xbbaacc0b, 0xbbaacc0b, 0xbbaacc0b, 0xbbaacc0b, 0xbbaacc0b, 0x3bf26487, 0x3bf26487, + 0x3bf26487, 0x3bf26487, 0x3bf26487, 0x3b8f9650, 0x3b8f9650, 0x3b8f9650, 0x3b8f9650, 0x3b8f9650, + 0x3ab31f0c, 0x3ab31f0c, 0x3ab31f0c, 0x3ab31f0c, 0x3ab31f0c, 0xbad81b93, 0xbad81b93, 0xbad81b93, + 0xbad81b93, 0xbad81b93, 0xbb98d56c, 0xbb98d56c, 0xbb98d56c, 0xbb98d56c, 0xbb98d56c, 0xbbfba398, + 0xbbfba398, 0xbbfba398, 0xbbfba398, 0xbbfba398, 0x3ba18cf1, 0x3ba18cf1, 0x3ba18cf1, 0x3ba18cf1, + 0x3ba18cf1, 0x3afaf9bb, 0x3afaf9bb, 0x3afaf9bb, 0x3afaf9bb, 0x3afaf9bb, 0xba9040e1, 0xba9040e1, + 0xba9040e1, 0xba9040e1, 0xba9040e1, 0xbb86deca, 0xbb86deca, 0xbb86deca, 0xbb86deca, 0xbb86deca, + 0xbbe9ad0b, 0xbbe9ad0b, 0xbbe9ad0b, 0xbbe9ad0b, 0xbbe9ad0b, 0x3bb3838e, 0x3bb3838e, 0x3bb3838e, + 0x3bb3838e, 0x3bb3838e, 0x3b216a33, 0x3b216a33, 0x3b216a33, 0x3b216a33, 0x3b216a33, 0xba10cc5a, + 0xba10cc5a, 0xba10cc5a, 0xba10cc5a, 0xba10cc5a, 0xbb69d04a, 0xbb69d04a, 0xbb69d04a, 0xbb69d04a, + 0xbb69d04a, 0xbbd7b679, 0xbbd7b679, 0xbbd7b679, 0xbbd7b679, 0xbbd7b679, 0x3bc57a28, 0x3bc57a28, + 0x3bc57a28, 0x3bc57a28, 0x3bc57a28, 0x3b455785, 0x3b455785, 0x3b455785, 0x3b455785, 0x3b455785, +] )) ), + +################ chunk 5120 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481db177, 0x481db177, 0x481db177, + 0x481db177, 0x481db177, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e4e8c, + 0x481e4e8c, 0x481e4e8c, 0x481e4e8c, 0x481e4e8c, 0x481e9d16, 0x481e9d16, 0x481e9d16, 0x481e9d16, + 0x481e9d16, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481f3a2a, 0x481f3a2a, + 0x481f3a2a, 0x481f3a2a, 0x481f3a2a, 0x481f88b4, 0x481f88b4, 0x481f88b4, 0x481f88b4, 0x481f88b4, + 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x482025c9, 0x482025c9, 0x482025c9, + 0x482025c9, 0x482025c9, 0x48207453, 0x48207453, 0x48207453, 0x48207453, 0x48207453, 0x4820c2dd, + 0x4820c2dd, 0x4820c2dd, 0x4820c2dd, 0x4820c2dd, 0x48211167, 0x48211167, 0x48211167, 0x48211167, + 0x48211167, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x4821ae7c, 0x4821ae7c, + 0x4821ae7c, 0x4821ae7c, 0x4821ae7c, 0x4821fd06, 0x4821fd06, 0x4821fd06, 0x4821fd06, 0x4821fd06, + 0x48224b90, 0x48224b90, 0x48224b90, 0x48224b90, 0x48224b90, 0x48229a1a, 0x48229a1a, 0x48229a1a, + 0x48229a1a, 0x48229a1a, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4823372f, + 0x4823372f, 0x4823372f, 0x4823372f, 0x4823372f, 0x482385b9, 0x482385b9, 0x482385b9, 0x482385b9, + 0x482385b9, 0x4823d443, 0x4823d443, 0x4823d443, 0x4823d443, 0x4823d443, 0x482422cd, 0x482422cd, + 0x482422cd, 0x482422cd, 0x482422cd, 0x48247157, 0x48247157, 0x48247157, 0x48247157, 0x48247157, + 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x48250e6c, 0x48250e6c, 0x48250e6c, + 0x48250e6c, 0x48250e6c, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x4825ab80, + 0x4825ab80, 0x4825ab80, 0x4825ab80, 0x4825ab80, 0x4825fa0a, 0x4825fa0a, 0x4825fa0a, 0x4825fa0a, + 0x4825fa0a, 0x48264895, 0x48264895, 0x48264895, 0x48264895, 0x48264895, 0x4826971f, 0x4826971f, + 0x4826971f, 0x4826971f, 0x4826971f, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, + 0x48273433, 0x48273433, 0x48273433, 0x48273433, 0x48273433, 0x482782bd, 0x482782bd, 0x482782bd, + 0x482782bd, 0x482782bd, 0x4827d148, 0x4827d148, 0x4827d148, 0x4827d148, 0x4827d148, 0x48281fd2, + 0x48281fd2, 0x48281fd2, 0x48281fd2, 0x48281fd2, 0x48286e5c, 0x48286e5c, 0x48286e5c, 0x48286e5c, + 0x48286e5c, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x48290b70, 0x48290b70, + 0x48290b70, 0x48290b70, 0x48290b70, 0x482959fb, 0x482959fb, 0x482959fb, 0x482959fb, 0x482959fb, + 0x4829a885, 0x4829a885, 0x4829a885, 0x4829a885, 0x4829a885, 0x4829f70f, 0x4829f70f, 0x4829f70f, + 0x4829f70f, 0x4829f70f, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a9423, + 0x482a9423, 0x482a9423, 0x482a9423, 0x482a9423, 0x482ae2ad, 0x482ae2ad, 0x482ae2ad, 0x482ae2ad, + 0x482ae2ad, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b7fc2, 0x482b7fc2, + 0x482b7fc2, 0x482b7fc2, 0x482b7fc2, 0x482bce4c, 0x482bce4c, 0x482bce4c, 0x482bce4c, 0x482bce4c, + 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c6b60, 0x482c6b60, 0x482c6b60, + 0x482c6b60, 0x482c6b60, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482d0875, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xb68b7725, 0xb68b7725, 0xb68b7725, 0xb68b7725, 0xb68b7725, 0xbb45e2fc, 0xbb45e2fc, 0xbb45e2fc, + 0xbb45e2fc, 0xbb45e2fc, 0xbbc5bfe3, 0xbbc5bfe3, 0xbbc5bfe3, 0xbbc5bfe3, 0xbbc5bfe3, 0x3bd770be, + 0x3bd770be, 0x3bd770be, 0x3bd770be, 0x3bd770be, 0x3b6944d3, 0x3b6944d3, 0x3b6944d3, 0x3b6944d3, + 0x3b6944d3, 0x3a0e9e7d, 0x3a0e9e7d, 0x3a0e9e7d, 0x3a0e9e7d, 0x3a0e9e7d, 0xbb21f5aa, 0xbb21f5aa, + 0xbb21f5aa, 0xbb21f5aa, 0xbb21f5aa, 0xbbb3c949, 0xbbb3c949, 0xbbb3c949, 0xbbb3c949, 0xbbb3c949, + 0x3be96750, 0x3be96750, 0x3be96750, 0x3be96750, 0x3be96750, 0x3b86990e, 0x3b86990e, 0x3b86990e, + 0x3b86990e, 0x3b86990e, 0x3a8f29f3, 0x3a8f29f3, 0x3a8f29f3, 0x3a8f29f3, 0x3a8f29f3, 0xbafc10a9, + 0xbafc10a9, 0xbafc10a9, 0xbafc10a9, 0xbafc10a9, 0xbba1d2ac, 0xbba1d2ac, 0xbba1d2ac, 0xbba1d2ac, + 0xbba1d2ac, 0x3bfb5ddd, 0x3bfb5ddd, 0x3bfb5ddd, 0x3bfb5ddd, 0x3bfb5ddd, 0x3b988fb1, 0x3b988fb1, + 0x3b988fb1, 0x3b988fb1, 0x3b988fb1, 0x3ad704a4, 0x3ad704a4, 0x3ad704a4, 0x3ad704a4, 0x3ad704a4, + 0xbab435fa, 0xbab435fa, 0xbab435fa, 0xbab435fa, 0xbab435fa, 0xbb8fdc0b, 0xbb8fdc0b, 0xbb8fdc0b, + 0xbb8fdc0b, 0xbb8fdc0b, 0xbbf2aa42, 0xbbf2aa42, 0xbbf2aa42, 0xbbf2aa42, 0xbbf2aa42, 0x3baa8650, + 0x3baa8650, 0x3baa8650, 0x3baa8650, 0x3baa8650, 0x3b0f6fa9, 0x3b0f6fa9, 0x3b0f6fa9, 0x3b0f6fa9, + 0x3b0f6fa9, 0xba58b68e, 0xba58b68e, 0xba58b68e, 0xba58b68e, 0xba58b68e, 0xbb7bcacf, 0xbb7bcacf, + 0xbb7bcacf, 0xbb7bcacf, 0xbb7bcacf, 0xbbe0b3b3, 0xbbe0b3b3, 0xbbe0b3b3, 0xbbe0b3b3, 0xbbe0b3b3, + 0x3bbc7cec, 0x3bbc7cec, 0x3bbc7cec, 0x3bbc7cec, 0x3bbc7cec, 0x3b335cfd, 0x3b335cfd, 0x3b335cfd, + 0x3b335cfd, 0x3b335cfd, 0xb9920246, 0xb9920246, 0xb9920246, 0xb9920246, 0xb9920246, 0xbb57dd83, + 0xbb57dd83, 0xbb57dd83, 0xbb57dd83, 0xbb57dd83, 0xbbcebd1f, 0xbbcebd1f, 0xbbcebd1f, 0xbbcebd1f, + 0xbbcebd1f, 0x3bce7384, 0x3bce7384, 0x3bce7384, 0x3bce7384, 0x3bce7384, 0x3b574a4d, 0x3b574a4d, + 0x3b574a4d, 0x3b574a4d, 0x3b574a4d, 0x398d6891, 0x398d6891, 0x398d6891, 0x398d6891, 0x398d6891, + 0xbb33f033, 0xbb33f033, 0xbb33f033, 0xbb33f033, 0xbb33f033, 0xbbbcc687, 0xbbbcc687, 0xbbbcc687, + 0xbbbcc687, 0xbbbcc687, 0x3be06a18, 0x3be06a18, 0x3be06a18, 0x3be06a18, 0x3be06a18, 0x3b7b3799, + 0x3b7b3799, 0x3b7b3799, 0x3b7b3799, 0x3b7b3799, 0x3a5669b3, 0x3a5669b3, 0x3a5669b3, 0x3a5669b3, + 0x3a5669b3, 0xbb1002df, 0xbb1002df, 0xbb1002df, 0xbb1002df, 0xbb1002df, 0xbbaacfeb, 0xbbaacfeb, + 0xbbaacfeb, 0xbbaacfeb, 0xbbaacfeb, 0x3bf260a7, 0x3bf260a7, 0x3bf260a7, 0x3bf260a7, 0x3bf260a7, + 0x3b8f9270, 0x3b8f9270, 0x3b8f9270, 0x3b8f9270, 0x3b8f9270, 0x3ab30f8d, 0x3ab30f8d, 0x3ab30f8d, + 0x3ab30f8d, 0x3ab30f8d, 0xbad82b12, 0xbad82b12, 0xbad82b12, 0xbad82b12, 0xbad82b12, 0xbb98d94c, + 0xbb98d94c, 0xbb98d94c, 0xbb98d94c, 0xbb98d94c, 0xbbfba778, 0xbbfba778, 0xbbfba778, 0xbbfba778, + 0xbbfba778, 0x3ba18911, 0x3ba18911, 0x3ba18911, 0x3ba18911, 0x3ba18911, 0x3afaea3c, 0x3afaea3c, + 0x3afaea3c, 0x3afaea3c, 0x3afaea3c, 0xba905060, 0xba905060, 0xba905060, 0xba905060, 0xba905060, + 0xbb86e2aa, 0xbb86e2aa, 0xbb86e2aa, 0xbb86e2aa, 0xbb86e2aa, 0xbbe9b0eb, 0xbbe9b0eb, 0xbbe9b0eb, + 0xbbe9b0eb, 0xbbe9b0eb, 0x3bb37fae, 0x3bb37fae, 0x3bb37fae, 0x3bb37fae, 0x3bb37fae, 0x3b216273, +] )) ), + +################ chunk 5632 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x482d0875, 0x482d0875, 0x482d0875, 0x482d0875, 0x482d56ff, 0x482d56ff, 0x482d56ff, 0x482d56ff, + 0x482d56ff, 0x482da589, 0x482da589, 0x482da589, 0x482da589, 0x482da589, 0x482df413, 0x482df413, + 0x482df413, 0x482df413, 0x482df413, 0x482e429e, 0x482e429e, 0x482e429e, 0x482e429e, 0x482e429e, + 0x482e9128, 0x482e9128, 0x482e9128, 0x482e9128, 0x482e9128, 0x482edfb2, 0x482edfb2, 0x482edfb2, + 0x482edfb2, 0x482edfb2, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f7cc6, + 0x482f7cc6, 0x482f7cc6, 0x482f7cc6, 0x482f7cc6, 0x482fcb51, 0x482fcb51, 0x482fcb51, 0x482fcb51, + 0x482fcb51, 0x483019db, 0x483019db, 0x483019db, 0x483019db, 0x483019db, 0x48306865, 0x48306865, + 0x48306865, 0x48306865, 0x48306865, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, + 0x48310579, 0x48310579, 0x48310579, 0x48310579, 0x48310579, 0x48315404, 0x48315404, 0x48315404, + 0x48315404, 0x48315404, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831f118, + 0x4831f118, 0x4831f118, 0x4831f118, 0x4831f118, 0x48323fa2, 0x48323fa2, 0x48323fa2, 0x48323fa2, + 0x48323fa2, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x4832dcb7, 0x4832dcb7, + 0x4832dcb7, 0x4832dcb7, 0x4832dcb7, 0x48332b41, 0x48332b41, 0x48332b41, 0x48332b41, 0x48332b41, + 0x483379cb, 0x483379cb, 0x483379cb, 0x483379cb, 0x483379cb, 0x4833c855, 0x4833c855, 0x4833c855, + 0x4833c855, 0x4833c855, 0x483416df, 0x483416df, 0x483416df, 0x483416df, 0x483416df, 0x48346569, + 0x48346569, 0x48346569, 0x48346569, 0x48346569, 0x4834b3f4, 0x4834b3f4, 0x4834b3f4, 0x4834b3f4, + 0x4834b3f4, 0x4835027e, 0x4835027e, 0x4835027e, 0x4835027e, 0x4835027e, 0x48355108, 0x48355108, + 0x48355108, 0x48355108, 0x48355108, 0x48359f92, 0x48359f92, 0x48359f92, 0x48359f92, 0x48359f92, + 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x48363ca7, 0x48363ca7, 0x48363ca7, + 0x48363ca7, 0x48363ca7, 0x48368b31, 0x48368b31, 0x48368b31, 0x48368b31, 0x48368b31, 0x4836d9bb, + 0x4836d9bb, 0x4836d9bb, 0x4836d9bb, 0x4836d9bb, 0x48372845, 0x48372845, 0x48372845, 0x48372845, + 0x48372845, 0x483776cf, 0x483776cf, 0x483776cf, 0x483776cf, 0x483776cf, 0x4837c55a, 0x4837c55a, + 0x4837c55a, 0x4837c55a, 0x4837c55a, 0x483813e4, 0x483813e4, 0x483813e4, 0x483813e4, 0x483813e4, + 0x4838626e, 0x4838626e, 0x4838626e, 0x4838626e, 0x4838626e, 0x4838b0f8, 0x4838b0f8, 0x4838b0f8, + 0x4838b0f8, 0x4838b0f8, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x48394e0d, + 0x48394e0d, 0x48394e0d, 0x48394e0d, 0x48394e0d, 0x48399c97, 0x48399c97, 0x48399c97, 0x48399c97, + 0x48399c97, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x483a39ab, 0x483a39ab, + 0x483a39ab, 0x483a39ab, 0x483a39ab, 0x483a8835, 0x483a8835, 0x483a8835, 0x483a8835, 0x483a8835, + 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483b254a, 0x483b254a, 0x483b254a, + 0x483b254a, 0x483b254a, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483bc25e, + 0x483bc25e, 0x483bc25e, 0x483bc25e, 0x483bc25e, 0x483c10e8, 0x483c10e8, 0x483c10e8, 0x483c10e8, + 0x483c10e8, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483cadfd, 0x483cadfd, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3b216273, 0x3b216273, 0x3b216273, 0x3b216273, 0xba10eb58, 0xba10eb58, 0xba10eb58, 0xba10eb58, + 0xba10eb58, 0xbb69d80a, 0xbb69d80a, 0xbb69d80a, 0xbb69d80a, 0xbb69d80a, 0xbbd7ba59, 0xbbd7ba59, + 0xbbd7ba59, 0xbbd7ba59, 0xbbd7ba59, 0x3bc57648, 0x3bc57648, 0x3bc57648, 0x3bc57648, 0x3bc57648, + 0x3b454fc6, 0x3b454fc6, 0x3b454fc6, 0x3b454fc6, 0x3b454fc6, 0xb69af629, 0xb69af629, 0xb69af629, + 0xb69af629, 0xb69af629, 0xbb45eabc, 0xbb45eabc, 0xbb45eabc, 0xbb45eabc, 0xbb45eabc, 0xbbc5c3c3, + 0xbbc5c3c3, 0xbbc5c3c3, 0xbbc5c3c3, 0xbbc5c3c3, 0x3bd76cde, 0x3bd76cde, 0x3bd76cde, 0x3bd76cde, + 0x3bd76cde, 0x3b693d14, 0x3b693d14, 0x3b693d14, 0x3b693d14, 0x3b693d14, 0x3a0e7f7f, 0x3a0e7f7f, + 0x3a0e7f7f, 0x3a0e7f7f, 0x3a0e7f7f, 0xbb21fd69, 0xbb21fd69, 0xbb21fd69, 0xbb21fd69, 0xbb21fd69, + 0xbbb3cd29, 0xbbb3cd29, 0xbbb3cd29, 0xbbb3cd29, 0xbbb3cd29, 0x3be96370, 0x3be96370, 0x3be96370, + 0x3be96370, 0x3be96370, 0x3b86952f, 0x3b86952f, 0x3b86952f, 0x3b86952f, 0x3b86952f, 0x3a8f1a74, + 0x3a8f1a74, 0x3a8f1a74, 0x3a8f1a74, 0x3a8f1a74, 0xbafc2028, 0xbafc2028, 0xbafc2028, 0xbafc2028, + 0xbafc2028, 0xbba1d68c, 0xbba1d68c, 0xbba1d68c, 0xbba1d68c, 0xbba1d68c, 0x3bfb59fe, 0x3bfb59fe, + 0x3bfb59fe, 0x3bfb59fe, 0x3bfb59fe, 0x3b988bd1, 0x3b988bd1, 0x3b988bd1, 0x3b988bd1, 0x3b988bd1, + 0x3ad6f525, 0x3ad6f525, 0x3ad6f525, 0x3ad6f525, 0x3ad6f525, 0xbab44579, 0xbab44579, 0xbab44579, + 0xbab44579, 0xbab44579, 0xbb8fdfeb, 0xbb8fdfeb, 0xbb8fdfeb, 0xbb8fdfeb, 0xbb8fdfeb, 0xbbf2ae22, + 0xbbf2ae22, 0xbbf2ae22, 0xbbf2ae22, 0xbbf2ae22, 0x3baa8270, 0x3baa8270, 0x3baa8270, 0x3baa8270, + 0x3baa8270, 0x3b0f67e9, 0x3b0f67e9, 0x3b0f67e9, 0x3b0f67e9, 0x3b0f67e9, 0xba58d58c, 0xba58d58c, + 0xba58d58c, 0xba58d58c, 0xba58d58c, 0xbb7bd28f, 0xbb7bd28f, 0xbb7bd28f, 0xbb7bd28f, 0xbb7bd28f, + 0xbbe0b792, 0xbbe0b792, 0xbbe0b792, 0xbbe0b792, 0xbbe0b792, 0x3bbc790c, 0x3bbc790c, 0x3bbc790c, + 0x3bbc790c, 0x3bbc790c, 0x3b33553d, 0x3b33553d, 0x3b33553d, 0x3b33553d, 0x3b33553d, 0xb9924043, + 0xb9924043, 0xb9924043, 0xb9924043, 0xb9924043, 0xbb57e543, 0xbb57e543, 0xbb57e543, 0xbb57e543, + 0xbb57e543, 0xbbcec0fe, 0xbbcec0fe, 0xbbcec0fe, 0xbbcec0fe, 0xbbcec0fe, 0x3bce6fa4, 0x3bce6fa4, + 0x3bce6fa4, 0x3bce6fa4, 0x3bce6fa4, 0x3b57428d, 0x3b57428d, 0x3b57428d, 0x3b57428d, 0x3b57428d, + 0x398d2a95, 0x398d2a95, 0x398d2a95, 0x398d2a95, 0x398d2a95, 0xbb33f7f3, 0xbb33f7f3, 0xbb33f7f3, + 0xbb33f7f3, 0xbb33f7f3, 0xbbbcca66, 0xbbbcca66, 0xbbbcca66, 0xbbbcca66, 0xbbbcca66, 0x3be06638, + 0x3be06638, 0x3be06638, 0x3be06638, 0x3be06638, 0x3b7b2fda, 0x3b7b2fda, 0x3b7b2fda, 0x3b7b2fda, + 0x3b7b2fda, 0x3a564ab5, 0x3a564ab5, 0x3a564ab5, 0x3a564ab5, 0x3a564ab5, 0xbb100a9f, 0xbb100a9f, + 0xbb100a9f, 0xbb100a9f, 0xbb100a9f, 0xbbaad3cb, 0xbbaad3cb, 0xbbaad3cb, 0xbbaad3cb, 0xbbaad3cb, + 0x3bf25cc8, 0x3bf25cc8, 0x3bf25cc8, 0x3bf25cc8, 0x3bf25cc8, 0x3b8f8e90, 0x3b8f8e90, 0x3b8f8e90, + 0x3b8f8e90, 0x3b8f8e90, 0x3ab3000e, 0x3ab3000e, 0x3ab3000e, 0x3ab3000e, 0x3ab3000e, 0xbad83a91, + 0xbad83a91, 0xbad83a91, 0xbad83a91, 0xbad83a91, 0xbb98dd2c, 0xbb98dd2c, 0xbb98dd2c, 0xbb98dd2c, + 0xbb98dd2c, 0xbbfbab58, 0xbbfbab58, 0xbbfbab58, 0xbbfbab58, 0xbbfbab58, 0x3ba18531, 0x3ba18531, +] )) ), + +################ chunk 6144 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x483cadfd, 0x483cadfd, 0x483cadfd, 0x483cfc87, 0x483cfc87, 0x483cfc87, 0x483cfc87, 0x483cfc87, + 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d999b, 0x483d999b, 0x483d999b, + 0x483d999b, 0x483d999b, 0x483de825, 0x483de825, 0x483de825, 0x483de825, 0x483de825, 0x483e36b0, + 0x483e36b0, 0x483e36b0, 0x483e36b0, 0x483e36b0, 0x483e853a, 0x483e853a, 0x483e853a, 0x483e853a, + 0x483e853a, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483f224e, 0x483f224e, + 0x483f224e, 0x483f224e, 0x483f224e, 0x483f70d8, 0x483f70d8, 0x483f70d8, 0x483f70d8, 0x483f70d8, + 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x48400ded, 0x48400ded, 0x48400ded, + 0x48400ded, 0x48400ded, 0x48405c77, 0x48405c77, 0x48405c77, 0x48405c77, 0x48405c77, 0x4840ab01, + 0x4840ab01, 0x4840ab01, 0x4840ab01, 0x4840ab01, 0x4840f98b, 0x4840f98b, 0x4840f98b, 0x4840f98b, + 0x4840f98b, 0x48414816, 0x48414816, 0x48414816, 0x48414816, 0x48414816, 0x484196a0, 0x484196a0, + 0x484196a0, 0x484196a0, 0x484196a0, 0x4841e52a, 0x4841e52a, 0x4841e52a, 0x4841e52a, 0x4841e52a, + 0x484233b4, 0x484233b4, 0x484233b4, 0x484233b4, 0x484233b4, 0x4842823e, 0x4842823e, 0x4842823e, + 0x4842823e, 0x4842823e, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x48431f53, + 0x48431f53, 0x48431f53, 0x48431f53, 0x48431f53, 0x48436ddd, 0x48436ddd, 0x48436ddd, 0x48436ddd, + 0x48436ddd, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x48440af1, 0x48440af1, + 0x48440af1, 0x48440af1, 0x48440af1, 0x4844597c, 0x4844597c, 0x4844597c, 0x4844597c, 0x4844597c, + 0x4844a806, 0x4844a806, 0x4844a806, 0x4844a806, 0x4844a806, 0x4844f690, 0x4844f690, 0x4844f690, + 0x4844f690, 0x4844f690, 0x4845451a, 0x4845451a, 0x4845451a, 0x4845451a, 0x4845451a, 0x484593a4, + 0x484593a4, 0x484593a4, 0x484593a4, 0x484593a4, 0x4845e22e, 0x4845e22e, 0x4845e22e, 0x4845e22e, + 0x4845e22e, 0x484630b9, 0x484630b9, 0x484630b9, 0x484630b9, 0x484630b9, 0x48467f43, 0x48467f43, + 0x48467f43, 0x48467f43, 0x48467f43, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, + 0x48471c57, 0x48471c57, 0x48471c57, 0x48471c57, 0x48471c57, 0x48476ae1, 0x48476ae1, 0x48476ae1, + 0x48476ae1, 0x48476ae1, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x484807f6, + 0x484807f6, 0x484807f6, 0x484807f6, 0x484807f6, 0x48485680, 0x48485680, 0x48485680, 0x48485680, + 0x48485680, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848f394, 0x4848f394, + 0x4848f394, 0x4848f394, 0x4848f394, 0x4849421f, 0x4849421f, 0x4849421f, 0x4849421f, 0x4849421f, + 0x484990a9, 0x484990a9, 0x484990a9, 0x484990a9, 0x484990a9, 0x4849df33, 0x4849df33, 0x4849df33, + 0x4849df33, 0x4849df33, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a7c47, + 0x484a7c47, 0x484a7c47, 0x484a7c47, 0x484a7c47, 0x484acad2, 0x484acad2, 0x484acad2, 0x484acad2, + 0x484acad2, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b67e6, 0x484b67e6, + 0x484b67e6, 0x484b67e6, 0x484b67e6, 0x484bb670, 0x484bb670, 0x484bb670, 0x484bb670, 0x484bb670, + 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c5385, 0x484c5385, 0x484c5385, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3ba18531, 0x3ba18531, 0x3ba18531, 0x3afadabd, 0x3afadabd, 0x3afadabd, 0x3afadabd, 0x3afadabd, + 0xba905fdf, 0xba905fdf, 0xba905fdf, 0xba905fdf, 0xba905fdf, 0xbb86e689, 0xbb86e689, 0xbb86e689, + 0xbb86e689, 0xbb86e689, 0xbbe9b4cb, 0xbbe9b4cb, 0xbbe9b4cb, 0xbbe9b4cb, 0xbbe9b4cb, 0x3bb37bcf, + 0x3bb37bcf, 0x3bb37bcf, 0x3bb37bcf, 0x3bb37bcf, 0x3b215ab4, 0x3b215ab4, 0x3b215ab4, 0x3b215ab4, + 0x3b215ab4, 0xba110a56, 0xba110a56, 0xba110a56, 0xba110a56, 0xba110a56, 0xbb69dfc9, 0xbb69dfc9, + 0xbb69dfc9, 0xbb69dfc9, 0xbb69dfc9, 0xbbd7be39, 0xbbd7be39, 0xbbd7be39, 0xbbd7be39, 0xbbd7be39, + 0x3bc57269, 0x3bc57269, 0x3bc57269, 0x3bc57269, 0x3bc57269, 0x3b454806, 0x3b454806, 0x3b454806, + 0x3b454806, 0x3b454806, 0xb6aa752d, 0xb6aa752d, 0xb6aa752d, 0xb6aa752d, 0xb6aa752d, 0xbb45f27b, + 0xbb45f27b, 0xbb45f27b, 0xbb45f27b, 0xbb45f27b, 0xbbc5c7a3, 0xbbc5c7a3, 0xbbc5c7a3, 0xbbc5c7a3, + 0xbbc5c7a3, 0x3bd768ff, 0x3bd768ff, 0x3bd768ff, 0x3bd768ff, 0x3bd768ff, 0x3b693554, 0x3b693554, + 0x3b693554, 0x3b693554, 0x3b693554, 0x3a0e6081, 0x3a0e6081, 0x3a0e6081, 0x3a0e6081, 0x3a0e6081, + 0xbb220529, 0xbb220529, 0xbb220529, 0xbb220529, 0xbb220529, 0xbbb3d109, 0xbbb3d109, 0xbbb3d109, + 0xbbb3d109, 0xbbb3d109, 0x3be95f91, 0x3be95f91, 0x3be95f91, 0x3be95f91, 0x3be95f91, 0x3b86914f, + 0x3b86914f, 0x3b86914f, 0x3b86914f, 0x3b86914f, 0x3a8f0af5, 0x3a8f0af5, 0x3a8f0af5, 0x3a8f0af5, + 0x3a8f0af5, 0xbafc2fa7, 0xbafc2fa7, 0xbafc2fa7, 0xbafc2fa7, 0xbafc2fa7, 0xbba1da6b, 0xbba1da6b, + 0xbba1da6b, 0xbba1da6b, 0xbba1da6b, 0x3bfb561e, 0x3bfb561e, 0x3bfb561e, 0x3bfb561e, 0x3bfb561e, + 0x3b9887f1, 0x3b9887f1, 0x3b9887f1, 0x3b9887f1, 0x3b9887f1, 0x3ad6e5a6, 0x3ad6e5a6, 0x3ad6e5a6, + 0x3ad6e5a6, 0x3ad6e5a6, 0xbab454f8, 0xbab454f8, 0xbab454f8, 0xbab454f8, 0xbab454f8, 0xbb8fe3cb, + 0xbb8fe3cb, 0xbb8fe3cb, 0xbb8fe3cb, 0xbb8fe3cb, 0xbbf2b202, 0xbbf2b202, 0xbbf2b202, 0xbbf2b202, + 0xbbf2b202, 0x3baa7e90, 0x3baa7e90, 0x3baa7e90, 0x3baa7e90, 0x3baa7e90, 0x3b0f602a, 0x3b0f602a, + 0x3b0f602a, 0x3b0f602a, 0x3b0f602a, 0xba58f48a, 0xba58f48a, 0xba58f48a, 0xba58f48a, 0xba58f48a, + 0xbb7bda4e, 0xbb7bda4e, 0xbb7bda4e, 0xbb7bda4e, 0xbb7bda4e, 0xbbe0bb72, 0xbbe0bb72, 0xbbe0bb72, + 0xbbe0bb72, 0xbbe0bb72, 0x3bbc752c, 0x3bbc752c, 0x3bbc752c, 0x3bbc752c, 0x3bbc752c, 0x3b334d7e, + 0x3b334d7e, 0x3b334d7e, 0x3b334d7e, 0x3b334d7e, 0xb9927e3f, 0xb9927e3f, 0xb9927e3f, 0xb9927e3f, + 0xb9927e3f, 0xbb57ed02, 0xbb57ed02, 0xbb57ed02, 0xbb57ed02, 0xbb57ed02, 0xbbcec4de, 0xbbcec4de, + 0xbbcec4de, 0xbbcec4de, 0xbbcec4de, 0x3bce6bc4, 0x3bce6bc4, 0x3bce6bc4, 0x3bce6bc4, 0x3bce6bc4, + 0x3b573ace, 0x3b573ace, 0x3b573ace, 0x3b573ace, 0x3b573ace, 0x398cec99, 0x398cec99, 0x398cec99, + 0x398cec99, 0x398cec99, 0xbb33ffb2, 0xbb33ffb2, 0xbb33ffb2, 0xbb33ffb2, 0xbb33ffb2, 0xbbbcce46, + 0xbbbcce46, 0xbbbcce46, 0xbbbcce46, 0xbbbcce46, 0x3be06258, 0x3be06258, 0x3be06258, 0x3be06258, + 0x3be06258, 0x3b7b281a, 0x3b7b281a, 0x3b7b281a, 0x3b7b281a, 0x3b7b281a, 0x3a562bb7, 0x3a562bb7, + 0x3a562bb7, 0x3a562bb7, 0x3a562bb7, 0xbb10125e, 0xbb10125e, 0xbb10125e, 0xbb10125e, 0xbb10125e, + 0xbbaad7aa, 0xbbaad7aa, 0xbbaad7aa, 0xbbaad7aa, 0xbbaad7aa, 0x3bf258e8, 0x3bf258e8, 0x3bf258e8, +] )) ), + +################ chunk 6656 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x484c5385, 0x484c5385, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484cf099, + 0x484cf099, 0x484cf099, 0x484cf099, 0x484cf099, 0x484d3f23, 0x484d3f23, 0x484d3f23, 0x484d3f23, + 0x484d3f23, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484ddc37, 0x484ddc37, + 0x484ddc37, 0x484ddc37, 0x484ddc37, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, + 0x484e794c, 0x484e794c, 0x484e794c, 0x484e794c, 0x484e794c, 0x484ec7d6, 0x484ec7d6, 0x484ec7d6, + 0x484ec7d6, 0x484ec7d6, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f64ea, + 0x484f64ea, 0x484f64ea, 0x484f64ea, 0x484f64ea, 0x484fb375, 0x484fb375, 0x484fb375, 0x484fb375, + 0x484fb375, 0x485001ff, 0x485001ff, 0x485001ff, 0x485001ff, 0x485001ff, 0x48505089, 0x48505089, + 0x48505089, 0x48505089, 0x48505089, 0x48509f13, 0x48509f13, 0x48509f13, 0x48509f13, 0x48509f13, + 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x48513c28, 0x48513c28, 0x48513c28, + 0x48513c28, 0x48513c28, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x4851d93c, + 0x4851d93c, 0x4851d93c, 0x4851d93c, 0x4851d93c, 0x485227c6, 0x485227c6, 0x485227c6, 0x485227c6, + 0x485227c6, 0x48527650, 0x48527650, 0x48527650, 0x48527650, 0x48527650, 0x4852c4db, 0x4852c4db, + 0x4852c4db, 0x4852c4db, 0x4852c4db, 0x48531365, 0x48531365, 0x48531365, 0x48531365, 0x48531365, + 0x485361ef, 0x485361ef, 0x485361ef, 0x485361ef, 0x485361ef, 0x4853b079, 0x4853b079, 0x4853b079, + 0x4853b079, 0x4853b079, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x48544d8e, + 0x48544d8e, 0x48544d8e, 0x48544d8e, 0x48544d8e, 0x48549c18, 0x48549c18, 0x48549c18, 0x48549c18, + 0x48549c18, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4855392c, 0x4855392c, + 0x4855392c, 0x4855392c, 0x4855392c, 0x485587b6, 0x485587b6, 0x485587b6, 0x485587b6, 0x485587b6, + 0x4855d641, 0x4855d641, 0x4855d641, 0x4855d641, 0x4855d641, 0x485624cb, 0x485624cb, 0x485624cb, + 0x485624cb, 0x485624cb, 0x48567355, 0x48567355, 0x48567355, 0x48567355, 0x48567355, 0x4856c1df, + 0x4856c1df, 0x4856c1df, 0x4856c1df, 0x4856c1df, 0x48571069, 0x48571069, 0x48571069, 0x48571069, + 0x48571069, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x4857ad7e, 0x4857ad7e, + 0x4857ad7e, 0x4857ad7e, 0x4857ad7e, 0x4857fc08, 0x4857fc08, 0x4857fc08, 0x4857fc08, 0x4857fc08, + 0x48584a92, 0x48584a92, 0x48584a92, 0x48584a92, 0x48584a92, 0x4858991c, 0x4858991c, 0x4858991c, + 0x4858991c, 0x4858991c, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x48593631, + 0x48593631, 0x48593631, 0x48593631, 0x48593631, 0x485984bb, 0x485984bb, 0x485984bb, 0x485984bb, + 0x485984bb, 0x4859d345, 0x4859d345, 0x4859d345, 0x4859d345, 0x4859d345, 0x485a21cf, 0x485a21cf, + 0x485a21cf, 0x485a21cf, 0x485a21cf, 0x485a7059, 0x485a7059, 0x485a7059, 0x485a7059, 0x485a7059, + 0x485abee4, 0x485abee4, 0x485abee4, 0x485abee4, 0x485abee4, 0x485b0d6e, 0x485b0d6e, 0x485b0d6e, + 0x485b0d6e, 0x485b0d6e, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485baa82, + 0x485baa82, 0x485baa82, 0x485baa82, 0x485baa82, 0x485bf90c, 0x485bf90c, 0x485bf90c, 0x485bf90c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3bf258e8, 0x3bf258e8, 0x3b8f8ab1, 0x3b8f8ab1, 0x3b8f8ab1, 0x3b8f8ab1, 0x3b8f8ab1, 0x3ab2f08f, + 0x3ab2f08f, 0x3ab2f08f, 0x3ab2f08f, 0x3ab2f08f, 0xbad84a10, 0xbad84a10, 0xbad84a10, 0xbad84a10, + 0xbad84a10, 0xbb98e10b, 0xbb98e10b, 0xbb98e10b, 0xbb98e10b, 0xbb98e10b, 0xbbfbaf38, 0xbbfbaf38, + 0xbbfbaf38, 0xbbfbaf38, 0xbbfbaf38, 0x3ba18151, 0x3ba18151, 0x3ba18151, 0x3ba18151, 0x3ba18151, + 0x3afacb3e, 0x3afacb3e, 0x3afacb3e, 0x3afacb3e, 0x3afacb3e, 0xba906f5e, 0xba906f5e, 0xba906f5e, + 0xba906f5e, 0xba906f5e, 0xbb86ea69, 0xbb86ea69, 0xbb86ea69, 0xbb86ea69, 0xbb86ea69, 0xbbe9b8aa, + 0xbbe9b8aa, 0xbbe9b8aa, 0xbbe9b8aa, 0xbbe9b8aa, 0x3bb377ef, 0x3bb377ef, 0x3bb377ef, 0x3bb377ef, + 0x3bb377ef, 0x3b2152f4, 0x3b2152f4, 0x3b2152f4, 0x3b2152f4, 0x3b2152f4, 0xba112954, 0xba112954, + 0xba112954, 0xba112954, 0xba112954, 0xbb69e789, 0xbb69e789, 0xbb69e789, 0xbb69e789, 0xbb69e789, + 0xbbd7c219, 0xbbd7c219, 0xbbd7c219, 0xbbd7c219, 0xbbd7c219, 0x3bc56e89, 0x3bc56e89, 0x3bc56e89, + 0x3bc56e89, 0x3bc56e89, 0x3b454047, 0x3b454047, 0x3b454047, 0x3b454047, 0x3b454047, 0xb6b9f432, + 0xb6b9f432, 0xb6b9f432, 0xb6b9f432, 0xb6b9f432, 0xbb45fa3b, 0xbb45fa3b, 0xbb45fa3b, 0xbb45fa3b, + 0xbb45fa3b, 0xbbc5cb83, 0xbbc5cb83, 0xbbc5cb83, 0xbbc5cb83, 0xbbc5cb83, 0x3bd7651f, 0x3bd7651f, + 0x3bd7651f, 0x3bd7651f, 0x3bd7651f, 0x3b692d95, 0x3b692d95, 0x3b692d95, 0x3b692d95, 0x3b692d95, + 0x3a0e4183, 0x3a0e4183, 0x3a0e4183, 0x3a0e4183, 0x3a0e4183, 0xbb220ce8, 0xbb220ce8, 0xbb220ce8, + 0xbb220ce8, 0xbb220ce8, 0xbbb3d4e9, 0xbbb3d4e9, 0xbbb3d4e9, 0xbbb3d4e9, 0xbbb3d4e9, 0x3be95bb1, + 0x3be95bb1, 0x3be95bb1, 0x3be95bb1, 0x3be95bb1, 0x3b868d6f, 0x3b868d6f, 0x3b868d6f, 0x3b868d6f, + 0x3b868d6f, 0x3a8efb76, 0x3a8efb76, 0x3a8efb76, 0x3a8efb76, 0x3a8efb76, 0xbafc3f26, 0xbafc3f26, + 0xbafc3f26, 0xbafc3f26, 0xbafc3f26, 0xbba1de4b, 0xbba1de4b, 0xbba1de4b, 0xbba1de4b, 0xbba1de4b, + 0x3bfb523e, 0x3bfb523e, 0x3bfb523e, 0x3bfb523e, 0x3bfb523e, 0x3b988411, 0x3b988411, 0x3b988411, + 0x3b988411, 0x3b988411, 0x3ad6d627, 0x3ad6d627, 0x3ad6d627, 0x3ad6d627, 0x3ad6d627, 0xbab46477, + 0xbab46477, 0xbab46477, 0xbab46477, 0xbab46477, 0xbb8fe7aa, 0xbb8fe7aa, 0xbb8fe7aa, 0xbb8fe7aa, + 0xbb8fe7aa, 0xbbf2b5e1, 0xbbf2b5e1, 0xbbf2b5e1, 0xbbf2b5e1, 0xbbf2b5e1, 0x3baa7ab1, 0x3baa7ab1, + 0x3baa7ab1, 0x3baa7ab1, 0x3baa7ab1, 0x3b0f586a, 0x3b0f586a, 0x3b0f586a, 0x3b0f586a, 0x3b0f586a, + 0xba591388, 0xba591388, 0xba591388, 0xba591388, 0xba591388, 0xbb7be20e, 0xbb7be20e, 0xbb7be20e, + 0xbb7be20e, 0xbb7be20e, 0xbbe0bf52, 0xbbe0bf52, 0xbbe0bf52, 0xbbe0bf52, 0xbbe0bf52, 0x3bbc714c, + 0x3bbc714c, 0x3bbc714c, 0x3bbc714c, 0x3bbc714c, 0x3b3345be, 0x3b3345be, 0x3b3345be, 0x3b3345be, + 0x3b3345be, 0xb992bc3b, 0xb992bc3b, 0xb992bc3b, 0xb992bc3b, 0xb992bc3b, 0xbb57f4c2, 0xbb57f4c2, + 0xbb57f4c2, 0xbb57f4c2, 0xbb57f4c2, 0xbbcec8be, 0xbbcec8be, 0xbbcec8be, 0xbbcec8be, 0xbbcec8be, + 0x3bce67e5, 0x3bce67e5, 0x3bce67e5, 0x3bce67e5, 0x3bce67e5, 0x3b57330f, 0x3b57330f, 0x3b57330f, + 0x3b57330f, 0x3b57330f, 0x398cae9d, 0x398cae9d, 0x398cae9d, 0x398cae9d, 0x398cae9d, 0xbb340772, + 0xbb340772, 0xbb340772, 0xbb340772, 0xbb340772, 0xbbbcd226, 0xbbbcd226, 0xbbbcd226, 0xbbbcd226, +] )) ), + +################ chunk 7168 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x485bf90c, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c9621, 0x485c9621, + 0x485c9621, 0x485c9621, 0x485c9621, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, + 0x485d3335, 0x485d3335, 0x485d3335, 0x485d3335, 0x485d3335, 0x485d81bf, 0x485d81bf, 0x485d81bf, + 0x485d81bf, 0x485d81bf, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485e1ed4, + 0x485e1ed4, 0x485e1ed4, 0x485e1ed4, 0x485e1ed4, 0x485e6d5e, 0x485e6d5e, 0x485e6d5e, 0x485e6d5e, + 0x485e6d5e, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485f0a72, 0x485f0a72, + 0x485f0a72, 0x485f0a72, 0x485f0a72, 0x485f58fc, 0x485f58fc, 0x485f58fc, 0x485f58fc, 0x485f58fc, + 0x485fa787, 0x485fa787, 0x485fa787, 0x485fa787, 0x485fa787, 0x485ff611, 0x485ff611, 0x485ff611, + 0x485ff611, 0x485ff611, 0x4860449b, 0x4860449b, 0x4860449b, 0x4860449b, 0x4860449b, 0x48609325, + 0x48609325, 0x48609325, 0x48609325, 0x48609325, 0x4860e1af, 0x4860e1af, 0x4860e1af, 0x4860e1af, + 0x4860e1af, 0x4861303a, 0x4861303a, 0x4861303a, 0x4861303a, 0x4861303a, 0x48617ec4, 0x48617ec4, + 0x48617ec4, 0x48617ec4, 0x48617ec4, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, + 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48626a62, 0x48626a62, 0x48626a62, + 0x48626a62, 0x48626a62, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x48630777, + 0x48630777, 0x48630777, 0x48630777, 0x48630777, 0x48635601, 0x48635601, 0x48635601, 0x48635601, + 0x48635601, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863f315, 0x4863f315, + 0x4863f315, 0x4863f315, 0x4863f315, 0x486441a0, 0x486441a0, 0x486441a0, 0x486441a0, 0x486441a0, + 0x4864902a, 0x4864902a, 0x4864902a, 0x4864902a, 0x4864902a, 0x4864deb4, 0x4864deb4, 0x4864deb4, + 0x4864deb4, 0x4864deb4, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48657bc8, + 0x48657bc8, 0x48657bc8, 0x48657bc8, 0x48657bc8, 0x4865ca53, 0x4865ca53, 0x4865ca53, 0x4865ca53, + 0x4865ca53, 0x486618dd, 0x486618dd, 0x486618dd, 0x486618dd, 0x486618dd, 0x48666767, 0x48666767, + 0x48666767, 0x48666767, 0x48666767, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, + 0x4867047b, 0x4867047b, 0x4867047b, 0x4867047b, 0x4867047b, 0x48675306, 0x48675306, 0x48675306, + 0x48675306, 0x48675306, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867f01a, + 0x4867f01a, 0x4867f01a, 0x4867f01a, 0x4867f01a, 0x48683ea4, 0x48683ea4, 0x48683ea4, 0x48683ea4, + 0x48683ea4, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x4868dbb8, 0x4868dbb8, + 0x4868dbb8, 0x4868dbb8, 0x4868dbb8, 0x48692a43, 0x48692a43, 0x48692a43, 0x48692a43, 0x48692a43, + 0x486978cd, 0x486978cd, 0x486978cd, 0x486978cd, 0x486978cd, 0x4869c757, 0x4869c757, 0x4869c757, + 0x4869c757, 0x4869c757, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a646b, + 0x486a646b, 0x486a646b, 0x486a646b, 0x486a646b, 0x486ab2f6, 0x486ab2f6, 0x486ab2f6, 0x486ab2f6, + 0x486ab2f6, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b500a, 0x486b500a, + 0x486b500a, 0x486b500a, 0x486b500a, 0x486b9e94, 0x486b9e94, 0x486b9e94, 0x486b9e94, 0x486b9e94, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbbbcd226, 0x3be05e79, 0x3be05e79, 0x3be05e79, 0x3be05e79, 0x3be05e79, 0x3b7b205b, 0x3b7b205b, + 0x3b7b205b, 0x3b7b205b, 0x3b7b205b, 0x3a560cb9, 0x3a560cb9, 0x3a560cb9, 0x3a560cb9, 0x3a560cb9, + 0xbb101a1e, 0xbb101a1e, 0xbb101a1e, 0xbb101a1e, 0xbb101a1e, 0xbbaadb8a, 0xbbaadb8a, 0xbbaadb8a, + 0xbbaadb8a, 0xbbaadb8a, 0x3bf25508, 0x3bf25508, 0x3bf25508, 0x3bf25508, 0x3bf25508, 0x3b8f86d1, + 0x3b8f86d1, 0x3b8f86d1, 0x3b8f86d1, 0x3b8f86d1, 0x3ab2e110, 0x3ab2e110, 0x3ab2e110, 0x3ab2e110, + 0x3ab2e110, 0xbad8598f, 0xbad8598f, 0xbad8598f, 0xbad8598f, 0xbad8598f, 0xbb98e4eb, 0xbb98e4eb, + 0xbb98e4eb, 0xbb98e4eb, 0xbb98e4eb, 0xbbfbb317, 0xbbfbb317, 0xbbfbb317, 0xbbfbb317, 0xbbfbb317, + 0x3ba17d72, 0x3ba17d72, 0x3ba17d72, 0x3ba17d72, 0x3ba17d72, 0x3afabbbf, 0x3afabbbf, 0x3afabbbf, + 0x3afabbbf, 0x3afabbbf, 0xba907edd, 0xba907edd, 0xba907edd, 0xba907edd, 0xba907edd, 0xbb86ee49, + 0xbb86ee49, 0xbb86ee49, 0xbb86ee49, 0xbb86ee49, 0xbbe9bc8a, 0xbbe9bc8a, 0xbbe9bc8a, 0xbbe9bc8a, + 0xbbe9bc8a, 0x3bb3740f, 0x3bb3740f, 0x3bb3740f, 0x3bb3740f, 0x3bb3740f, 0x3b214b35, 0x3b214b35, + 0x3b214b35, 0x3b214b35, 0x3b214b35, 0xba114852, 0xba114852, 0xba114852, 0xba114852, 0xba114852, + 0xbb69ef48, 0xbb69ef48, 0xbb69ef48, 0xbb69ef48, 0xbb69ef48, 0xbbd7c5f8, 0xbbd7c5f8, 0xbbd7c5f8, + 0xbbd7c5f8, 0xbbd7c5f8, 0x3bc56aa9, 0x3bc56aa9, 0x3bc56aa9, 0x3bc56aa9, 0x3bc56aa9, 0x3b453887, + 0x3b453887, 0x3b453887, 0x3b453887, 0x3b453887, 0xb6c97336, 0xb6c97336, 0xb6c97336, 0xb6c97336, + 0xb6c97336, 0xbb4601fa, 0xbb4601fa, 0xbb4601fa, 0xbb4601fa, 0xbb4601fa, 0xbbc5cf62, 0xbbc5cf62, + 0xbbc5cf62, 0xbbc5cf62, 0xbbc5cf62, 0x3bd7613f, 0x3bd7613f, 0x3bd7613f, 0x3bd7613f, 0x3bd7613f, + 0x3b6925d5, 0x3b6925d5, 0x3b6925d5, 0x3b6925d5, 0x3b6925d5, 0x3a0e2285, 0x3a0e2285, 0x3a0e2285, + 0x3a0e2285, 0x3a0e2285, 0xbb2214a8, 0xbb2214a8, 0xbb2214a8, 0xbb2214a8, 0xbb2214a8, 0xbbb3d8c8, + 0xbbb3d8c8, 0xbbb3d8c8, 0xbbb3d8c8, 0xbbb3d8c8, 0x3be957d1, 0x3be957d1, 0x3be957d1, 0x3be957d1, + 0x3be957d1, 0x3b868990, 0x3b868990, 0x3b868990, 0x3b868990, 0x3b868990, 0x3a8eebf7, 0x3a8eebf7, + 0x3a8eebf7, 0x3a8eebf7, 0x3a8eebf7, 0xbafc4ea5, 0xbafc4ea5, 0xbafc4ea5, 0xbafc4ea5, 0xbafc4ea5, + 0xbba1e22b, 0xbba1e22b, 0xbba1e22b, 0xbba1e22b, 0xbba1e22b, 0x3bfb4e5e, 0x3bfb4e5e, 0x3bfb4e5e, + 0x3bfb4e5e, 0x3bfb4e5e, 0x3b988032, 0x3b988032, 0x3b988032, 0x3b988032, 0x3b988032, 0x3ad6c6a8, + 0x3ad6c6a8, 0x3ad6c6a8, 0x3ad6c6a8, 0x3ad6c6a8, 0xbab473f6, 0xbab473f6, 0xbab473f6, 0xbab473f6, + 0xbab473f6, 0xbb8feb8a, 0xbb8feb8a, 0xbb8feb8a, 0xbb8feb8a, 0xbb8feb8a, 0xbbf2b9c1, 0xbbf2b9c1, + 0xbbf2b9c1, 0xbbf2b9c1, 0xbbf2b9c1, 0x3baa76d1, 0x3baa76d1, 0x3baa76d1, 0x3baa76d1, 0x3baa76d1, + 0x3b0f50ab, 0x3b0f50ab, 0x3b0f50ab, 0x3b0f50ab, 0x3b0f50ab, 0xba593286, 0xba593286, 0xba593286, + 0xba593286, 0xba593286, 0xbb7be9cd, 0xbb7be9cd, 0xbb7be9cd, 0xbb7be9cd, 0xbb7be9cd, 0xbbe0c332, + 0xbbe0c332, 0xbbe0c332, 0xbbe0c332, 0xbbe0c332, 0x3bbc6d6d, 0x3bbc6d6d, 0x3bbc6d6d, 0x3bbc6d6d, + 0x3bbc6d6d, 0x3b333dff, 0x3b333dff, 0x3b333dff, 0x3b333dff, 0x3b333dff, 0xb992fa37, 0xb992fa37, + 0xb992fa37, 0xb992fa37, 0xb992fa37, 0xbb57fc81, 0xbb57fc81, 0xbb57fc81, 0xbb57fc81, 0xbb57fc81, +] )) ), + +################ chunk 7680 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486c3ba9, 0x486c3ba9, 0x486c3ba9, + 0x486c3ba9, 0x486c3ba9, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486cd8bd, + 0x486cd8bd, 0x486cd8bd, 0x486cd8bd, 0x486cd8bd, 0x486d2747, 0x486d2747, 0x486d2747, 0x486d2747, + 0x486d2747, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486dc45c, 0x486dc45c, + 0x486dc45c, 0x486dc45c, 0x486dc45c, 0x486e12e6, 0x486e12e6, 0x486e12e6, 0x486e12e6, 0x486e12e6, + 0x486e6170, 0x486e6170, 0x486e6170, 0x486e6170, 0x486e6170, 0x486eaffa, 0x486eaffa, 0x486eaffa, + 0x486eaffa, 0x486eaffa, 0x486efe84, 0x486efe84, 0x486efe84, 0x486efe84, 0x486efe84, 0x486f4d0f, + 0x486f4d0f, 0x486f4d0f, 0x486f4d0f, 0x486f4d0f, 0x486f9b99, 0x486f9b99, 0x486f9b99, 0x486f9b99, + 0x486f9b99, 0x486fea23, 0x486fea23, 0x486fea23, 0x486fea23, 0x486fea23, 0x487038ad, 0x487038ad, + 0x487038ad, 0x487038ad, 0x487038ad, 0x48708737, 0x48708737, 0x48708737, 0x48708737, 0x48708737, + 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4871244c, 0x4871244c, 0x4871244c, + 0x4871244c, 0x4871244c, 0x487172d6, 0x487172d6, 0x487172d6, 0x487172d6, 0x487172d6, 0x4871c160, + 0x4871c160, 0x4871c160, 0x4871c160, 0x4871c160, 0x48720fea, 0x48720fea, 0x48720fea, 0x48720fea, + 0x48720fea, 0x48725e74, 0x48725e74, 0x48725e74, 0x48725e74, 0x48725e74, 0x4872acff, 0x4872acff, + 0x4872acff, 0x4872acff, 0x4872acff, 0x4872fb89, 0x4872fb89, 0x4872fb89, 0x4872fb89, 0x4872fb89, + 0x48734a13, 0x48734a13, 0x48734a13, 0x48734a13, 0x48734a13, 0x4873989d, 0x4873989d, 0x4873989d, + 0x4873989d, 0x4873989d, 0x4873e727, 0x4873e727, 0x4873e727, 0x4873e727, 0x4873e727, 0x487435b2, + 0x487435b2, 0x487435b2, 0x487435b2, 0x487435b2, 0x4874843c, 0x4874843c, 0x4874843c, 0x4874843c, + 0x4874843c, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x48752150, 0x48752150, + 0x48752150, 0x48752150, 0x48752150, 0x48756fda, 0x48756fda, 0x48756fda, 0x48756fda, 0x48756fda, + 0x4875be65, 0x4875be65, 0x4875be65, 0x4875be65, 0x4875be65, 0x48760cef, 0x48760cef, 0x48760cef, + 0x48760cef, 0x48760cef, 0x48765b79, 0x48765b79, 0x48765b79, 0x48765b79, 0x48765b79, 0x4876aa03, + 0x4876aa03, 0x4876aa03, 0x4876aa03, 0x4876aa03, 0x4876f88d, 0x4876f88d, 0x4876f88d, 0x4876f88d, + 0x4876f88d, 0x48774718, 0x48774718, 0x48774718, 0x48774718, 0x48774718, 0x487795a2, 0x487795a2, + 0x487795a2, 0x487795a2, 0x487795a2, 0x4877e42c, 0x4877e42c, 0x4877e42c, 0x4877e42c, 0x4877e42c, + 0x487832b6, 0x487832b6, 0x487832b6, 0x487832b6, 0x487832b6, 0x48788140, 0x48788140, 0x48788140, + 0x48788140, 0x48788140, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x48791e55, + 0x48791e55, 0x48791e55, 0x48791e55, 0x48791e55, 0x48796cdf, 0x48796cdf, 0x48796cdf, 0x48796cdf, + 0x48796cdf, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x487a09f3, 0x487a09f3, + 0x487a09f3, 0x487a09f3, 0x487a09f3, 0x487a587d, 0x487a587d, 0x487a587d, 0x487a587d, 0x487a587d, + 0x487aa708, 0x487aa708, 0x487aa708, 0x487aa708, 0x487aa708, 0x487af592, 0x487af592, 0x487af592, + 0x487af592, 0x487af592, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b92a6, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbbcecc9e, 0xbbcecc9e, 0xbbcecc9e, 0xbbcecc9e, 0xbbcecc9e, 0x3bce6405, 0x3bce6405, 0x3bce6405, + 0x3bce6405, 0x3bce6405, 0x3b572b4f, 0x3b572b4f, 0x3b572b4f, 0x3b572b4f, 0x3b572b4f, 0x398c70a1, + 0x398c70a1, 0x398c70a1, 0x398c70a1, 0x398c70a1, 0xbb340f31, 0xbb340f31, 0xbb340f31, 0xbb340f31, + 0xbb340f31, 0xbbbcd606, 0xbbbcd606, 0xbbbcd606, 0xbbbcd606, 0xbbbcd606, 0x3be05a99, 0x3be05a99, + 0x3be05a99, 0x3be05a99, 0x3be05a99, 0x3b7b189b, 0x3b7b189b, 0x3b7b189b, 0x3b7b189b, 0x3b7b189b, + 0x3a55edbb, 0x3a55edbb, 0x3a55edbb, 0x3a55edbb, 0x3a55edbb, 0xbb1021dd, 0xbb1021dd, 0xbb1021dd, + 0xbb1021dd, 0xbb1021dd, 0xbbaadf6a, 0xbbaadf6a, 0xbbaadf6a, 0xbbaadf6a, 0xbbaadf6a, 0x3bf25129, + 0x3bf25129, 0x3bf25129, 0x3bf25129, 0x3bf25129, 0x3b8f82f1, 0x3b8f82f1, 0x3b8f82f1, 0x3b8f82f1, + 0x3b8f82f1, 0x3ab2d191, 0x3ab2d191, 0x3ab2d191, 0x3ab2d191, 0x3ab2d191, 0xbad8690e, 0xbad8690e, + 0xbad8690e, 0xbad8690e, 0xbad8690e, 0xbb98e8cb, 0xbb98e8cb, 0xbb98e8cb, 0xbb98e8cb, 0xbb98e8cb, + 0xbbfbb6f7, 0xbbfbb6f7, 0xbbfbb6f7, 0xbbfbb6f7, 0xbbfbb6f7, 0x3ba17992, 0x3ba17992, 0x3ba17992, + 0x3ba17992, 0x3ba17992, 0x3afaac40, 0x3afaac40, 0x3afaac40, 0x3afaac40, 0x3afaac40, 0xba908e5c, + 0xba908e5c, 0xba908e5c, 0xba908e5c, 0xba908e5c, 0xbb86f229, 0xbb86f229, 0xbb86f229, 0xbb86f229, + 0xbb86f229, 0xbbe9c06a, 0xbbe9c06a, 0xbbe9c06a, 0xbbe9c06a, 0xbbe9c06a, 0x3bb3702f, 0x3bb3702f, + 0x3bb3702f, 0x3bb3702f, 0x3bb3702f, 0x3b214375, 0x3b214375, 0x3b214375, 0x3b214375, 0x3b214375, + 0xba116750, 0xba116750, 0xba116750, 0xba116750, 0xba116750, 0xbb69f708, 0xbb69f708, 0xbb69f708, + 0xbb69f708, 0xbb69f708, 0xbbd7c9d8, 0xbbd7c9d8, 0xbbd7c9d8, 0xbbd7c9d8, 0xbbd7c9d8, 0x3bc566c9, + 0x3bc566c9, 0x3bc566c9, 0x3bc566c9, 0x3bc566c9, 0x3b4530c8, 0x3b4530c8, 0x3b4530c8, 0x3b4530c8, + 0x3b4530c8, 0xb6d8f23a, 0xb6d8f23a, 0xb6d8f23a, 0xb6d8f23a, 0xb6d8f23a, 0xbb4609ba, 0xbb4609ba, + 0xbb4609ba, 0xbb4609ba, 0xbb4609ba, 0xbbc5d342, 0xbbc5d342, 0xbbc5d342, 0xbbc5d342, 0xbbc5d342, + 0x3bd75d60, 0x3bd75d60, 0x3bd75d60, 0x3bd75d60, 0x3bd75d60, 0x3b691e16, 0x3b691e16, 0x3b691e16, + 0x3b691e16, 0x3b691e16, 0x3a0e0387, 0x3a0e0387, 0x3a0e0387, 0x3a0e0387, 0x3a0e0387, 0xbb221c67, + 0xbb221c67, 0xbb221c67, 0xbb221c67, 0xbb221c67, 0xbbb3dca8, 0xbbb3dca8, 0xbbb3dca8, 0xbbb3dca8, + 0xbbb3dca8, 0x3be953f1, 0x3be953f1, 0x3be953f1, 0x3be953f1, 0x3be953f1, 0x3b8685b0, 0x3b8685b0, + 0x3b8685b0, 0x3b8685b0, 0x3b8685b0, 0x3a8edc78, 0x3a8edc78, 0x3a8edc78, 0x3a8edc78, 0x3a8edc78, + 0xbafc5e24, 0xbafc5e24, 0xbafc5e24, 0xbafc5e24, 0xbafc5e24, 0xbba1e60b, 0xbba1e60b, 0xbba1e60b, + 0xbba1e60b, 0xbba1e60b, 0x3bfb4a7f, 0x3bfb4a7f, 0x3bfb4a7f, 0x3bfb4a7f, 0x3bfb4a7f, 0x3b987c52, + 0x3b987c52, 0x3b987c52, 0x3b987c52, 0x3b987c52, 0x3ad6b729, 0x3ad6b729, 0x3ad6b729, 0x3ad6b729, + 0x3ad6b729, 0xbab48375, 0xbab48375, 0xbab48375, 0xbab48375, 0xbab48375, 0xbb8fef6a, 0xbb8fef6a, + 0xbb8fef6a, 0xbb8fef6a, 0xbb8fef6a, 0xbbf2bda1, 0xbbf2bda1, 0xbbf2bda1, 0xbbf2bda1, 0xbbf2bda1, + 0x3baa72f1, 0x3baa72f1, 0x3baa72f1, 0x3baa72f1, 0x3baa72f1, 0x3b0f48eb, 0x3b0f48eb, 0x3b0f48eb, + 0x3b0f48eb, 0x3b0f48eb, 0xba595184, 0xba595184, 0xba595184, 0xba595184, 0xba595184, 0xbb7bf18d, +] )) ), + +################ chunk 8192 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x487b92a6, 0x487b92a6, 0x487b92a6, 0x487b92a6, 0x487be130, 0x487be130, 0x487be130, 0x487be130, + 0x487be130, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c7e45, 0x487c7e45, + 0x487c7e45, 0x487c7e45, 0x487c7e45, 0x487ccccf, 0x487ccccf, 0x487ccccf, 0x487ccccf, 0x487ccccf, + 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d69e3, 0x487d69e3, 0x487d69e3, + 0x487d69e3, 0x487d69e3, 0x487db86e, 0x487db86e, 0x487db86e, 0x487db86e, 0x487db86e, 0x487e06f8, + 0x487e06f8, 0x487e06f8, 0x487e06f8, 0x487e06f8, 0x487e5582, 0x487e5582, 0x487e5582, 0x487e5582, + 0x487e5582, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ef296, 0x487ef296, + 0x487ef296, 0x487ef296, 0x487ef296, 0x487f4121, 0x487f4121, 0x487f4121, 0x487f4121, 0x487f4121, + 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487fde35, 0x487fde35, 0x487fde35, + 0x487fde35, 0x487fde35, 0x48801660, 0x48801660, 0x48801660, 0x48801660, 0x48801660, 0x48803da5, + 0x48803da5, 0x48803da5, 0x48803da5, 0x48803da5, 0x488064ea, 0x488064ea, 0x488064ea, 0x488064ea, + 0x488064ea, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x4880b374, 0x4880b374, + 0x4880b374, 0x4880b374, 0x4880b374, 0x4880dab9, 0x4880dab9, 0x4880dab9, 0x4880dab9, 0x4880dab9, + 0x488101fe, 0x488101fe, 0x488101fe, 0x488101fe, 0x488101fe, 0x48812943, 0x48812943, 0x48812943, + 0x48812943, 0x48812943, 0x48815088, 0x48815088, 0x48815088, 0x48815088, 0x48815088, 0x488177cd, + 0x488177cd, 0x488177cd, 0x488177cd, 0x488177cd, 0x48819f13, 0x48819f13, 0x48819f13, 0x48819f13, + 0x48819f13, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881ed9d, 0x4881ed9d, + 0x4881ed9d, 0x4881ed9d, 0x4881ed9d, 0x488214e2, 0x488214e2, 0x488214e2, 0x488214e2, 0x488214e2, + 0x48823c27, 0x48823c27, 0x48823c27, 0x48823c27, 0x48823c27, 0x4882636c, 0x4882636c, 0x4882636c, + 0x4882636c, 0x4882636c, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x4882b1f6, + 0x4882b1f6, 0x4882b1f6, 0x4882b1f6, 0x4882b1f6, 0x4882d93b, 0x4882d93b, 0x4882d93b, 0x4882d93b, + 0x4882d93b, 0x48830080, 0x48830080, 0x48830080, 0x48830080, 0x48830080, 0x488327c6, 0x488327c6, + 0x488327c6, 0x488327c6, 0x488327c6, 0x48834f0b, 0x48834f0b, 0x48834f0b, 0x48834f0b, 0x48834f0b, + 0x48837650, 0x48837650, 0x48837650, 0x48837650, 0x48837650, 0x48839d95, 0x48839d95, 0x48839d95, + 0x48839d95, 0x48839d95, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883ec1f, + 0x4883ec1f, 0x4883ec1f, 0x4883ec1f, 0x4883ec1f, 0x48841364, 0x48841364, 0x48841364, 0x48841364, + 0x48841364, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x488461ee, 0x488461ee, + 0x488461ee, 0x488461ee, 0x488461ee, 0x48848933, 0x48848933, 0x48848933, 0x48848933, 0x48848933, + 0x4884b078, 0x4884b078, 0x4884b078, 0x4884b078, 0x4884b078, 0x4884d7be, 0x4884d7be, 0x4884d7be, + 0x4884d7be, 0x4884d7be, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x48852648, + 0x48852648, 0x48852648, 0x48852648, 0x48852648, 0x48854d8d, 0x48854d8d, 0x48854d8d, 0x48854d8d, + 0x48854d8d, 0x488574d2, 0x488574d2, 0x488574d2, 0x488574d2, 0x488574d2, 0x48859c17, 0x48859c17, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbb7bf18d, 0xbb7bf18d, 0xbb7bf18d, 0xbb7bf18d, 0xbbe0c711, 0xbbe0c711, 0xbbe0c711, 0xbbe0c711, + 0xbbe0c711, 0x3bbc698d, 0x3bbc698d, 0x3bbc698d, 0x3bbc698d, 0x3bbc698d, 0x3b33363f, 0x3b33363f, + 0x3b33363f, 0x3b33363f, 0x3b33363f, 0xb9933833, 0xb9933833, 0xb9933833, 0xb9933833, 0xb9933833, + 0xbb580441, 0xbb580441, 0xbb580441, 0xbb580441, 0xbb580441, 0xbbced07d, 0xbbced07d, 0xbbced07d, + 0xbbced07d, 0xbbced07d, 0x3bce6025, 0x3bce6025, 0x3bce6025, 0x3bce6025, 0x3bce6025, 0x3b572390, + 0x3b572390, 0x3b572390, 0x3b572390, 0x3b572390, 0x398c32a5, 0x398c32a5, 0x398c32a5, 0x398c32a5, + 0x398c32a5, 0xbb3416f1, 0xbb3416f1, 0xbb3416f1, 0xbb3416f1, 0xbb3416f1, 0xbbbcd9e5, 0xbbbcd9e5, + 0xbbbcd9e5, 0xbbbcd9e5, 0xbbbcd9e5, 0x3be056b9, 0x3be056b9, 0x3be056b9, 0x3be056b9, 0x3be056b9, + 0x3b7b10dc, 0x3b7b10dc, 0x3b7b10dc, 0x3b7b10dc, 0x3b7b10dc, 0x3a55cebd, 0x3a55cebd, 0x3a55cebd, + 0x3a55cebd, 0x3a55cebd, 0x3c5bf3e6, 0x3c5bf3e6, 0x3c5bf3e6, 0x3c5bf3e6, 0x3c5bf3e6, 0x3c2a8d78, + 0x3c2a8d78, 0x3c2a8d78, 0x3c2a8d78, 0x3c2a8d78, 0x3bf24d49, 0x3bf24d49, 0x3bf24d49, 0x3bf24d49, + 0x3bf24d49, 0x3b8f7f11, 0x3b8f7f11, 0x3b8f7f11, 0x3b8f7f11, 0x3b8f7f11, 0x3ab2c212, 0x3ab2c212, + 0x3ab2c212, 0x3ab2c212, 0x3ab2c212, 0xbad8788d, 0xbad8788d, 0xbad8788d, 0xbad8788d, 0xbad8788d, + 0xbb98ecab, 0xbb98ecab, 0xbb98ecab, 0xbb98ecab, 0xbb98ecab, 0xbbfbbad7, 0xbbfbbad7, 0xbbfbbad7, + 0xbbfbbad7, 0xbbfbbad7, 0xbc2f4436, 0xbc2f4436, 0xbc2f4436, 0xbc2f4436, 0xbc2f4436, 0xbc60aa99, + 0xbc60aa99, 0xbc60aa99, 0xbc60aa99, 0xbc60aa99, 0x3c6dea20, 0x3c6dea20, 0x3c6dea20, 0x3c6dea20, + 0x3c6dea20, 0x3c3c83df, 0x3c3c83df, 0x3c3c83df, 0x3c3c83df, 0x3c3c83df, 0x3c0b1d2d, 0x3c0b1d2d, + 0x3c0b1d2d, 0x3c0b1d2d, 0x3c0b1d2d, 0x3bb36c50, 0x3bb36c50, 0x3bb36c50, 0x3bb36c50, 0x3bb36c50, + 0x3b213bb6, 0x3b213bb6, 0x3b213bb6, 0x3b213bb6, 0x3b213bb6, 0xba11864e, 0xba11864e, 0xba11864e, + 0xba11864e, 0xba11864e, 0xbb69fec7, 0xbb69fec7, 0xbb69fec7, 0xbb69fec7, 0xbb69fec7, 0xbbd7cdb8, + 0xbbd7cdb8, 0xbbd7cdb8, 0xbbd7cdb8, 0xbbd7cdb8, 0xbc1d4dc6, 0xbc1d4dc6, 0xbc1d4dc6, 0xbc1d4dc6, + 0xbc1d4dc6, 0xbc4eb452, 0xbc4eb452, 0xbc4eb452, 0xbc4eb452, 0xbc4eb452, 0x3c7fe048, 0x3c7fe048, + 0x3c7fe048, 0x3c7fe048, 0x3c7fe048, 0x3c4e7a37, 0x3c4e7a37, 0x3c4e7a37, 0x3c4e7a37, 0x3c4e7a37, + 0x3c1d13aa, 0x3c1d13aa, 0x3c1d13aa, 0x3c1d13aa, 0x3c1d13aa, 0x3bd75980, 0x3bd75980, 0x3bd75980, + 0x3bd75980, 0x3bd75980, 0x3b691656, 0x3b691656, 0x3b691656, 0x3b691656, 0x3b691656, 0x3a0de489, + 0x3a0de489, 0x3a0de489, 0x3a0de489, 0x3a0de489, 0xbb222427, 0xbb222427, 0xbb222427, 0xbb222427, + 0xbb222427, 0xbbb3e088, 0xbbb3e088, 0xbbb3e088, 0xbbb3e088, 0xbbb3e088, 0xbc0b5748, 0xbc0b5748, + 0xbc0b5748, 0xbc0b5748, 0xbc0b5748, 0xbc3cbdfa, 0xbc3cbdfa, 0xbc3cbdfa, 0xbc3cbdfa, 0xbc3cbdfa, + 0xbc6e243b, 0xbc6e243b, 0xbc6e243b, 0xbc6e243b, 0xbc6e243b, 0x3c60707e, 0x3c60707e, 0x3c60707e, + 0x3c60707e, 0x3c60707e, 0x3c2f0a1b, 0x3c2f0a1b, 0x3c2f0a1b, 0x3c2f0a1b, 0x3c2f0a1b, 0x3bfb469f, + 0x3bfb469f, 0x3bfb469f, 0x3bfb469f, 0x3bfb469f, 0x3b987872, 0x3b987872, 0x3b987872, 0x3b987872, + 0x3b987872, 0x3ad6a7aa, 0x3ad6a7aa, 0x3ad6a7aa, 0x3ad6a7aa, 0x3ad6a7aa, 0xbab492f4, 0xbab492f4, +] )) ), + +################ chunk 8704 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x48859c17, 0x48859c17, 0x48859c17, 0x4885c35c, 0x4885c35c, 0x4885c35c, 0x4885c35c, 0x4885c35c, + 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x488611e6, 0x488611e6, 0x488611e6, + 0x488611e6, 0x488611e6, 0x4886392b, 0x4886392b, 0x4886392b, 0x4886392b, 0x4886392b, 0x48866071, + 0x48866071, 0x48866071, 0x48866071, 0x48866071, 0x488687b6, 0x488687b6, 0x488687b6, 0x488687b6, + 0x488687b6, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886d640, 0x4886d640, + 0x4886d640, 0x4886d640, 0x4886d640, 0x4886fd85, 0x4886fd85, 0x4886fd85, 0x4886fd85, 0x4886fd85, + 0x488724ca, 0x488724ca, 0x488724ca, 0x488724ca, 0x488724ca, 0x48874c0f, 0x48874c0f, 0x48874c0f, + 0x48874c0f, 0x48874c0f, 0x48877354, 0x48877354, 0x48877354, 0x48877354, 0x48877354, 0x48879a99, + 0x48879a99, 0x48879a99, 0x48879a99, 0x48879a99, 0x4887c1de, 0x4887c1de, 0x4887c1de, 0x4887c1de, + 0x4887c1de, 0x4887e923, 0x4887e923, 0x4887e923, 0x4887e923, 0x4887e923, 0x48881069, 0x48881069, + 0x48881069, 0x48881069, 0x48881069, 0x488837ae, 0x488837ae, 0x488837ae, 0x488837ae, 0x488837ae, + 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48888638, 0x48888638, 0x48888638, + 0x48888638, 0x48888638, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888d4c2, + 0x4888d4c2, 0x4888d4c2, 0x4888d4c2, 0x4888d4c2, 0x4888fc07, 0x4888fc07, 0x4888fc07, 0x4888fc07, + 0x4888fc07, 0x4889234c, 0x4889234c, 0x4889234c, 0x4889234c, 0x4889234c, 0x48894a91, 0x48894a91, + 0x48894a91, 0x48894a91, 0x48894a91, 0x488971d6, 0x488971d6, 0x488971d6, 0x488971d6, 0x488971d6, + 0x4889991c, 0x4889991c, 0x4889991c, 0x4889991c, 0x4889991c, 0x4889c061, 0x4889c061, 0x4889c061, + 0x4889c061, 0x4889c061, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x488a0eeb, + 0x488a0eeb, 0x488a0eeb, 0x488a0eeb, 0x488a0eeb, 0x488a3630, 0x488a3630, 0x488a3630, 0x488a3630, + 0x488a3630, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a84ba, 0x488a84ba, + 0x488a84ba, 0x488a84ba, 0x488a84ba, 0x488aabff, 0x488aabff, 0x488aabff, 0x488aabff, 0x488aabff, + 0x488ad344, 0x488ad344, 0x488ad344, 0x488ad344, 0x488ad344, 0x488afa89, 0x488afa89, 0x488afa89, + 0x488afa89, 0x488afa89, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b4914, + 0x488b4914, 0x488b4914, 0x488b4914, 0x488b4914, 0x488b7059, 0x488b7059, 0x488b7059, 0x488b7059, + 0x488b7059, 0x488b979e, 0x488b979e, 0x488b979e, 0x488b979e, 0x488b979e, 0x488bbee3, 0x488bbee3, + 0x488bbee3, 0x488bbee3, 0x488bbee3, 0x488be628, 0x488be628, 0x488be628, 0x488be628, 0x488be628, + 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c34b2, 0x488c34b2, 0x488c34b2, + 0x488c34b2, 0x488c34b2, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c833c, + 0x488c833c, 0x488c833c, 0x488c833c, 0x488c833c, 0x488caa81, 0x488caa81, 0x488caa81, 0x488caa81, + 0x488caa81, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cf90c, 0x488cf90c, + 0x488cf90c, 0x488cf90c, 0x488cf90c, 0x488d2051, 0x488d2051, 0x488d2051, 0x488d2051, 0x488d2051, + 0x488d4796, 0x488d4796, 0x488d4796, 0x488d4796, 0x488d4796, 0x488d6edb, 0x488d6edb, 0x488d6edb, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbab492f4, 0xbab492f4, 0xbab492f4, 0xbb8ff34a, 0xbb8ff34a, 0xbb8ff34a, 0xbb8ff34a, 0xbb8ff34a, + 0xbbf2c181, 0xbbf2c181, 0xbbf2c181, 0xbbf2c181, 0xbbf2c181, 0xbc2ac793, 0xbc2ac793, 0xbc2ac793, + 0xbc2ac793, 0xbc2ac793, 0xbc5c2e01, 0xbc5c2e01, 0xbc5c2e01, 0xbc5c2e01, 0xbc5c2e01, 0x3c7266b4, + 0x3c7266b4, 0x3c7266b4, 0x3c7266b4, 0x3c7266b4, 0x3c41007e, 0x3c41007e, 0x3c41007e, 0x3c41007e, + 0x3c41007e, 0x3c0f99d5, 0x3c0f99d5, 0x3c0f99d5, 0x3c0f99d5, 0x3c0f99d5, 0x3bbc65ad, 0x3bbc65ad, + 0x3bbc65ad, 0x3bbc65ad, 0x3bbc65ad, 0x3b332e80, 0x3b332e80, 0x3b332e80, 0x3b332e80, 0x3b332e80, + 0xb993762f, 0xb993762f, 0xb993762f, 0xb993762f, 0xb993762f, 0xbb580c00, 0xbb580c00, 0xbb580c00, + 0xbb580c00, 0xbb580c00, 0xbbced45d, 0xbbced45d, 0xbbced45d, 0xbbced45d, 0xbbced45d, 0xbc18d11f, + 0xbc18d11f, 0xbc18d11f, 0xbc18d11f, 0xbc18d11f, 0xbc4a37b5, 0xbc4a37b5, 0xbc4a37b5, 0xbc4a37b5, + 0xbc4a37b5, 0xbc7b9dd2, 0xbc7b9dd2, 0xbc7b9dd2, 0xbc7b9dd2, 0xbc7b9dd2, 0x3c52f6d2, 0x3c52f6d2, + 0x3c52f6d2, 0x3c52f6d2, 0x3c52f6d2, 0x3c219050, 0x3c219050, 0x3c219050, 0x3c219050, 0x3c219050, + 0x3be052d9, 0x3be052d9, 0x3be052d9, 0x3be052d9, 0x3be052d9, 0x3b7b091c, 0x3b7b091c, 0x3b7b091c, + 0x3b7b091c, 0x3b7b091c, 0x3a55afbf, 0x3a55afbf, 0x3a55afbf, 0x3a55afbf, 0x3a55afbf, 0xbb10315c, + 0xbb10315c, 0xbb10315c, 0xbb10315c, 0xbb10315c, 0xbbaae729, 0xbbaae729, 0xbbaae729, 0xbbaae729, + 0xbbaae729, 0xbc06da9f, 0xbc06da9f, 0xbc06da9f, 0xbc06da9f, 0xbc06da9f, 0xbc38415a, 0xbc38415a, + 0xbc38415a, 0xbc38415a, 0xbc38415a, 0xbc69a7a6, 0xbc69a7a6, 0xbc69a7a6, 0xbc69a7a6, 0xbc69a7a6, + 0x3c64ed16, 0x3c64ed16, 0x3c64ed16, 0x3c64ed16, 0x3c64ed16, 0x3c3386bd, 0x3c3386bd, 0x3c3386bd, + 0x3c3386bd, 0x3c3386bd, 0x3c021ffa, 0x3c021ffa, 0x3c021ffa, 0x3c021ffa, 0x3c021ffa, 0x3ba171d2, + 0x3ba171d2, 0x3ba171d2, 0x3ba171d2, 0x3ba171d2, 0x3afa8d42, 0x3afa8d42, 0x3afa8d42, 0x3afa8d42, + 0x3afa8d42, 0xba90ad5a, 0xba90ad5a, 0xba90ad5a, 0xba90ad5a, 0xba90ad5a, 0xbb86f9e8, 0xbb86f9e8, + 0xbb86f9e8, 0xbb86f9e8, 0xbb86f9e8, 0xbbe9c829, 0xbbe9c829, 0xbbe9c829, 0xbbe9c829, 0xbbe9c829, + 0xbc264af0, 0xbc264af0, 0xbc264af0, 0xbc264af0, 0xbc264af0, 0xbc57b167, 0xbc57b167, 0xbc57b167, + 0xbc57b167, 0xbc57b167, 0x3c76e347, 0x3c76e347, 0x3c76e347, 0x3c76e347, 0x3c76e347, 0x3c457d1d, + 0x3c457d1d, 0x3c457d1d, 0x3c457d1d, 0x3c457d1d, 0x3c14167d, 0x3c14167d, 0x3c14167d, 0x3c14167d, + 0x3c14167d, 0x3bc55f0a, 0x3bc55f0a, 0x3bc55f0a, 0x3bc55f0a, 0x3bc55f0a, 0x3b452149, 0x3b452149, + 0x3b452149, 0x3b452149, 0x3b452149, 0xb6f7f042, 0xb6f7f042, 0xb6f7f042, 0xb6f7f042, 0xb6f7f042, + 0xbb461939, 0xbb461939, 0xbb461939, 0xbb461939, 0xbb461939, 0xbbc5db01, 0xbbc5db01, 0xbbc5db01, + 0xbbc5db01, 0xbbc5db01, 0xbc145478, 0xbc145478, 0xbc145478, 0xbc145478, 0xbc145478, 0xbc45bb18, + 0xbc45bb18, 0xbc45bb18, 0xbc45bb18, 0xbc45bb18, 0xbc772141, 0xbc772141, 0xbc772141, 0xbc772141, + 0xbc772141, 0x3c57736d, 0x3c57736d, 0x3c57736d, 0x3c57736d, 0x3c57736d, 0x3c260cf4, 0x3c260cf4, + 0x3c260cf4, 0x3c260cf4, 0x3c260cf4, 0x3be94c32, 0x3be94c32, 0x3be94c32, 0x3be94c32, 0x3be94c32, + 0x3b867df0, 0x3b867df0, 0x3b867df0, 0x3b867df0, 0x3b867df0, 0x3a8ebd7a, 0x3a8ebd7a, 0x3a8ebd7a, +] )) ), + +################ chunk 9216 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x488d6edb, 0x488d6edb, 0x488d9620, 0x488d9620, 0x488d9620, 0x488d9620, 0x488d9620, 0x488dbd65, + 0x488dbd65, 0x488dbd65, 0x488dbd65, 0x488dbd65, 0x488de4aa, 0x488de4aa, 0x488de4aa, 0x488de4aa, + 0x488de4aa, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e3334, 0x488e3334, + 0x488e3334, 0x488e3334, 0x488e3334, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, + 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488ea904, 0x488ea904, 0x488ea904, + 0x488ea904, 0x488ea904, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ef78e, + 0x488ef78e, 0x488ef78e, 0x488ef78e, 0x488ef78e, 0x488f1ed3, 0x488f1ed3, 0x488f1ed3, 0x488f1ed3, + 0x488f1ed3, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f6d5d, 0x488f6d5d, + 0x488f6d5d, 0x488f6d5d, 0x488f6d5d, 0x488f94a2, 0x488f94a2, 0x488f94a2, 0x488f94a2, 0x488f94a2, + 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fe32d, 0x488fe32d, 0x488fe32d, + 0x488fe32d, 0x488fe32d, 0x48900a72, 0x48900a72, 0x48900a72, 0x48900a72, 0x48900a72, 0x489031b7, + 0x489031b7, 0x489031b7, 0x489031b7, 0x489031b7, 0x489058fc, 0x489058fc, 0x489058fc, 0x489058fc, + 0x489058fc, 0x48908041, 0x48908041, 0x48908041, 0x48908041, 0x48908041, 0x4890a786, 0x4890a786, + 0x4890a786, 0x4890a786, 0x4890a786, 0x4890cecb, 0x4890cecb, 0x4890cecb, 0x4890cecb, 0x4890cecb, + 0x4890f610, 0x4890f610, 0x4890f610, 0x4890f610, 0x4890f610, 0x48911d55, 0x48911d55, 0x48911d55, + 0x48911d55, 0x48911d55, 0x4891449a, 0x4891449a, 0x4891449a, 0x4891449a, 0x4891449a, 0x48916bdf, + 0x48916bdf, 0x48916bdf, 0x48916bdf, 0x48916bdf, 0x48919325, 0x48919325, 0x48919325, 0x48919325, + 0x48919325, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891e1af, 0x4891e1af, + 0x4891e1af, 0x4891e1af, 0x4891e1af, 0x489208f4, 0x489208f4, 0x489208f4, 0x489208f4, 0x489208f4, + 0x48923039, 0x48923039, 0x48923039, 0x48923039, 0x48923039, 0x4892577e, 0x4892577e, 0x4892577e, + 0x4892577e, 0x4892577e, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x4892a608, + 0x4892a608, 0x4892a608, 0x4892a608, 0x4892a608, 0x4892cd4d, 0x4892cd4d, 0x4892cd4d, 0x4892cd4d, + 0x4892cd4d, 0x4892f492, 0x4892f492, 0x4892f492, 0x4892f492, 0x4892f492, 0x48931bd8, 0x48931bd8, + 0x48931bd8, 0x48931bd8, 0x48931bd8, 0x4893431d, 0x4893431d, 0x4893431d, 0x4893431d, 0x4893431d, + 0x48936a62, 0x48936a62, 0x48936a62, 0x48936a62, 0x48936a62, 0x489391a7, 0x489391a7, 0x489391a7, + 0x489391a7, 0x489391a7, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893e031, + 0x4893e031, 0x4893e031, 0x4893e031, 0x4893e031, 0x48940776, 0x48940776, 0x48940776, 0x48940776, + 0x48940776, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48945600, 0x48945600, + 0x48945600, 0x48945600, 0x48945600, 0x48947d45, 0x48947d45, 0x48947d45, 0x48947d45, 0x48947d45, + 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894cbd0, 0x4894cbd0, 0x4894cbd0, + 0x4894cbd0, 0x4894cbd0, 0x4894f315, 0x4894f315, 0x4894f315, 0x4894f315, 0x4894f315, 0x48951a5a, + 0x48951a5a, 0x48951a5a, 0x48951a5a, 0x48951a5a, 0x4895419f, 0x4895419f, 0x4895419f, 0x4895419f, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3a8ebd7a, 0x3a8ebd7a, 0xbafc7d22, 0xbafc7d22, 0xbafc7d22, 0xbafc7d22, 0xbafc7d22, 0xbba1edca, + 0xbba1edca, 0xbba1edca, 0xbba1edca, 0xbba1edca, 0xbc025df6, 0xbc025df6, 0xbc025df6, 0xbc025df6, + 0xbc025df6, 0xbc33c4b8, 0xbc33c4b8, 0xbc33c4b8, 0xbc33c4b8, 0xbc33c4b8, 0xbc652b10, 0xbc652b10, + 0xbc652b10, 0xbc652b10, 0xbc652b10, 0x3c6969ac, 0x3c6969ac, 0x3c6969ac, 0x3c6969ac, 0x3c6969ac, + 0x3c38035f, 0x3c38035f, 0x3c38035f, 0x3c38035f, 0x3c38035f, 0x3c069ca4, 0x3c069ca4, 0x3c069ca4, + 0x3c069ca4, 0x3c069ca4, 0x3baa6b32, 0x3baa6b32, 0x3baa6b32, 0x3baa6b32, 0x3baa6b32, 0x3b0f396c, + 0x3b0f396c, 0x3b0f396c, 0x3b0f396c, 0x3b0f396c, 0xba598f80, 0xba598f80, 0xba598f80, 0xba598f80, + 0xba598f80, 0xbb7c010c, 0xbb7c010c, 0xbb7c010c, 0xbb7c010c, 0xbb7c010c, 0xbbe0ced1, 0xbbe0ced1, + 0xbbe0ced1, 0xbbe0ced1, 0xbbe0ced1, 0xbc21ce4b, 0xbc21ce4b, 0xbc21ce4b, 0xbc21ce4b, 0xbc21ce4b, + 0xbc5334cd, 0xbc5334cd, 0xbc5334cd, 0xbc5334cd, 0xbc5334cd, 0x3c7b5fd8, 0x3c7b5fd8, 0x3c7b5fd8, + 0x3c7b5fd8, 0x3c7b5fd8, 0x3c49f9ba, 0x3c49f9ba, 0x3c49f9ba, 0x3c49f9ba, 0x3c49f9ba, 0x3c189324, + 0x3c189324, 0x3c189324, 0x3c189324, 0x3c189324, 0x3bce5866, 0x3bce5866, 0x3bce5866, 0x3bce5866, + 0x3bce5866, 0x3b571411, 0x3b571411, 0x3b571411, 0x3b571411, 0x3b571411, 0x398bb6ad, 0x398bb6ad, + 0x398bb6ad, 0x398bb6ad, 0x398bb6ad, 0xbb342670, 0xbb342670, 0xbb342670, 0xbb342670, 0xbb342670, + 0xbbbce1a5, 0xbbbce1a5, 0xbbbce1a5, 0xbbbce1a5, 0xbbbce1a5, 0xbc0fd7d1, 0xbc0fd7d1, 0xbc0fd7d1, + 0xbc0fd7d1, 0xbc0fd7d1, 0xbc413e79, 0xbc413e79, 0xbc413e79, 0xbc413e79, 0xbc413e79, 0xbc72a4af, + 0xbc72a4af, 0xbc72a4af, 0xbc72a4af, 0xbc72a4af, 0x3c5bf006, 0x3c5bf006, 0x3c5bf006, 0x3c5bf006, + 0x3c5bf006, 0x3c2a8998, 0x3c2a8998, 0x3c2a8998, 0x3c2a8998, 0x3c2a8998, 0x3bf24589, 0x3bf24589, + 0x3bf24589, 0x3bf24589, 0x3bf24589, 0x3b8f7752, 0x3b8f7752, 0x3b8f7752, 0x3b8f7752, 0x3b8f7752, + 0x3ab2a314, 0x3ab2a314, 0x3ab2a314, 0x3ab2a314, 0x3ab2a314, 0xbad8978b, 0xbad8978b, 0xbad8978b, + 0xbad8978b, 0xbad8978b, 0xbb98f46a, 0xbb98f46a, 0xbb98f46a, 0xbb98f46a, 0xbb98f46a, 0xbbfbc296, + 0xbbfbc296, 0xbbfbc296, 0xbbfbc296, 0xbbfbc296, 0xbc2f4816, 0xbc2f4816, 0xbc2f4816, 0xbc2f4816, + 0xbc2f4816, 0xbc60ae79, 0xbc60ae79, 0xbc60ae79, 0xbc60ae79, 0xbc60ae79, 0x3c6de641, 0x3c6de641, + 0x3c6de641, 0x3c6de641, 0x3c6de641, 0x3c3c7fff, 0x3c3c7fff, 0x3c3c7fff, 0x3c3c7fff, 0x3c3c7fff, + 0x3c0b194d, 0x3c0b194d, 0x3c0b194d, 0x3c0b194d, 0x3c0b194d, 0x3bb36490, 0x3bb36490, 0x3bb36490, + 0x3bb36490, 0x3bb36490, 0x3b212c37, 0x3b212c37, 0x3b212c37, 0x3b212c37, 0x3b212c37, 0xba11c44a, + 0xba11c44a, 0xba11c44a, 0xba11c44a, 0xba11c44a, 0xbb6a0e46, 0xbb6a0e46, 0xbb6a0e46, 0xbb6a0e46, + 0xbb6a0e46, 0xbbd7d577, 0xbbd7d577, 0xbbd7d577, 0xbbd7d577, 0xbbd7d577, 0xbc1d51a5, 0xbc1d51a5, + 0xbc1d51a5, 0xbc1d51a5, 0xbc1d51a5, 0xbc4eb831, 0xbc4eb831, 0xbc4eb831, 0xbc4eb831, 0xbc4eb831, + 0x3c7fdc68, 0x3c7fdc68, 0x3c7fdc68, 0x3c7fdc68, 0x3c7fdc68, 0x3c4e7657, 0x3c4e7657, 0x3c4e7657, + 0x3c4e7657, 0x3c4e7657, 0x3c1d0fca, 0x3c1d0fca, 0x3c1d0fca, 0x3c1d0fca, 0x3c1d0fca, 0x3bd751c0, + 0x3bd751c0, 0x3bd751c0, 0x3bd751c0, 0x3bd751c0, 0x3b6906d7, 0x3b6906d7, 0x3b6906d7, 0x3b6906d7, +] )) ), + +################ chunk 9728 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4895419f, 0x489568e4, 0x489568e4, 0x489568e4, 0x489568e4, 0x489568e4, 0x48959029, 0x48959029, + 0x48959029, 0x48959029, 0x48959029, 0x4895b76e, 0x4895b76e, 0x4895b76e, 0x4895b76e, 0x4895b76e, + 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x489605f8, 0x489605f8, 0x489605f8, + 0x489605f8, 0x489605f8, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48965483, + 0x48965483, 0x48965483, 0x48965483, 0x48965483, 0x48967bc8, 0x48967bc8, 0x48967bc8, 0x48967bc8, + 0x48967bc8, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896ca52, 0x4896ca52, + 0x4896ca52, 0x4896ca52, 0x4896ca52, 0x4896f197, 0x4896f197, 0x4896f197, 0x4896f197, 0x4896f197, + 0x489718dc, 0x489718dc, 0x489718dc, 0x489718dc, 0x489718dc, 0x48974021, 0x48974021, 0x48974021, + 0x48974021, 0x48974021, 0x48976766, 0x48976766, 0x48976766, 0x48976766, 0x48976766, 0x48978eab, + 0x48978eab, 0x48978eab, 0x48978eab, 0x48978eab, 0x4897b5f0, 0x4897b5f0, 0x4897b5f0, 0x4897b5f0, + 0x4897b5f0, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4898047b, 0x4898047b, + 0x4898047b, 0x4898047b, 0x4898047b, 0x48982bc0, 0x48982bc0, 0x48982bc0, 0x48982bc0, 0x48982bc0, + 0x48985305, 0x48985305, 0x48985305, 0x48985305, 0x48985305, 0x48987a4a, 0x48987a4a, 0x48987a4a, + 0x48987a4a, 0x48987a4a, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898c8d4, + 0x4898c8d4, 0x4898c8d4, 0x4898c8d4, 0x4898c8d4, 0x4898f019, 0x4898f019, 0x4898f019, 0x4898f019, + 0x4898f019, 0x4899175e, 0x4899175e, 0x4899175e, 0x4899175e, 0x4899175e, 0x48993ea3, 0x48993ea3, + 0x48993ea3, 0x48993ea3, 0x48993ea3, 0x489965e8, 0x489965e8, 0x489965e8, 0x489965e8, 0x489965e8, + 0x431d1463, 0x431d1463, 0x431d1463, 0x431d1463, 0x431d1463, 0x43ba23ad, 0x43ba23ad, 0x43ba23ad, + 0x43ba23ad, 0x43ba23ad, 0x4412de95, 0x4412de95, 0x4412de95, 0x4412de95, 0x4412de95, 0x4448ab53, + 0x4448ab53, 0x4448ab53, 0x4448ab53, 0x4448ab53, 0x447e7811, 0x447e7811, 0x447e7811, 0x447e7811, + 0x447e7811, 0x449a2267, 0x449a2267, 0x449a2267, 0x449a2267, 0x449a2267, 0x44b508c6, 0x44b508c6, + 0x44b508c6, 0x44b508c6, 0x44b508c6, 0x44cfef25, 0x44cfef25, 0x44cfef25, 0x44cfef25, 0x44cfef25, + 0x44ead584, 0x44ead584, 0x44ead584, 0x44ead584, 0x44ead584, 0x4502ddf2, 0x4502ddf2, 0x4502ddf2, + 0x4502ddf2, 0x4502ddf2, 0x45105121, 0x45105121, 0x45105121, 0x45105121, 0x45105121, 0x451dc451, + 0x451dc451, 0x451dc451, 0x451dc451, 0x451dc451, 0x452b3780, 0x452b3780, 0x452b3780, 0x452b3780, + 0x452b3780, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x45461ddf, 0x45461ddf, + 0x45461ddf, 0x45461ddf, 0x45461ddf, 0x4553910f, 0x4553910f, 0x4553910f, 0x4553910f, 0x4553910f, + 0x4561043e, 0x4561043e, 0x4561043e, 0x4561043e, 0x4561043e, 0x456e776e, 0x456e776e, 0x456e776e, + 0x456e776e, 0x456e776e, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x4584aee6, + 0x4584aee6, 0x4584aee6, 0x4584aee6, 0x4584aee6, 0x458b687e, 0x458b687e, 0x458b687e, 0x458b687e, + 0x458b687e, 0x45922216, 0x45922216, 0x45922216, 0x45922216, 0x45922216, 0x4598dbae, 0x4598dbae, + 0x4598dbae, 0x4598dbae, 0x4598dbae, 0x459f9545, 0x459f9545, 0x459f9545, 0x459f9545, 0x459f9545, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3b6906d7, 0x3a0da68d, 0x3a0da68d, 0x3a0da68d, 0x3a0da68d, 0x3a0da68d, 0xbb2233a6, 0xbb2233a6, + 0xbb2233a6, 0xbb2233a6, 0xbb2233a6, 0xbbb3e847, 0xbbb3e847, 0xbbb3e847, 0xbbb3e847, 0xbbb3e847, + 0xbc0b5b28, 0xbc0b5b28, 0xbc0b5b28, 0xbc0b5b28, 0xbc0b5b28, 0xbc3cc1da, 0xbc3cc1da, 0xbc3cc1da, + 0xbc3cc1da, 0xbc3cc1da, 0xbc6e281b, 0xbc6e281b, 0xbc6e281b, 0xbc6e281b, 0xbc6e281b, 0x3c606c9f, + 0x3c606c9f, 0x3c606c9f, 0x3c606c9f, 0x3c606c9f, 0x3c2f063b, 0x3c2f063b, 0x3c2f063b, 0x3c2f063b, + 0x3c2f063b, 0x3bfb3ee0, 0x3bfb3ee0, 0x3bfb3ee0, 0x3bfb3ee0, 0x3bfb3ee0, 0x3b9870b3, 0x3b9870b3, + 0x3b9870b3, 0x3b9870b3, 0x3b9870b3, 0x3ad688ac, 0x3ad688ac, 0x3ad688ac, 0x3ad688ac, 0x3ad688ac, + 0xbab4b1f2, 0xbab4b1f2, 0xbab4b1f2, 0xbab4b1f2, 0xbab4b1f2, 0xbb8ffb09, 0xbb8ffb09, 0xbb8ffb09, + 0xbb8ffb09, 0xbb8ffb09, 0xbbf2c940, 0xbbf2c940, 0xbbf2c940, 0xbbf2c940, 0xbbf2c940, 0xbc2acb73, + 0xbc2acb73, 0xbc2acb73, 0xbc2acb73, 0xbc2acb73, 0xbc5c31e0, 0xbc5c31e0, 0xbc5c31e0, 0xbc5c31e0, + 0xbc5c31e0, 0x3c7262d5, 0x3c7262d5, 0x3c7262d5, 0x3c7262d5, 0x3c7262d5, 0x3c40fc9e, 0x3c40fc9e, + 0x3c40fc9e, 0x3c40fc9e, 0x3c40fc9e, 0x3c0f95f5, 0x3c0f95f5, 0x3c0f95f5, 0x3c0f95f5, 0x3c0f95f5, + 0x3bbc5dee, 0x3bbc5dee, 0x3bbc5dee, 0x3bbc5dee, 0x3bbc5dee, 0x3b331f01, 0x3b331f01, 0x3b331f01, + 0x3b331f01, 0x3b331f01, 0xb993f227, 0xb993f227, 0xb993f227, 0xb993f227, 0xb993f227, 0xbb581b7f, + 0xbb581b7f, 0xbb581b7f, 0xbb581b7f, 0xbb581b7f, 0xbbcedc1d, 0xbbcedc1d, 0xbbcedc1d, 0xbbcedc1d, + 0xbbcedc1d, 0xbc18d4ff, 0xbc18d4ff, 0xbc18d4ff, 0xbc18d4ff, 0xbc18d4ff, 0xbc4a3b95, 0xbc4a3b95, + 0xbc4a3b95, 0xbc4a3b95, 0xbc4a3b95, 0xbc7ba1b2, 0xbc7ba1b2, 0xbc7ba1b2, 0xbc7ba1b2, 0xbc7ba1b2, + 0x36455799, 0x36455799, 0x36455799, 0x36455799, 0x36455799, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0xb7972331, 0xb7972331, 0xb7972331, 0xb7972331, 0xb7972331, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x37959b6f, 0x37959b6f, 0x37959b6f, 0x37959b6f, + 0x37959b6f, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3835f62a, 0x3835f62a, + 0x3835f62a, 0x3835f62a, 0x3835f62a, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, + 0xb836ba0b, 0xb836ba0b, 0xb836ba0b, 0xb836ba0b, 0xb836ba0b, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x38377dec, 0x38377dec, 0x38377dec, 0x38377dec, 0x38377dec, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb83841cd, 0xb83841cd, 0xb83841cd, 0xb83841cd, + 0xb83841cd, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x383905ae, 0x383905ae, + 0x383905ae, 0x383905ae, 0x383905ae, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, + 0xb839c98f, 0xb839c98f, 0xb839c98f, 0xb839c98f, 0xb839c98f, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x383a8d70, 0x383a8d70, 0x383a8d70, 0x383a8d70, 0x383a8d70, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb83b5151, 0xb83b5151, 0xb83b5151, 0xb83b5151, + 0xb83b5151, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb950fab3, 0xb950fab3, + 0xb950fab3, 0xb950fab3, 0xb950fab3, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, +] )) ), + +################ chunk 10240 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45ad0875, 0x45ad0875, 0x45ad0875, + 0x45ad0875, 0x45ad0875, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45ba7ba4, + 0x45ba7ba4, 0x45ba7ba4, 0x45ba7ba4, 0x45ba7ba4, 0x45c1353c, 0x45c1353c, 0x45c1353c, 0x45c1353c, + 0x45c1353c, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45cea86c, 0x45cea86c, + 0x45cea86c, 0x45cea86c, 0x45cea86c, 0x45d56203, 0x45d56203, 0x45d56203, 0x45d56203, 0x45d56203, + 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45e2d533, 0x45e2d533, 0x45e2d533, + 0x45e2d533, 0x45e2d533, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45f04862, + 0x45f04862, 0x45f04862, 0x45f04862, 0x45f04862, 0x45f701fa, 0x45f701fa, 0x45f701fa, 0x45f701fa, + 0x45f701fa, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x46023a95, 0x46023a95, + 0x46023a95, 0x46023a95, 0x46023a95, 0x46059761, 0x46059761, 0x46059761, 0x46059761, 0x46059761, + 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x460c50f8, 0x460c50f8, 0x460c50f8, + 0x460c50f8, 0x460c50f8, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x46130a90, + 0x46130a90, 0x46130a90, 0x46130a90, 0x46130a90, 0x4616675c, 0x4616675c, 0x4616675c, 0x4616675c, + 0x4616675c, 0x4619c428, 0x4619c428, 0x4619c428, 0x4619c428, 0x4619c428, 0x461d20f4, 0x461d20f4, + 0x461d20f4, 0x461d20f4, 0x461d20f4, 0x46207dc0, 0x46207dc0, 0x46207dc0, 0x46207dc0, 0x46207dc0, + 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x46273757, 0x46273757, 0x46273757, + 0x46273757, 0x46273757, 0x462a9423, 0x462a9423, 0x462a9423, 0x462a9423, 0x462a9423, 0x462df0ef, + 0x462df0ef, 0x462df0ef, 0x462df0ef, 0x462df0ef, 0x46314dbb, 0x46314dbb, 0x46314dbb, 0x46314dbb, + 0x46314dbb, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x46380753, 0x46380753, + 0x46380753, 0x46380753, 0x46380753, 0x463b641f, 0x463b641f, 0x463b641f, 0x463b641f, 0x463b641f, + 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x46421db6, 0x46421db6, 0x46421db6, + 0x46421db6, 0x46421db6, 0x46457a82, 0x46457a82, 0x46457a82, 0x46457a82, 0x46457a82, 0x4648d74e, + 0x4648d74e, 0x4648d74e, 0x4648d74e, 0x4648d74e, 0x464c341a, 0x464c341a, 0x464c341a, 0x464c341a, + 0x464c341a, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x4652edb2, 0x4652edb2, + 0x4652edb2, 0x4652edb2, 0x4652edb2, 0x46564a7e, 0x46564a7e, 0x46564a7e, 0x46564a7e, 0x46564a7e, + 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x465d0415, 0x465d0415, 0x465d0415, + 0x465d0415, 0x465d0415, 0x466060e1, 0x466060e1, 0x466060e1, 0x466060e1, 0x466060e1, 0x4663bdad, + 0x4663bdad, 0x4663bdad, 0x4663bdad, 0x4663bdad, 0x46671a79, 0x46671a79, 0x46671a79, 0x46671a79, + 0x46671a79, 0x466a7745, 0x466a7745, 0x466a7745, 0x466a7745, 0x466a7745, 0x466dd411, 0x466dd411, + 0x466dd411, 0x466dd411, 0x466dd411, 0x467130dd, 0x467130dd, 0x467130dd, 0x467130dd, 0x467130dd, + 0x46748da9, 0x46748da9, 0x46748da9, 0x46748da9, 0x46748da9, 0x4677ea74, 0x4677ea74, 0x4677ea74, + 0x4677ea74, 0x4677ea74, 0x467b4740, 0x467b4740, 0x467b4740, 0x467b4740, 0x467b4740, 0x467ea40c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xb83cd913, 0xb83cd913, 0xb83cd913, 0xb83cd913, 0xb83cd913, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0xb95098c3, 0xb95098c3, 0xb95098c3, 0xb95098c3, 0xb95098c3, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb83e60d5, 0xb83e60d5, 0xb83e60d5, 0xb83e60d5, + 0xb83e60d5, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb95036d2, 0xb95036d2, + 0xb95036d2, 0xb95036d2, 0xb95036d2, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, + 0xb83fe897, 0xb83fe897, 0xb83fe897, 0xb83fe897, 0xb83fe897, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0xb94fd4e2, 0xb94fd4e2, 0xb94fd4e2, 0xb94fd4e2, 0xb94fd4e2, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb841705a, 0xb841705a, 0xb841705a, 0xb841705a, + 0xb841705a, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94f72f1, 0xb94f72f1, + 0xb94f72f1, 0xb94f72f1, 0xb94f72f1, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e7a0fc, 0x39e7a0fc, 0x39e7a0fc, 0x39e7a0fc, 0x39e7a0fc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3998777f, 0x3998777f, 0x3998777f, 0x3998777f, 0x3998777f, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8447fde, 0xb8447fde, 0xb8447fde, 0xb8447fde, + 0xb8447fde, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94eaf10, 0xb94eaf10, + 0xb94eaf10, 0xb94eaf10, 0xb94eaf10, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e73f0c, 0x39e73f0c, 0x39e73f0c, 0x39e73f0c, 0x39e73f0c, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3998d970, 0x3998d970, 0x3998d970, 0x3998d970, 0x3998d970, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8478f62, 0xb8478f62, 0xb8478f62, 0xb8478f62, + 0xb8478f62, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94deb2f, 0xb94deb2f, + 0xb94deb2f, 0xb94deb2f, 0xb94deb2f, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e6dd1b, 0x39e6dd1b, 0x39e6dd1b, 0x39e6dd1b, 0x39e6dd1b, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x39993b61, 0x39993b61, 0x39993b61, 0x39993b61, 0x39993b61, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb84a9ee6, 0xb84a9ee6, 0xb84a9ee6, 0xb84a9ee6, + 0xb84a9ee6, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94d274e, 0xb94d274e, + 0xb94d274e, 0xb94d274e, 0xb94d274e, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e67b2a, 0x39e67b2a, 0x39e67b2a, 0x39e67b2a, 0x39e67b2a, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x39999d51, 0x39999d51, 0x39999d51, 0x39999d51, 0x39999d51, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb84dae6b, 0xb84dae6b, 0xb84dae6b, 0xb84dae6b, + 0xb84dae6b, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94c636d, 0xb94c636d, + 0xb94c636d, 0xb94c636d, 0xb94c636d, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e6193a, 0x39e6193a, 0x39e6193a, 0x39e6193a, 0x39e6193a, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3999ff42, 0x3999ff42, 0x3999ff42, 0x3999ff42, 0x3999ff42, 0xbf800000, +] )) ), + +################ chunk 10752 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x467ea40c, 0x467ea40c, 0x467ea40c, 0x467ea40c, 0x4681006c, 0x4681006c, 0x4681006c, 0x4681006c, + 0x4681006c, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x46845d38, 0x46845d38, + 0x46845d38, 0x46845d38, 0x46845d38, 0x46860b9e, 0x46860b9e, 0x46860b9e, 0x46860b9e, 0x46860b9e, + 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4689686a, 0x4689686a, 0x4689686a, + 0x4689686a, 0x4689686a, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468cc536, + 0x468cc536, 0x468cc536, 0x468cc536, 0x468cc536, 0x468e739c, 0x468e739c, 0x468e739c, 0x468e739c, + 0x468e739c, 0x46902201, 0x46902201, 0x46902201, 0x46902201, 0x46902201, 0x4691d067, 0x4691d067, + 0x4691d067, 0x4691d067, 0x4691d067, 0x46937ecd, 0x46937ecd, 0x46937ecd, 0x46937ecd, 0x46937ecd, + 0x46952d33, 0x46952d33, 0x46952d33, 0x46952d33, 0x46952d33, 0x4696db99, 0x4696db99, 0x4696db99, + 0x4696db99, 0x4696db99, 0x469889ff, 0x469889ff, 0x469889ff, 0x469889ff, 0x469889ff, 0x469a3865, + 0x469a3865, 0x469a3865, 0x469a3865, 0x469a3865, 0x469be6cb, 0x469be6cb, 0x469be6cb, 0x469be6cb, + 0x469be6cb, 0x469d9531, 0x469d9531, 0x469d9531, 0x469d9531, 0x469d9531, 0x469f4397, 0x469f4397, + 0x469f4397, 0x469f4397, 0x469f4397, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, + 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a44ec9, 0x46a44ec9, 0x46a44ec9, + 0x46a44ec9, 0x46a44ec9, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a7ab95, + 0x46a7ab95, 0x46a7ab95, 0x46a7ab95, 0x46a7ab95, 0x46a959fb, 0x46a959fb, 0x46a959fb, 0x46a959fb, + 0x46a959fb, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46acb6c6, 0x46acb6c6, + 0x46acb6c6, 0x46acb6c6, 0x46acb6c6, 0x46ae652c, 0x46ae652c, 0x46ae652c, 0x46ae652c, 0x46ae652c, + 0x46b01392, 0x46b01392, 0x46b01392, 0x46b01392, 0x46b01392, 0x46b1c1f8, 0x46b1c1f8, 0x46b1c1f8, + 0x46b1c1f8, 0x46b1c1f8, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b51ec4, + 0x46b51ec4, 0x46b51ec4, 0x46b51ec4, 0x46b51ec4, 0x46b6cd2a, 0x46b6cd2a, 0x46b6cd2a, 0x46b6cd2a, + 0x46b6cd2a, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46ba29f6, 0x46ba29f6, + 0x46ba29f6, 0x46ba29f6, 0x46ba29f6, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, + 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bf3528, 0x46bf3528, 0x46bf3528, + 0x46bf3528, 0x46bf3528, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c291f4, + 0x46c291f4, 0x46c291f4, 0x46c291f4, 0x46c291f4, 0x46c4405a, 0x46c4405a, 0x46c4405a, 0x46c4405a, + 0x46c4405a, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c79d25, 0x46c79d25, + 0x46c79d25, 0x46c79d25, 0x46c79d25, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, + 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46cca857, 0x46cca857, 0x46cca857, + 0x46cca857, 0x46cca857, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46d00523, + 0x46d00523, 0x46d00523, 0x46d00523, 0x46d00523, 0x46d1b389, 0x46d1b389, 0x46d1b389, 0x46d1b389, + 0x46d1b389, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d51055, 0x46d51055, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb850bdef, 0xb850bdef, 0xb850bdef, 0xb850bdef, + 0xb850bdef, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94b9f8c, 0xb94b9f8c, + 0xb94b9f8c, 0xb94b9f8c, 0xb94b9f8c, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e5b749, 0x39e5b749, 0x39e5b749, 0x39e5b749, 0x39e5b749, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0xba32cf66, 0xba32cf66, 0xba32cf66, 0xba32cf66, 0xba32cf66, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a72c327, 0x3a72c327, 0x3a72c327, 0x3a72c327, + 0x3a72c327, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4d4914, 0x3a4d4914, + 0x3a4d4914, 0x3a4d4914, 0x3a4d4914, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba0d5553, 0xba0d5553, 0xba0d5553, 0xba0d5553, 0xba0d5553, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x399ac323, 0x399ac323, 0x399ac323, 0x399ac323, 0x399ac323, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb856dcf7, 0xb856dcf7, 0xb856dcf7, 0xb856dcf7, + 0xb856dcf7, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94a17ca, 0xb94a17ca, + 0xb94a17ca, 0xb94a17ca, 0xb94a17ca, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e4f368, 0x39e4f368, 0x39e4f368, 0x39e4f368, 0x39e4f368, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0xba326d75, 0xba326d75, 0xba326d75, 0xba326d75, 0xba326d75, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a726136, 0x3a726136, 0x3a726136, 0x3a726136, + 0x3a726136, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4dab04, 0x3a4dab04, + 0x3a4dab04, 0x3a4dab04, 0x3a4dab04, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba0db743, 0xba0db743, 0xba0db743, 0xba0db743, 0xba0db743, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x399b8704, 0x399b8704, 0x399b8704, 0x399b8704, 0x399b8704, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb85cfc00, 0xb85cfc00, 0xb85cfc00, 0xb85cfc00, + 0xb85cfc00, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb9489008, 0xb9489008, + 0xb9489008, 0xb9489008, 0xb9489008, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e42f87, 0x39e42f87, 0x39e42f87, 0x39e42f87, 0x39e42f87, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0xba320b85, 0xba320b85, 0xba320b85, 0xba320b85, 0xba320b85, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a71ff45, 0x3a71ff45, 0x3a71ff45, 0x3a71ff45, + 0x3a71ff45, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4e0cf5, 0x3a4e0cf5, + 0x3a4e0cf5, 0x3a4e0cf5, 0x3a4e0cf5, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba0e1934, 0xba0e1934, 0xba0e1934, 0xba0e1934, 0xba0e1934, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x399c4ae5, 0x399c4ae5, 0x399c4ae5, 0x399c4ae5, 0x399c4ae5, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8631b08, 0xb8631b08, 0xb8631b08, 0xb8631b08, + 0xb8631b08, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb9470846, 0xb9470846, +] )) ), + +################ chunk 11264 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x46d51055, 0x46d51055, 0x46d51055, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, + 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46da1b87, 0x46da1b87, 0x46da1b87, + 0x46da1b87, 0x46da1b87, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dd7853, + 0x46dd7853, 0x46dd7853, 0x46dd7853, 0x46dd7853, 0x46df26b9, 0x46df26b9, 0x46df26b9, 0x46df26b9, + 0x46df26b9, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e28384, 0x46e28384, + 0x46e28384, 0x46e28384, 0x46e28384, 0x46e431ea, 0x46e431ea, 0x46e431ea, 0x46e431ea, 0x46e431ea, + 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e78eb6, 0x46e78eb6, 0x46e78eb6, + 0x46e78eb6, 0x46e78eb6, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46eaeb82, + 0x46eaeb82, 0x46eaeb82, 0x46eaeb82, 0x46eaeb82, 0x46ec99e8, 0x46ec99e8, 0x46ec99e8, 0x46ec99e8, + 0x46ec99e8, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46eff6b4, 0x46eff6b4, + 0x46eff6b4, 0x46eff6b4, 0x46eff6b4, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, + 0x46f35380, 0x46f35380, 0x46f35380, 0x46f35380, 0x46f35380, 0x46f501e6, 0x46f501e6, 0x46f501e6, + 0x46f501e6, 0x46f501e6, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f85eb2, + 0x46f85eb2, 0x46f85eb2, 0x46f85eb2, 0x46f85eb2, 0x46fa0d18, 0x46fa0d18, 0x46fa0d18, 0x46fa0d18, + 0x46fa0d18, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fd69e3, 0x46fd69e3, + 0x46fd69e3, 0x46fd69e3, 0x46fd69e3, 0x46ff1849, 0x46ff1849, 0x46ff1849, 0x46ff1849, 0x46ff1849, + 0x47006358, 0x47006358, 0x47006358, 0x47006358, 0x47006358, 0x47013a8b, 0x47013a8b, 0x47013a8b, + 0x47013a8b, 0x47013a8b, 0x470211be, 0x470211be, 0x470211be, 0x470211be, 0x470211be, 0x4702e8f1, + 0x4702e8f1, 0x4702e8f1, 0x4702e8f1, 0x4702e8f1, 0x4703c024, 0x4703c024, 0x4703c024, 0x4703c024, + 0x4703c024, 0x47049756, 0x47049756, 0x47049756, 0x47049756, 0x47049756, 0x47056e89, 0x47056e89, + 0x47056e89, 0x47056e89, 0x47056e89, 0x470645bc, 0x470645bc, 0x470645bc, 0x470645bc, 0x470645bc, + 0x47071cef, 0x47071cef, 0x47071cef, 0x47071cef, 0x47071cef, 0x4707f422, 0x4707f422, 0x4707f422, + 0x4707f422, 0x4707f422, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4709a288, + 0x4709a288, 0x4709a288, 0x4709a288, 0x4709a288, 0x470a79bb, 0x470a79bb, 0x470a79bb, 0x470a79bb, + 0x470a79bb, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470c2821, 0x470c2821, + 0x470c2821, 0x470c2821, 0x470c2821, 0x470cff54, 0x470cff54, 0x470cff54, 0x470cff54, 0x470cff54, + 0x470dd687, 0x470dd687, 0x470dd687, 0x470dd687, 0x470dd687, 0x470eadba, 0x470eadba, 0x470eadba, + 0x470eadba, 0x470eadba, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x47105c20, + 0x47105c20, 0x47105c20, 0x47105c20, 0x47105c20, 0x47113353, 0x47113353, 0x47113353, 0x47113353, + 0x47113353, 0x47120a86, 0x47120a86, 0x47120a86, 0x47120a86, 0x47120a86, 0x4712e1b9, 0x4712e1b9, + 0x4712e1b9, 0x4712e1b9, 0x4712e1b9, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, + 0x4714901f, 0x4714901f, 0x4714901f, 0x4714901f, 0x4714901f, 0x47156752, 0x47156752, 0x47156752, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xb9470846, 0xb9470846, 0xb9470846, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e36ba6, 0x39e36ba6, 0x39e36ba6, 0x39e36ba6, 0x39e36ba6, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0xba31a994, 0xba31a994, 0xba31a994, 0xba31a994, 0xba31a994, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a719d55, 0x3a719d55, 0x3a719d55, 0x3a719d55, + 0x3a719d55, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4e6ee5, 0x3a4e6ee5, + 0x3a4e6ee5, 0x3a4e6ee5, 0x3a4e6ee5, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba0e7b24, 0xba0e7b24, 0xba0e7b24, 0xba0e7b24, 0xba0e7b24, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x399d0ec6, 0x399d0ec6, 0x399d0ec6, 0x399d0ec6, 0x399d0ec6, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8693a11, 0xb8693a11, 0xb8693a11, 0xb8693a11, + 0xb8693a11, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb9458083, 0xb9458083, + 0xb9458083, 0xb9458083, 0xb9458083, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e2a7c5, 0x39e2a7c5, 0x39e2a7c5, 0x39e2a7c5, 0x39e2a7c5, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0xba3147a4, 0xba3147a4, 0xba3147a4, 0xba3147a4, 0xba3147a4, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a713b64, 0x3a713b64, 0x3a713b64, 0x3a713b64, + 0x3a713b64, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4ed0d6, 0x3a4ed0d6, + 0x3a4ed0d6, 0x3a4ed0d6, 0x3a4ed0d6, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0x3ab89171, 0x3ab89171, 0x3ab89171, 0x3ab89171, 0x3ab89171, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, + 0x3f7fffec, 0x3f7fffec, 0xbad88b50, 0xbad88b50, 0xbad88b50, 0xbad88b50, 0xbad88b50, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af8852d, 0x3af8852d, 0x3af8852d, 0x3af8852d, + 0x3af8852d, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae780e0, 0x3ae780e0, + 0x3ae780e0, 0x3ae780e0, 0x3ae780e0, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, + 0xbac78702, 0xbac78702, 0xbac78702, 0xbac78702, 0xbac78702, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3aa78d23, 0x3aa78d23, 0x3aa78d23, 0x3aa78d23, 0x3aa78d23, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba879343, 0xba879343, 0xba879343, 0xba879343, + 0xba879343, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4f32c7, 0x3a4f32c7, + 0x3a4f32c7, 0x3a4f32c7, 0x3a4f32c7, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba0f3f06, 0xba0f3f06, 0xba0f3f06, 0xba0f3f06, 0xba0f3f06, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x399e9688, 0x399e9688, 0x399e9688, 0x399e9688, 0x399e9688, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8757822, 0xb8757822, 0xb8757822, 0xb8757822, + 0xb8757822, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94270ff, 0xb94270ff, + 0xb94270ff, 0xb94270ff, 0xb94270ff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39e12003, 0x39e12003, 0x39e12003, 0x39e12003, 0x39e12003, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, +] )) ), + +################ chunk 11776 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47156752, 0x47156752, 0x47163e85, 0x47163e85, 0x47163e85, 0x47163e85, 0x47163e85, 0x471715b8, + 0x471715b8, 0x471715b8, 0x471715b8, 0x471715b8, 0x4717eceb, 0x4717eceb, 0x4717eceb, 0x4717eceb, + 0x4717eceb, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x47199b51, 0x47199b51, + 0x47199b51, 0x47199b51, 0x47199b51, 0x471a7284, 0x471a7284, 0x471a7284, 0x471a7284, 0x471a7284, + 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471c20ea, 0x471c20ea, 0x471c20ea, + 0x471c20ea, 0x471c20ea, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471dcf50, + 0x471dcf50, 0x471dcf50, 0x471dcf50, 0x471dcf50, 0x471ea683, 0x471ea683, 0x471ea683, 0x471ea683, + 0x471ea683, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x472054e8, 0x472054e8, + 0x472054e8, 0x472054e8, 0x472054e8, 0x47212c1b, 0x47212c1b, 0x47212c1b, 0x47212c1b, 0x47212c1b, + 0x4722034e, 0x4722034e, 0x4722034e, 0x4722034e, 0x4722034e, 0x4722da81, 0x4722da81, 0x4722da81, + 0x4722da81, 0x4722da81, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x472488e7, + 0x472488e7, 0x472488e7, 0x472488e7, 0x472488e7, 0x4725601a, 0x4725601a, 0x4725601a, 0x4725601a, + 0x4725601a, 0x4726374d, 0x4726374d, 0x4726374d, 0x4726374d, 0x4726374d, 0x47270e80, 0x47270e80, + 0x47270e80, 0x47270e80, 0x47270e80, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, + 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x47299419, 0x47299419, 0x47299419, + 0x47299419, 0x47299419, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472b427f, + 0x472b427f, 0x472b427f, 0x472b427f, 0x472b427f, 0x472c19b2, 0x472c19b2, 0x472c19b2, 0x472c19b2, + 0x472c19b2, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472dc818, 0x472dc818, + 0x472dc818, 0x472dc818, 0x472dc818, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, + 0x472f767e, 0x472f767e, 0x472f767e, 0x472f767e, 0x472f767e, 0x47304db1, 0x47304db1, 0x47304db1, + 0x47304db1, 0x47304db1, 0x473124e4, 0x473124e4, 0x473124e4, 0x473124e4, 0x473124e4, 0x4731fc17, + 0x4731fc17, 0x4731fc17, 0x4731fc17, 0x4731fc17, 0x4732d34a, 0x4732d34a, 0x4732d34a, 0x4732d34a, + 0x4732d34a, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x473481b0, 0x473481b0, + 0x473481b0, 0x473481b0, 0x473481b0, 0x473558e3, 0x473558e3, 0x473558e3, 0x473558e3, 0x473558e3, + 0x47363016, 0x47363016, 0x47363016, 0x47363016, 0x47363016, 0x47370749, 0x47370749, 0x47370749, + 0x47370749, 0x47370749, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4738b5af, + 0x4738b5af, 0x4738b5af, 0x4738b5af, 0x4738b5af, 0x47398ce2, 0x47398ce2, 0x47398ce2, 0x47398ce2, + 0x47398ce2, 0x473a6414, 0x473a6414, 0x473a6414, 0x473a6414, 0x473a6414, 0x473b3b47, 0x473b3b47, + 0x473b3b47, 0x473b3b47, 0x473b3b47, 0x473c127a, 0x473c127a, 0x473c127a, 0x473c127a, 0x473c127a, + 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473dc0e0, 0x473dc0e0, 0x473dc0e0, + 0x473dc0e0, 0x473dc0e0, 0x473e9813, 0x473e9813, 0x473e9813, 0x473e9813, 0x473e9813, 0x473f6f46, + 0x473f6f46, 0x473f6f46, 0x473f6f46, 0x473f6f46, 0x47404679, 0x47404679, 0x47404679, 0x47404679, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffffd, 0x3f7ffffd, 0xba3083c3, 0xba3083c3, 0xba3083c3, 0xba3083c3, 0xba3083c3, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a707783, 0x3a707783, 0x3a707783, 0x3a707783, + 0x3a707783, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0xba9835a2, 0xba9835a2, + 0xba9835a2, 0xba9835a2, 0xba9835a2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, + 0x3ab82f81, 0x3ab82f81, 0x3ab82f81, 0x3ab82f81, 0x3ab82f81, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, + 0x3f7fffec, 0x3f7fffec, 0xbad8295f, 0xbad8295f, 0xbad8295f, 0xbad8295f, 0xbad8295f, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af8233d, 0x3af8233d, 0x3af8233d, 0x3af8233d, + 0x3af8233d, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae7e2d0, 0x3ae7e2d0, + 0x3ae7e2d0, 0x3ae7e2d0, 0x3ae7e2d0, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, + 0xbac7e8f2, 0xbac7e8f2, 0xbac7e8f2, 0xbac7e8f2, 0xbac7e8f2, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0x3aa7ef13, 0x3aa7ef13, 0x3aa7ef13, 0x3aa7ef13, 0x3aa7ef13, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba87f534, 0xba87f534, 0xba87f534, 0xba87f534, + 0xba87f534, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4ff6a8, 0x3a4ff6a8, + 0x3a4ff6a8, 0x3a4ff6a8, 0x3a4ff6a8, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba1002e7, 0xba1002e7, 0xba1002e7, 0xba1002e7, 0xba1002e7, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x39a01e4a, 0x39a01e4a, 0x39a01e4a, 0x39a01e4a, 0x39a01e4a, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb880db19, 0xb880db19, 0xb880db19, 0xb880db19, + 0xb880db19, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb93f617b, 0xb93f617b, + 0xb93f617b, 0xb93f617b, 0xb93f617b, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39df9841, 0x39df9841, 0x39df9841, 0x39df9841, 0x39df9841, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0xba2fbfe2, 0xba2fbfe2, 0xba2fbfe2, 0xba2fbfe2, 0xba2fbfe2, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a6fb3a2, 0x3a6fb3a2, 0x3a6fb3a2, 0x3a6fb3a2, + 0x3a6fb3a2, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0xba97d3b1, 0xba97d3b1, + 0xba97d3b1, 0xba97d3b1, 0xba97d3b1, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, + 0x3ab7cd90, 0x3ab7cd90, 0x3ab7cd90, 0x3ab7cd90, 0x3ab7cd90, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0xbad7c76f, 0xbad7c76f, 0xbad7c76f, 0xbad7c76f, 0xbad7c76f, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af7c14c, 0x3af7c14c, 0x3af7c14c, 0x3af7c14c, + 0x3af7c14c, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae844c1, 0x3ae844c1, + 0x3ae844c1, 0x3ae844c1, 0x3ae844c1, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, + 0xbac84ae3, 0xbac84ae3, 0xbac84ae3, 0xbac84ae3, 0xbac84ae3, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0x3aa85104, 0x3aa85104, 0x3aa85104, 0x3aa85104, 0x3aa85104, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba885724, 0xba885724, 0xba885724, 0xba885724, +] )) ), + +################ chunk 12288 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47404679, 0x47411dac, 0x47411dac, 0x47411dac, 0x47411dac, 0x47411dac, 0x4741f4df, 0x4741f4df, + 0x4741f4df, 0x4741f4df, 0x4741f4df, 0x4742cc12, 0x4742cc12, 0x4742cc12, 0x4742cc12, 0x4742cc12, + 0x4743a345, 0x4743a345, 0x4743a345, 0x4743a345, 0x4743a345, 0x47447a78, 0x47447a78, 0x47447a78, + 0x47447a78, 0x47447a78, 0x474551ab, 0x474551ab, 0x474551ab, 0x474551ab, 0x474551ab, 0x474628de, + 0x474628de, 0x474628de, 0x474628de, 0x474628de, 0x47470011, 0x47470011, 0x47470011, 0x47470011, + 0x47470011, 0x4747d744, 0x4747d744, 0x4747d744, 0x4747d744, 0x4747d744, 0x4748ae77, 0x4748ae77, + 0x4748ae77, 0x4748ae77, 0x4748ae77, 0x474985aa, 0x474985aa, 0x474985aa, 0x474985aa, 0x474985aa, + 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474b3410, 0x474b3410, 0x474b3410, + 0x474b3410, 0x474b3410, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474ce276, + 0x474ce276, 0x474ce276, 0x474ce276, 0x474ce276, 0x474db9a9, 0x474db9a9, 0x474db9a9, 0x474db9a9, + 0x474db9a9, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474f680f, 0x474f680f, + 0x474f680f, 0x474f680f, 0x474f680f, 0x47503f42, 0x47503f42, 0x47503f42, 0x47503f42, 0x47503f42, + 0x47511675, 0x47511675, 0x47511675, 0x47511675, 0x47511675, 0x4751eda8, 0x4751eda8, 0x4751eda8, + 0x4751eda8, 0x4751eda8, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x47539c0e, + 0x47539c0e, 0x47539c0e, 0x47539c0e, 0x47539c0e, 0x47547341, 0x47547341, 0x47547341, 0x47547341, + 0x47547341, 0x47554a73, 0x47554a73, 0x47554a73, 0x47554a73, 0x47554a73, 0x475621a6, 0x475621a6, + 0x475621a6, 0x475621a6, 0x475621a6, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, + 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4758a73f, 0x4758a73f, 0x4758a73f, + 0x4758a73f, 0x4758a73f, 0x47597e72, 0x47597e72, 0x47597e72, 0x47597e72, 0x47597e72, 0x475a55a5, + 0x475a55a5, 0x475a55a5, 0x475a55a5, 0x475a55a5, 0x475b2cd8, 0x475b2cd8, 0x475b2cd8, 0x475b2cd8, + 0x475b2cd8, 0x475c040b, 0x475c040b, 0x475c040b, 0x475c040b, 0x475c040b, 0x475cdb3e, 0x475cdb3e, + 0x475cdb3e, 0x475cdb3e, 0x475cdb3e, 0x475db271, 0x475db271, 0x475db271, 0x475db271, 0x475db271, + 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475f60d7, 0x475f60d7, 0x475f60d7, + 0x475f60d7, 0x475f60d7, 0x4760380a, 0x4760380a, 0x4760380a, 0x4760380a, 0x4760380a, 0x47610f3d, + 0x47610f3d, 0x47610f3d, 0x47610f3d, 0x47610f3d, 0x4761e670, 0x4761e670, 0x4761e670, 0x4761e670, + 0x4761e670, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x476394d6, 0x476394d6, + 0x476394d6, 0x476394d6, 0x476394d6, 0x47646c09, 0x47646c09, 0x47646c09, 0x47646c09, 0x47646c09, + 0x4765433c, 0x4765433c, 0x4765433c, 0x4765433c, 0x4765433c, 0x47661a6f, 0x47661a6f, 0x47661a6f, + 0x47661a6f, 0x47661a6f, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4767c8d5, + 0x4767c8d5, 0x4767c8d5, 0x4767c8d5, 0x4767c8d5, 0x4768a008, 0x4768a008, 0x4768a008, 0x4768a008, + 0x4768a008, 0x4769773b, 0x4769773b, 0x4769773b, 0x4769773b, 0x4769773b, 0x476a4e6e, 0x476a4e6e, + 0x476a4e6e, 0x476a4e6e, 0x476a4e6e, 0x476b25a1, 0x476b25a1, 0x476b25a1, 0x476b25a1, 0x476b25a1, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xba885724, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a50ba89, 0x3a50ba89, + 0x3a50ba89, 0x3a50ba89, 0x3a50ba89, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba10c6c8, 0xba10c6c8, 0xba10c6c8, 0xba10c6c8, 0xba10c6c8, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x39a1a60c, 0x39a1a60c, 0x39a1a60c, 0x39a1a60c, 0x39a1a60c, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb886fa22, 0xb886fa22, 0xb886fa22, 0xb886fa22, + 0xb886fa22, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb93c51f7, 0xb93c51f7, + 0xb93c51f7, 0xb93c51f7, 0xb93c51f7, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39de107f, 0x39de107f, 0x39de107f, 0x39de107f, 0x39de107f, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0xba2efc01, 0xba2efc01, 0xba2efc01, 0xba2efc01, 0xba2efc01, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a6eefc1, 0x3a6eefc1, 0x3a6eefc1, 0x3a6eefc1, + 0x3a6eefc1, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0xba9771c1, 0xba9771c1, + 0xba9771c1, 0xba9771c1, 0xba9771c1, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, + 0x3ab76ba0, 0x3ab76ba0, 0x3ab76ba0, 0x3ab76ba0, 0x3ab76ba0, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0xbad7657e, 0xbad7657e, 0xbad7657e, 0xbad7657e, 0xbad7657e, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af75f5c, 0x3af75f5c, 0x3af75f5c, 0x3af75f5c, + 0x3af75f5c, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae8a6b1, 0x3ae8a6b1, + 0x3ae8a6b1, 0x3ae8a6b1, 0x3ae8a6b1, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, + 0xbac8acd3, 0xbac8acd3, 0xbac8acd3, 0xbac8acd3, 0xbac8acd3, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0x3aa8b2f4, 0x3aa8b2f4, 0x3aa8b2f4, 0x3aa8b2f4, 0x3aa8b2f4, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba88b915, 0xba88b915, 0xba88b915, 0xba88b915, + 0xba88b915, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a517e6a, 0x3a517e6a, + 0x3a517e6a, 0x3a517e6a, 0x3a517e6a, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba118aa9, 0xba118aa9, 0xba118aa9, 0xba118aa9, 0xba118aa9, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x39a32dce, 0x39a32dce, 0x39a32dce, 0x39a32dce, 0x39a32dce, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb88d192a, 0xb88d192a, 0xb88d192a, 0xb88d192a, + 0xb88d192a, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb9394272, 0xb9394272, + 0xb9394272, 0xb9394272, 0xb9394272, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x39dc88bd, 0x39dc88bd, 0x39dc88bd, 0x39dc88bd, 0x39dc88bd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0xba2e3820, 0xba2e3820, 0xba2e3820, 0xba2e3820, 0xba2e3820, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a6e2be0, 0x3a6e2be0, 0x3a6e2be0, 0x3a6e2be0, + 0x3a6e2be0, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0xba970fd0, 0xba970fd0, + 0xba970fd0, 0xba970fd0, 0xba970fd0, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, +] )) ), + +################ chunk 12800 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476cd407, 0x476cd407, 0x476cd407, + 0x476cd407, 0x476cd407, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476e826d, + 0x476e826d, 0x476e826d, 0x476e826d, 0x476e826d, 0x476f59a0, 0x476f59a0, 0x476f59a0, 0x476f59a0, + 0x476f59a0, 0x477030d2, 0x477030d2, 0x477030d2, 0x477030d2, 0x477030d2, 0x47710805, 0x47710805, + 0x47710805, 0x47710805, 0x47710805, 0x4771df38, 0x4771df38, 0x4771df38, 0x4771df38, 0x4771df38, + 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x47738d9e, 0x47738d9e, 0x47738d9e, + 0x47738d9e, 0x47738d9e, 0x477464d1, 0x477464d1, 0x477464d1, 0x477464d1, 0x477464d1, 0x47753c04, + 0x47753c04, 0x47753c04, 0x47753c04, 0x47753c04, 0x47761337, 0x47761337, 0x47761337, 0x47761337, + 0x47761337, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4777c19d, 0x4777c19d, + 0x4777c19d, 0x4777c19d, 0x4777c19d, 0x477898d0, 0x477898d0, 0x477898d0, 0x477898d0, 0x477898d0, + 0x47797003, 0x47797003, 0x47797003, 0x47797003, 0x47797003, 0x477a4736, 0x477a4736, 0x477a4736, + 0x477a4736, 0x477a4736, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477bf59c, + 0x477bf59c, 0x477bf59c, 0x477bf59c, 0x477bf59c, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, + 0x477ccccf, 0x477da402, 0x477da402, 0x477da402, 0x477da402, 0x477da402, 0x477e7b35, 0x477e7b35, + 0x477e7b35, 0x477e7b35, 0x477e7b35, 0x477f5268, 0x477f5268, 0x477f5268, 0x477f5268, 0x477f5268, + 0x478014cd, 0x478014cd, 0x478014cd, 0x478014cd, 0x478014cd, 0x47808067, 0x47808067, 0x47808067, + 0x47808067, 0x47808067, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4781579a, + 0x4781579a, 0x4781579a, 0x4781579a, 0x4781579a, 0x4781c333, 0x4781c333, 0x4781c333, 0x4781c333, + 0x4781c333, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47829a66, 0x47829a66, + 0x47829a66, 0x47829a66, 0x47829a66, 0x47830600, 0x47830600, 0x47830600, 0x47830600, 0x47830600, + 0x47837199, 0x47837199, 0x47837199, 0x47837199, 0x47837199, 0x4783dd33, 0x4783dd33, 0x4783dd33, + 0x4783dd33, 0x4783dd33, 0x478448cc, 0x478448cc, 0x478448cc, 0x478448cc, 0x478448cc, 0x4784b466, + 0x4784b466, 0x4784b466, 0x4784b466, 0x4784b466, 0x47851fff, 0x47851fff, 0x47851fff, 0x47851fff, + 0x47851fff, 0x47858b99, 0x47858b99, 0x47858b99, 0x47858b99, 0x47858b99, 0x4785f732, 0x4785f732, + 0x4785f732, 0x4785f732, 0x4785f732, 0x478662cc, 0x478662cc, 0x478662cc, 0x478662cc, 0x478662cc, + 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x478739ff, 0x478739ff, 0x478739ff, + 0x478739ff, 0x478739ff, 0x4787a598, 0x4787a598, 0x4787a598, 0x4787a598, 0x4787a598, 0x47881132, + 0x47881132, 0x47881132, 0x47881132, 0x47881132, 0x47887ccb, 0x47887ccb, 0x47887ccb, 0x47887ccb, + 0x47887ccb, 0x4788e865, 0x4788e865, 0x4788e865, 0x4788e865, 0x4788e865, 0x478953fe, 0x478953fe, + 0x478953fe, 0x478953fe, 0x478953fe, 0x4789bf98, 0x4789bf98, 0x4789bf98, 0x4789bf98, 0x4789bf98, + 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a96cb, 0x478a96cb, 0x478a96cb, + 0x478a96cb, 0x478a96cb, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b6dfe, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3ab709af, 0x3ab709af, 0x3ab709af, 0x3ab709af, 0x3ab709af, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0xbad7038e, 0xbad7038e, 0xbad7038e, 0xbad7038e, 0xbad7038e, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af6fd6c, 0x3af6fd6c, 0x3af6fd6c, 0x3af6fd6c, + 0x3af6fd6c, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae908a2, 0x3ae908a2, + 0x3ae908a2, 0x3ae908a2, 0x3ae908a2, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, + 0xbac90ec4, 0xbac90ec4, 0xbac90ec4, 0xbac90ec4, 0xbac90ec4, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0x3aa914e5, 0x3aa914e5, 0x3aa914e5, 0x3aa914e5, 0x3aa914e5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba891b05, 0xba891b05, 0xba891b05, 0xba891b05, + 0xba891b05, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a52424b, 0x3a52424b, + 0x3a52424b, 0x3a52424b, 0x3a52424b, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0xba124e8a, 0xba124e8a, 0xba124e8a, 0xba124e8a, 0xba124e8a, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x39a4b590, 0x39a4b590, 0x39a4b590, 0x39a4b590, 0x39a4b590, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8933833, 0xb8933833, 0xb8933833, 0xb8933833, + 0xb8933833, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb93632ee, 0xb93632ee, + 0xb93632ee, 0xb93632ee, 0xb93632ee, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0xbb649fc2, 0xbb649fc2, 0xbb649fc2, 0xbb649fc2, 0xbb649fc2, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3b54a2d8, 0x3b54a2d8, 0x3b54a2d8, 0x3b54a2d8, 0x3b54a2d8, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb44a5ec, 0xbb44a5ec, 0xbb44a5ec, 0xbb44a5ec, + 0xbb44a5ec, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3b34a900, 0x3b34a900, + 0x3b34a900, 0x3b34a900, 0x3b34a900, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, + 0xbb24ac13, 0xbb24ac13, 0xbb24ac13, 0xbb24ac13, 0xbb24ac13, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3b14af26, 0x3b14af26, 0x3b14af26, 0x3b14af26, 0x3b14af26, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbb04b238, 0xbb04b238, 0xbb04b238, 0xbb04b238, + 0xbb04b238, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, 0x3ae96a92, 0x3ae96a92, + 0x3ae96a92, 0x3ae96a92, 0x3ae96a92, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, + 0xbac970b4, 0xbac970b4, 0xbac970b4, 0xbac970b4, 0xbac970b4, 0x3f7fffcc, 0x3f7fffcc, 0x3f7fffcc, + 0x3f7fffcc, 0x3f7fffcc, 0x3aa976d5, 0x3aa976d5, 0x3aa976d5, 0x3aa976d5, 0x3aa976d5, 0xbf7fffc1, + 0xbf7fffc1, 0xbf7fffc1, 0xbf7fffc1, 0xbf7fffc1, 0xba897cf6, 0xba897cf6, 0xba897cf6, 0xba897cf6, + 0xba897cf6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3a53062c, 0x3a53062c, + 0x3a53062c, 0x3a53062c, 0x3a53062c, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, + 0xba13126b, 0xba13126b, 0xba13126b, 0xba13126b, 0xba13126b, 0x3f7fff9b, 0x3f7fff9b, 0x3f7fff9b, + 0x3f7fff9b, 0x3f7fff9b, 0x39a63d53, 0x39a63d53, 0x39a63d53, 0x39a63d53, 0x39a63d53, 0xbf7fff8c, +] )) ), + +################ chunk 13312 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x478b6dfe, 0x478b6dfe, 0x478b6dfe, 0x478b6dfe, 0x478bd997, 0x478bd997, 0x478bd997, 0x478bd997, + 0x478bd997, 0x478c4530, 0x478c4530, 0x478c4530, 0x478c4530, 0x478c4530, 0x478cb0ca, 0x478cb0ca, + 0x478cb0ca, 0x478cb0ca, 0x478cb0ca, 0x478d1c63, 0x478d1c63, 0x478d1c63, 0x478d1c63, 0x478d1c63, + 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478df396, 0x478df396, 0x478df396, + 0x478df396, 0x478df396, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478ecac9, + 0x478ecac9, 0x478ecac9, 0x478ecac9, 0x478ecac9, 0x478f3663, 0x478f3663, 0x478f3663, 0x478f3663, + 0x478f3663, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x47900d96, 0x47900d96, + 0x47900d96, 0x47900d96, 0x47900d96, 0x4790792f, 0x4790792f, 0x4790792f, 0x4790792f, 0x4790792f, + 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x47915062, 0x47915062, 0x47915062, + 0x47915062, 0x47915062, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x47922795, + 0x47922795, 0x47922795, 0x47922795, 0x47922795, 0x4792932f, 0x4792932f, 0x4792932f, 0x4792932f, + 0x4792932f, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x47936a62, 0x47936a62, + 0x47936a62, 0x47936a62, 0x47936a62, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, + 0x47944195, 0x47944195, 0x47944195, 0x47944195, 0x47944195, 0x4794ad2e, 0x4794ad2e, 0x4794ad2e, + 0x4794ad2e, 0x4794ad2e, 0x479518c8, 0x479518c8, 0x479518c8, 0x479518c8, 0x479518c8, 0x47958461, + 0x47958461, 0x47958461, 0x47958461, 0x47958461, 0x4795effb, 0x4795effb, 0x4795effb, 0x4795effb, + 0x4795effb, 0x47965b94, 0x47965b94, 0x47965b94, 0x47965b94, 0x47965b94, 0x4796c72e, 0x4796c72e, + 0x4796c72e, 0x4796c72e, 0x4796c72e, 0x479732c7, 0x479732c7, 0x479732c7, 0x479732c7, 0x479732c7, + 0x47979e61, 0x47979e61, 0x47979e61, 0x47979e61, 0x47979e61, 0x479809fa, 0x479809fa, 0x479809fa, + 0x479809fa, 0x479809fa, 0x47987594, 0x47987594, 0x47987594, 0x47987594, 0x47987594, 0x4798e12d, + 0x4798e12d, 0x4798e12d, 0x4798e12d, 0x4798e12d, 0x47994cc7, 0x47994cc7, 0x47994cc7, 0x47994cc7, + 0x47994cc7, 0x4799b860, 0x4799b860, 0x4799b860, 0x4799b860, 0x4799b860, 0x479a23f9, 0x479a23f9, + 0x479a23f9, 0x479a23f9, 0x479a23f9, 0x479a8f93, 0x479a8f93, 0x479a8f93, 0x479a8f93, 0x479a8f93, + 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479b66c6, 0x479b66c6, 0x479b66c6, + 0x479b66c6, 0x479b66c6, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479c3df9, + 0x479c3df9, 0x479c3df9, 0x479c3df9, 0x479c3df9, 0x479ca992, 0x479ca992, 0x479ca992, 0x479ca992, + 0x479ca992, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d80c5, 0x479d80c5, + 0x479d80c5, 0x479d80c5, 0x479d80c5, 0x479dec5f, 0x479dec5f, 0x479dec5f, 0x479dec5f, 0x479dec5f, + 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479ec392, 0x479ec392, 0x479ec392, + 0x479ec392, 0x479ec392, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f9ac5, + 0x479f9ac5, 0x479f9ac5, 0x479f9ac5, 0x479f9ac5, 0x47a0065e, 0x47a0065e, 0x47a0065e, 0x47a0065e, + 0x47a0065e, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a0dd91, 0x47a0dd91, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbf7fff8c, 0xbf7fff8c, 0xbf7fff8c, 0xbf7fff8c, 0xb899573b, 0xb899573b, 0xb899573b, 0xb899573b, + 0xb899573b, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0xb933236a, 0xb933236a, + 0xb933236a, 0xb933236a, 0xb933236a, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, + 0x39d97938, 0x39d97938, 0x39d97938, 0x39d97938, 0x39d97938, 0x3f7fffa1, 0x3f7fffa1, 0x3f7fffa1, + 0x3f7fffa1, 0x3f7fffa1, 0xba2cb05e, 0xba2cb05e, 0xba2cb05e, 0xba2cb05e, 0xba2cb05e, 0xbf7fffae, + 0xbf7fffae, 0xbf7fffae, 0xbf7fffae, 0xbf7fffae, 0x3a6ca41e, 0x3a6ca41e, 0x3a6ca41e, 0x3a6ca41e, + 0x3a6ca41e, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0xba964bef, 0xba964bef, + 0xba964bef, 0xba964bef, 0xba964bef, 0xbf7fffc6, 0xbf7fffc6, 0xbf7fffc6, 0xbf7fffc6, 0xbf7fffc6, + 0x3ab645ce, 0x3ab645ce, 0x3ab645ce, 0x3ab645ce, 0x3ab645ce, 0x3f7fffd0, 0x3f7fffd0, 0x3f7fffd0, + 0x3f7fffd0, 0x3f7fffd0, 0xbad63fad, 0xbad63fad, 0xbad63fad, 0xbad63fad, 0xbad63fad, 0xbf7fffd9, + 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0x3af6398b, 0x3af6398b, 0x3af6398b, 0x3af6398b, + 0x3af6398b, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0xbb0b19b4, 0xbb0b19b4, + 0xbb0b19b4, 0xbb0b19b4, 0xbb0b19b4, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, + 0x3b1b16a1, 0x3b1b16a1, 0x3b1b16a1, 0x3b1b16a1, 0x3b1b16a1, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0xbb2b138f, 0xbb2b138f, 0xbb2b138f, 0xbb2b138f, 0xbb2b138f, 0xbf7ffff4, + 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b3b107b, 0x3b3b107b, 0x3b3b107b, 0x3b3b107b, + 0x3b3b107b, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0xbb4b0d67, 0xbb4b0d67, + 0xbb4b0d67, 0xbb4b0d67, 0xbb4b0d67, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0x3b5b0a52, 0x3b5b0a52, 0x3b5b0a52, 0x3b5b0a52, 0x3b5b0a52, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0xbb6b073c, 0xbb6b073c, 0xbb6b073c, 0xbb6b073c, 0xbb6b073c, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b7b0426, 0x3b7b0426, 0x3b7b0426, 0x3b7b0426, + 0x3b7b0426, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3b74fe9c, 0x3b74fe9c, + 0x3b74fe9c, 0x3b74fe9c, 0x3b74fe9c, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0xbb6501b3, 0xbb6501b3, 0xbb6501b3, 0xbb6501b3, 0xbb6501b3, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3b5504c8, 0x3b5504c8, 0x3b5504c8, 0x3b5504c8, 0x3b5504c8, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb4507dd, 0xbb4507dd, 0xbb4507dd, 0xbb4507dd, + 0xbb4507dd, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3b350af1, 0x3b350af1, + 0x3b350af1, 0x3b350af1, 0x3b350af1, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, + 0xbb250e04, 0xbb250e04, 0xbb250e04, 0xbb250e04, 0xbb250e04, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3b151116, 0x3b151116, 0x3b151116, 0x3b151116, 0x3b151116, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbb051428, 0xbb051428, 0xbb051428, 0xbb051428, + 0xbb051428, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3aea2e73, 0x3aea2e73, +] )) ), + +################ chunk 13824 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47a0dd91, 0x47a0dd91, 0x47a0dd91, 0x47a1492b, 0x47a1492b, 0x47a1492b, 0x47a1492b, 0x47a1492b, + 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a2205e, 0x47a2205e, 0x47a2205e, + 0x47a2205e, 0x47a2205e, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a2f791, + 0x47a2f791, 0x47a2f791, 0x47a2f791, 0x47a2f791, 0x47a3632a, 0x47a3632a, 0x47a3632a, 0x47a3632a, + 0x47a3632a, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a43a5d, 0x47a43a5d, + 0x47a43a5d, 0x47a43a5d, 0x47a43a5d, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, + 0x47a51190, 0x47a51190, 0x47a51190, 0x47a51190, 0x47a51190, 0x47a57d2a, 0x47a57d2a, 0x47a57d2a, + 0x47a57d2a, 0x47a57d2a, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a6545d, + 0x47a6545d, 0x47a6545d, 0x47a6545d, 0x47a6545d, 0x47a6bff6, 0x47a6bff6, 0x47a6bff6, 0x47a6bff6, + 0x47a6bff6, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a79729, 0x47a79729, + 0x47a79729, 0x47a79729, 0x47a79729, 0x47a802c2, 0x47a802c2, 0x47a802c2, 0x47a802c2, 0x47a802c2, + 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a8d9f5, 0x47a8d9f5, 0x47a8d9f5, + 0x47a8d9f5, 0x47a8d9f5, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9b128, + 0x47a9b128, 0x47a9b128, 0x47a9b128, 0x47a9b128, 0x47aa1cc2, 0x47aa1cc2, 0x47aa1cc2, 0x47aa1cc2, + 0x47aa1cc2, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aaf3f5, 0x47aaf3f5, + 0x47aaf3f5, 0x47aaf3f5, 0x47aaf3f5, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, + 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47ac36c1, 0x47ac36c1, 0x47ac36c1, + 0x47ac36c1, 0x47ac36c1, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47ad0df4, + 0x47ad0df4, 0x47ad0df4, 0x47ad0df4, 0x47ad0df4, 0x47ad798e, 0x47ad798e, 0x47ad798e, 0x47ad798e, + 0x47ad798e, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ae50c1, 0x47ae50c1, + 0x47ae50c1, 0x47ae50c1, 0x47ae50c1, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, + 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af938d, 0x47af938d, 0x47af938d, + 0x47af938d, 0x47af938d, 0x47afff27, 0x47afff27, 0x47afff27, 0x47afff27, 0x47afff27, 0x47b06ac0, + 0x47b06ac0, 0x47b06ac0, 0x47b06ac0, 0x47b06ac0, 0x47b0d65a, 0x47b0d65a, 0x47b0d65a, 0x47b0d65a, + 0x47b0d65a, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b1ad8d, 0x47b1ad8d, + 0x47b1ad8d, 0x47b1ad8d, 0x47b1ad8d, 0x47b21926, 0x47b21926, 0x47b21926, 0x47b21926, 0x47b21926, + 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b2f059, 0x47b2f059, 0x47b2f059, + 0x47b2f059, 0x47b2f059, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b3c78c, + 0x47b3c78c, 0x47b3c78c, 0x47b3c78c, 0x47b3c78c, 0x47b43326, 0x47b43326, 0x47b43326, 0x47b43326, + 0x47b43326, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b50a58, 0x47b50a58, + 0x47b50a58, 0x47b50a58, 0x47b50a58, 0x47b575f2, 0x47b575f2, 0x47b575f2, 0x47b575f2, 0x47b575f2, + 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b64d25, 0x47b64d25, 0x47b64d25, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3aea2e73, 0x3aea2e73, 0x3aea2e73, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, + 0xbaca3495, 0xbaca3495, 0xbaca3495, 0xbaca3495, 0xbaca3495, 0x3f7fffcc, 0x3f7fffcc, 0x3f7fffcc, + 0x3f7fffcc, 0x3f7fffcc, 0x3aaa3ab6, 0x3aaa3ab6, 0x3aaa3ab6, 0x3aaa3ab6, 0x3aaa3ab6, 0xbf7fffc2, + 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xba8a40d7, 0xba8a40d7, 0xba8a40d7, 0xba8a40d7, + 0xba8a40d7, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3a548dee, 0x3a548dee, + 0x3a548dee, 0x3a548dee, 0x3a548dee, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, + 0xba149a2d, 0xba149a2d, 0xba149a2d, 0xba149a2d, 0xba149a2d, 0x3f7fff9b, 0x3f7fff9b, 0x3f7fff9b, + 0x3f7fff9b, 0x3f7fff9b, 0x39a94cd7, 0x39a94cd7, 0x39a94cd7, 0x39a94cd7, 0x39a94cd7, 0xbf7fff8d, + 0xbf7fff8d, 0xbf7fff8d, 0xbf7fff8d, 0xbf7fff8d, 0xb8a5954c, 0xb8a5954c, 0xb8a5954c, 0xb8a5954c, + 0xb8a5954c, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0xb92d0461, 0xb92d0461, + 0xb92d0461, 0xb92d0461, 0xb92d0461, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, + 0x39d669b4, 0x39d669b4, 0x39d669b4, 0x39d669b4, 0x39d669b4, 0x3f7fffa0, 0x3f7fffa0, 0x3f7fffa0, + 0x3f7fffa0, 0x3f7fffa0, 0xba2b289b, 0xba2b289b, 0xba2b289b, 0xba2b289b, 0xba2b289b, 0xbf7fffae, + 0xbf7fffae, 0xbf7fffae, 0xbf7fffae, 0xbf7fffae, 0x3a6b1c5c, 0x3a6b1c5c, 0x3a6b1c5c, 0x3a6b1c5c, + 0x3a6b1c5c, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0xba95880e, 0xba95880e, + 0xba95880e, 0xba95880e, 0xba95880e, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, + 0x3ab581ed, 0x3ab581ed, 0x3ab581ed, 0x3ab581ed, 0x3ab581ed, 0x3f7fffd0, 0x3f7fffd0, 0x3f7fffd0, + 0x3f7fffd0, 0x3f7fffd0, 0xbad57bcc, 0xbad57bcc, 0xbad57bcc, 0xbad57bcc, 0xbad57bcc, 0xbf7fffd9, + 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0x3af575aa, 0x3af575aa, 0x3af575aa, 0x3af575aa, + 0x3af575aa, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0xbb0ab7c3, 0xbb0ab7c3, + 0xbb0ab7c3, 0xbb0ab7c3, 0xbb0ab7c3, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, + 0x3b1ab4b1, 0x3b1ab4b1, 0x3b1ab4b1, 0x3b1ab4b1, 0x3b1ab4b1, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0xbb2ab19e, 0xbb2ab19e, 0xbb2ab19e, 0xbb2ab19e, 0xbb2ab19e, 0xbf7ffff4, + 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b3aae8b, 0x3b3aae8b, 0x3b3aae8b, 0x3b3aae8b, + 0x3b3aae8b, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0xbb4aab77, 0xbb4aab77, + 0xbb4aab77, 0xbb4aab77, 0xbb4aab77, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0x3b5aa862, 0x3b5aa862, 0x3b5aa862, 0x3b5aa862, 0x3b5aa862, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0xbb6aa54c, 0xbb6aa54c, 0xbb6aa54c, 0xbb6aa54c, 0xbb6aa54c, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b7aa235, 0x3b7aa235, 0x3b7aa235, 0x3b7aa235, + 0x3b7aa235, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3b75608d, 0x3b75608d, + 0x3b75608d, 0x3b75608d, 0x3b75608d, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0xbb6563a3, 0xbb6563a3, 0xbb6563a3, 0xbb6563a3, 0xbb6563a3, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, +] )) ), + +################ chunk 14336 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47b64d25, 0x47b64d25, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b72458, + 0x47b72458, 0x47b72458, 0x47b72458, 0x47b72458, 0x47b78ff1, 0x47b78ff1, 0x47b78ff1, 0x47b78ff1, + 0x47b78ff1, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b86724, 0x47b86724, + 0x47b86724, 0x47b86724, 0x47b86724, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, + 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b9a9f1, 0x47b9a9f1, 0x47b9a9f1, + 0x47b9a9f1, 0x47b9a9f1, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba8124, + 0x47ba8124, 0x47ba8124, 0x47ba8124, 0x47ba8124, 0x47baecbd, 0x47baecbd, 0x47baecbd, 0x47baecbd, + 0x47baecbd, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bbc3f0, 0x47bbc3f0, + 0x47bbc3f0, 0x47bbc3f0, 0x47bbc3f0, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, + 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bd06bd, 0x47bd06bd, 0x47bd06bd, + 0x47bd06bd, 0x47bd06bd, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bdddf0, + 0x47bdddf0, 0x47bdddf0, 0x47bdddf0, 0x47bdddf0, 0x47be4989, 0x47be4989, 0x47be4989, 0x47be4989, + 0x47be4989, 0x47beb523, 0x47beb523, 0x47beb523, 0x47beb523, 0x47beb523, 0x47bf20bc, 0x47bf20bc, + 0x47bf20bc, 0x47bf20bc, 0x47bf20bc, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, + 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47c06389, 0x47c06389, 0x47c06389, + 0x47c06389, 0x47c06389, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c13abc, + 0x47c13abc, 0x47c13abc, 0x47c13abc, 0x47c13abc, 0x47c1a655, 0x47c1a655, 0x47c1a655, 0x47c1a655, + 0x47c1a655, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c27d88, 0x47c27d88, + 0x47c27d88, 0x47c27d88, 0x47c27d88, 0x47c2e921, 0x47c2e921, 0x47c2e921, 0x47c2e921, 0x47c2e921, + 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c3c054, 0x47c3c054, 0x47c3c054, + 0x47c3c054, 0x47c3c054, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c49787, + 0x47c49787, 0x47c49787, 0x47c49787, 0x47c49787, 0x47c50321, 0x47c50321, 0x47c50321, 0x47c50321, + 0x47c50321, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c5da54, 0x47c5da54, + 0x47c5da54, 0x47c5da54, 0x47c5da54, 0x47c645ed, 0x47c645ed, 0x47c645ed, 0x47c645ed, 0x47c645ed, + 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c71d20, 0x47c71d20, 0x47c71d20, + 0x47c71d20, 0x47c71d20, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c7f453, + 0x47c7f453, 0x47c7f453, 0x47c7f453, 0x47c7f453, 0x47c85fed, 0x47c85fed, 0x47c85fed, 0x47c85fed, + 0x47c85fed, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c93720, 0x47c93720, + 0x47c93720, 0x47c93720, 0x47c93720, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, + 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca79ec, 0x47ca79ec, 0x47ca79ec, + 0x47ca79ec, 0x47ca79ec, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cb511f, + 0x47cb511f, 0x47cb511f, 0x47cb511f, 0x47cb511f, 0x47cbbcb9, 0x47cbbcb9, 0x47cbbcb9, 0x47cbbcb9, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffffe, 0x3f7ffffe, 0x3b5566b8, 0x3b5566b8, 0x3b5566b8, 0x3b5566b8, 0x3b5566b8, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb4569cd, 0xbb4569cd, 0xbb4569cd, 0xbb4569cd, + 0xbb4569cd, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3b356ce1, 0x3b356ce1, + 0x3b356ce1, 0x3b356ce1, 0x3b356ce1, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, + 0xbb256ff4, 0xbb256ff4, 0xbb256ff4, 0xbb256ff4, 0xbb256ff4, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3b157307, 0x3b157307, 0x3b157307, 0x3b157307, 0x3b157307, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbb057619, 0xbb057619, 0xbb057619, 0xbb057619, + 0xbb057619, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3aeaf254, 0x3aeaf254, + 0x3aeaf254, 0x3aeaf254, 0x3aeaf254, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, + 0xbacaf876, 0xbacaf876, 0xbacaf876, 0xbacaf876, 0xbacaf876, 0x3f7fffcc, 0x3f7fffcc, 0x3f7fffcc, + 0x3f7fffcc, 0x3f7fffcc, 0x3aaafe97, 0x3aaafe97, 0x3aaafe97, 0x3aaafe97, 0x3aaafe97, 0xbf7fffc2, + 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xba8b04b8, 0xba8b04b8, 0xba8b04b8, 0xba8b04b8, + 0xba8b04b8, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3a5615b0, 0x3a5615b0, + 0x3a5615b0, 0x3a5615b0, 0x3a5615b0, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, + 0xba1621ef, 0xba1621ef, 0xba1621ef, 0xba1621ef, 0xba1621ef, 0x3f7fff9c, 0x3f7fff9c, 0x3f7fff9c, + 0x3f7fff9c, 0x3f7fff9c, 0x39ac5c5b, 0x39ac5c5b, 0x39ac5c5b, 0x39ac5c5b, 0x39ac5c5b, 0xbf7fff8d, + 0xbf7fff8d, 0xbf7fff8d, 0xbf7fff8d, 0xbf7fff8d, 0xb8b1d35d, 0xb8b1d35d, 0xb8b1d35d, 0xb8b1d35d, + 0xb8b1d35d, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0xb926e559, 0xb926e559, + 0xb926e559, 0xb926e559, 0xb926e559, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, + 0x39d35a30, 0x39d35a30, 0x39d35a30, 0x39d35a30, 0x39d35a30, 0x3f7fffa0, 0x3f7fffa0, 0x3f7fffa0, + 0x3f7fffa0, 0x3f7fffa0, 0xba29a0d9, 0xba29a0d9, 0xba29a0d9, 0xba29a0d9, 0xba29a0d9, 0xbf7fffad, + 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0x3a69949a, 0x3a69949a, 0x3a69949a, 0x3a69949a, + 0x3a69949a, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0xba94c42d, 0xba94c42d, + 0xba94c42d, 0xba94c42d, 0xba94c42d, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, + 0x3ab4be0c, 0x3ab4be0c, 0x3ab4be0c, 0x3ab4be0c, 0x3ab4be0c, 0x3f7fffcf, 0x3f7fffcf, 0x3f7fffcf, + 0x3f7fffcf, 0x3f7fffcf, 0xbad4b7eb, 0xbad4b7eb, 0xbad4b7eb, 0xbad4b7eb, 0xbad4b7eb, 0xbf7fffd9, + 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0x3af4b1c9, 0x3af4b1c9, 0x3af4b1c9, 0x3af4b1c9, + 0x3af4b1c9, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0xbb0a55d3, 0xbb0a55d3, + 0xbb0a55d3, 0xbb0a55d3, 0xbb0a55d3, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, + 0x3b1a52c1, 0x3b1a52c1, 0x3b1a52c1, 0x3b1a52c1, 0x3b1a52c1, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0xbb2a4fae, 0xbb2a4fae, 0xbb2a4fae, 0xbb2a4fae, 0xbb2a4fae, 0xbf7ffff4, + 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b3a4c9a, 0x3b3a4c9a, 0x3b3a4c9a, 0x3b3a4c9a, +] )) ), + +################ chunk 14848 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47cbbcb9, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc93ec, 0x47cc93ec, + 0x47cc93ec, 0x47cc93ec, 0x47cc93ec, 0x47ccff85, 0x47ccff85, 0x47ccff85, 0x47ccff85, 0x47ccff85, + 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cdd6b8, 0x47cdd6b8, 0x47cdd6b8, + 0x47cdd6b8, 0x47cdd6b8, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ceadeb, + 0x47ceadeb, 0x47ceadeb, 0x47ceadeb, 0x47ceadeb, 0x47cf1985, 0x47cf1985, 0x47cf1985, 0x47cf1985, + 0x47cf1985, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cff0b7, 0x47cff0b7, + 0x47cff0b7, 0x47cff0b7, 0x47cff0b7, 0x47d05c51, 0x47d05c51, 0x47d05c51, 0x47d05c51, 0x47d05c51, + 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d13384, 0x47d13384, 0x47d13384, + 0x47d13384, 0x47d13384, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d20ab7, + 0x47d20ab7, 0x47d20ab7, 0x47d20ab7, 0x47d20ab7, 0x47d27650, 0x47d27650, 0x47d27650, 0x47d27650, + 0x47d27650, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d34d83, 0x47d34d83, + 0x47d34d83, 0x47d34d83, 0x47d34d83, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, + 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d49050, 0x47d49050, 0x47d49050, + 0x47d49050, 0x47d49050, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d56783, + 0x47d56783, 0x47d56783, 0x47d56783, 0x47d56783, 0x47d5d31c, 0x47d5d31c, 0x47d5d31c, 0x47d5d31c, + 0x47d5d31c, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d6aa4f, 0x47d6aa4f, + 0x47d6aa4f, 0x47d6aa4f, 0x47d6aa4f, 0x47d715e9, 0x47d715e9, 0x47d715e9, 0x47d715e9, 0x47d715e9, + 0x47d78182, 0x47d78182, 0x47d78182, 0x47d78182, 0x47d78182, 0x47d7ed1c, 0x47d7ed1c, 0x47d7ed1c, + 0x47d7ed1c, 0x47d7ed1c, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d8c44f, + 0x47d8c44f, 0x47d8c44f, 0x47d8c44f, 0x47d8c44f, 0x47d92fe8, 0x47d92fe8, 0x47d92fe8, 0x47d92fe8, + 0x47d92fe8, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47da071b, 0x47da071b, + 0x47da071b, 0x47da071b, 0x47da071b, 0x47da72b5, 0x47da72b5, 0x47da72b5, 0x47da72b5, 0x47da72b5, + 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47db49e8, 0x47db49e8, 0x47db49e8, + 0x47db49e8, 0x47db49e8, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dc211b, + 0x47dc211b, 0x47dc211b, 0x47dc211b, 0x47dc211b, 0x47dc8cb4, 0x47dc8cb4, 0x47dc8cb4, 0x47dc8cb4, + 0x47dc8cb4, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dd63e7, 0x47dd63e7, + 0x47dd63e7, 0x47dd63e7, 0x47dd63e7, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, + 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47dea6b3, 0x47dea6b3, 0x47dea6b3, + 0x47dea6b3, 0x47dea6b3, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df7de6, + 0x47df7de6, 0x47df7de6, 0x47df7de6, 0x47df7de6, 0x47dfe980, 0x47dfe980, 0x47dfe980, 0x47dfe980, + 0x47dfe980, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e0c0b3, 0x47e0c0b3, + 0x47e0c0b3, 0x47e0c0b3, 0x47e0c0b3, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3b3a4c9a, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0xbb4a4986, 0xbb4a4986, + 0xbb4a4986, 0xbb4a4986, 0xbb4a4986, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0x3b5a4671, 0x3b5a4671, 0x3b5a4671, 0x3b5a4671, 0x3b5a4671, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0xbb6a435c, 0xbb6a435c, 0xbb6a435c, 0xbb6a435c, 0xbb6a435c, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b7a4045, 0x3b7a4045, 0x3b7a4045, 0x3b7a4045, + 0x3b7a4045, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3b75c27d, 0x3b75c27d, + 0x3b75c27d, 0x3b75c27d, 0x3b75c27d, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0xbb65c593, 0xbb65c593, 0xbb65c593, 0xbb65c593, 0xbb65c593, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3b55c8a9, 0x3b55c8a9, 0x3b55c8a9, 0x3b55c8a9, 0x3b55c8a9, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb45cbbe, 0xbb45cbbe, 0xbb45cbbe, 0xbb45cbbe, + 0xbb45cbbe, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3b35ced1, 0x3b35ced1, + 0x3b35ced1, 0x3b35ced1, 0x3b35ced1, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, + 0xbb25d1e5, 0xbb25d1e5, 0xbb25d1e5, 0xbb25d1e5, 0xbb25d1e5, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3b15d4f7, 0x3b15d4f7, 0x3b15d4f7, 0x3b15d4f7, 0x3b15d4f7, 0xbf7fffe7, + 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbb05d809, 0xbb05d809, 0xbb05d809, 0xbb05d809, + 0xbb05d809, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3aebb635, 0x3aebb635, + 0x3aebb635, 0x3aebb635, 0x3aebb635, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, + 0xbacbbc57, 0xbacbbc57, 0xbacbbc57, 0xbacbbc57, 0xbacbbc57, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3aabc279, 0x3aabc279, 0x3aabc279, 0x3aabc279, 0x3aabc279, 0xbf7fffc2, + 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xba8bc899, 0xba8bc899, 0xba8bc899, 0xba8bc899, + 0xba8bc899, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3a579d72, 0x3a579d72, + 0x3a579d72, 0x3a579d72, 0x3a579d72, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, + 0xba17a9b1, 0xba17a9b1, 0xba17a9b1, 0xba17a9b1, 0xba17a9b1, 0x3f7fff9c, 0x3f7fff9c, 0x3f7fff9c, + 0x3f7fff9c, 0x3f7fff9c, 0x39af6bdf, 0x39af6bdf, 0x39af6bdf, 0x39af6bdf, 0x39af6bdf, 0xbf7fff8e, + 0xbf7fff8e, 0xbf7fff8e, 0xbf7fff8e, 0xbf7fff8e, 0xb8be116e, 0xb8be116e, 0xb8be116e, 0xb8be116e, + 0xb8be116e, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0xb920c651, 0xb920c651, + 0xb920c651, 0xb920c651, 0xb920c651, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, + 0x39d04aac, 0x39d04aac, 0x39d04aac, 0x39d04aac, 0x39d04aac, 0x3f7fffa0, 0x3f7fffa0, 0x3f7fffa0, + 0x3f7fffa0, 0x3f7fffa0, 0xba281917, 0xba281917, 0xba281917, 0xba281917, 0xba281917, 0xbf7fffad, + 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0x3a680cd8, 0x3a680cd8, 0x3a680cd8, 0x3a680cd8, + 0x3a680cd8, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0xba94004c, 0xba94004c, + 0xba94004c, 0xba94004c, 0xba94004c, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, +] )) ), + +################ chunk 15360 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e2037f, 0x47e2037f, 0x47e2037f, + 0x47e2037f, 0x47e2037f, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e2dab2, + 0x47e2dab2, 0x47e2dab2, 0x47e2dab2, 0x47e2dab2, 0x47e3464c, 0x47e3464c, 0x47e3464c, 0x47e3464c, + 0x47e3464c, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e41d7f, 0x47e41d7f, + 0x47e41d7f, 0x47e41d7f, 0x47e41d7f, 0x47e48918, 0x47e48918, 0x47e48918, 0x47e48918, 0x47e48918, + 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e5604b, 0x47e5604b, 0x47e5604b, + 0x47e5604b, 0x47e5604b, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e6377e, + 0x47e6377e, 0x47e6377e, 0x47e6377e, 0x47e6377e, 0x47e6a318, 0x47e6a318, 0x47e6a318, 0x47e6a318, + 0x47e6a318, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e77a4b, 0x47e77a4b, + 0x47e77a4b, 0x47e77a4b, 0x47e77a4b, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, + 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8bd17, 0x47e8bd17, 0x47e8bd17, + 0x47e8bd17, 0x47e8bd17, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e9944a, + 0x47e9944a, 0x47e9944a, 0x47e9944a, 0x47e9944a, 0x47e9ffe4, 0x47e9ffe4, 0x47e9ffe4, 0x47e9ffe4, + 0x47e9ffe4, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ead716, 0x47ead716, + 0x47ead716, 0x47ead716, 0x47ead716, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, + 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ec19e3, 0x47ec19e3, 0x47ec19e3, + 0x47ec19e3, 0x47ec19e3, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ecf116, + 0x47ecf116, 0x47ecf116, 0x47ecf116, 0x47ecf116, 0x47ed5caf, 0x47ed5caf, 0x47ed5caf, 0x47ed5caf, + 0x47ed5caf, 0x47edc849, 0x47edc849, 0x47edc849, 0x47edc849, 0x47edc849, 0x47ee33e2, 0x47ee33e2, + 0x47ee33e2, 0x47ee33e2, 0x47ee33e2, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, + 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef76af, 0x47ef76af, 0x47ef76af, + 0x47ef76af, 0x47ef76af, 0x47efe248, 0x47efe248, 0x47efe248, 0x47efe248, 0x47efe248, 0x47f04de2, + 0x47f04de2, 0x47f04de2, 0x47f04de2, 0x47f04de2, 0x47f0b97b, 0x47f0b97b, 0x47f0b97b, 0x47f0b97b, + 0x47f0b97b, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f190ae, 0x47f190ae, + 0x47f190ae, 0x47f190ae, 0x47f190ae, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, + 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f2d37b, 0x47f2d37b, 0x47f2d37b, + 0x47f2d37b, 0x47f2d37b, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f3aaae, + 0x47f3aaae, 0x47f3aaae, 0x47f3aaae, 0x47f3aaae, 0x47f41647, 0x47f41647, 0x47f41647, 0x47f41647, + 0x47f41647, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f4ed7a, 0x47f4ed7a, + 0x47f4ed7a, 0x47f4ed7a, 0x47f4ed7a, 0x47f55914, 0x47f55914, 0x47f55914, 0x47f55914, 0x47f55914, + 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f63047, 0x47f63047, 0x47f63047, + 0x47f63047, 0x47f63047, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f7077a, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3ab3fa2b, 0x3ab3fa2b, 0x3ab3fa2b, 0x3ab3fa2b, 0x3ab3fa2b, 0x3f7fffcf, 0x3f7fffcf, 0x3f7fffcf, + 0x3f7fffcf, 0x3f7fffcf, 0xbad3f40a, 0xbad3f40a, 0xbad3f40a, 0xbad3f40a, 0xbad3f40a, 0xbf7fffd9, + 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0x3af3ede8, 0x3af3ede8, 0x3af3ede8, 0x3af3ede8, + 0x3af3ede8, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0xbb09f3e2, 0xbb09f3e2, + 0xbb09f3e2, 0xbb09f3e2, 0xbb09f3e2, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, + 0x3b19f0d0, 0x3b19f0d0, 0x3b19f0d0, 0x3b19f0d0, 0x3b19f0d0, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0xbb29edbd, 0xbb29edbd, 0xbb29edbd, 0xbb29edbd, 0xbb29edbd, 0xbf7ffff4, + 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b39eaaa, 0x3b39eaaa, 0x3b39eaaa, 0x3b39eaaa, + 0x3b39eaaa, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0xbb49e796, 0xbb49e796, + 0xbb49e796, 0xbb49e796, 0xbb49e796, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0x3b59e481, 0x3b59e481, 0x3b59e481, 0x3b59e481, 0x3b59e481, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0xbb69e16b, 0xbb69e16b, 0xbb69e16b, 0xbb69e16b, 0xbb69e16b, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b79de55, 0x3b79de55, 0x3b79de55, 0x3b79de55, + 0x3b79de55, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3b76246d, 0x3b76246d, + 0x3b76246d, 0x3b76246d, 0x3b76246d, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0xbb662784, 0xbb662784, 0xbb662784, 0xbb662784, 0xbb662784, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3b562a99, 0x3b562a99, 0x3b562a99, 0x3b562a99, 0x3b562a99, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb462dae, 0xbb462dae, 0xbb462dae, 0xbb462dae, + 0xbb462dae, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3b3630c2, 0x3b3630c2, + 0x3b3630c2, 0x3b3630c2, 0x3b3630c2, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, + 0xbb2633d5, 0xbb2633d5, 0xbb2633d5, 0xbb2633d5, 0xbb2633d5, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3b1636e8, 0x3b1636e8, 0x3b1636e8, 0x3b1636e8, 0x3b1636e8, 0xbf7fffe7, + 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbb0639fa, 0xbb0639fa, 0xbb0639fa, 0xbb0639fa, + 0xbb0639fa, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3aec7a16, 0x3aec7a16, + 0x3aec7a16, 0x3aec7a16, 0x3aec7a16, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, + 0xbacc8038, 0xbacc8038, 0xbacc8038, 0xbacc8038, 0xbacc8038, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3aac865a, 0x3aac865a, 0x3aac865a, 0x3aac865a, 0x3aac865a, 0xbf7fffc2, + 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xba8c8c7a, 0xba8c8c7a, 0xba8c8c7a, 0xba8c8c7a, + 0xba8c8c7a, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3a592534, 0x3a592534, + 0x3a592534, 0x3a592534, 0x3a592534, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, + 0xba193173, 0xba193173, 0xba193173, 0xba193173, 0xba193173, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, + 0x3f7fff9d, 0x3f7fff9d, 0x39b27b63, 0x39b27b63, 0x39b27b63, 0x39b27b63, 0x39b27b63, 0xbf7fff8e, +] )) ), + +################ chunk 15872 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47f7077a, 0x47f7077a, 0x47f7077a, 0x47f7077a, 0x47f77313, 0x47f77313, 0x47f77313, 0x47f77313, + 0x47f77313, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f84a46, 0x47f84a46, + 0x47f84a46, 0x47f84a46, 0x47f84a46, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, + 0x47f92179, 0x47f92179, 0x47f92179, 0x47f92179, 0x47f92179, 0x47f98d12, 0x47f98d12, 0x47f98d12, + 0x47f98d12, 0x47f98d12, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47fa6445, + 0x47fa6445, 0x47fa6445, 0x47fa6445, 0x47fa6445, 0x47facfdf, 0x47facfdf, 0x47facfdf, 0x47facfdf, + 0x47facfdf, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fba712, 0x47fba712, + 0x47fba712, 0x47fba712, 0x47fba712, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, + 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fce9de, 0x47fce9de, 0x47fce9de, + 0x47fce9de, 0x47fce9de, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fdc111, + 0x47fdc111, 0x47fdc111, 0x47fdc111, 0x47fdc111, 0x47fe2cab, 0x47fe2cab, 0x47fe2cab, 0x47fe2cab, + 0x47fe2cab, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47ff03de, 0x47ff03de, + 0x47ff03de, 0x47ff03de, 0x47ff03de, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, + 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x48002355, 0x48002355, 0x48002355, + 0x48002355, 0x48002355, 0x48005922, 0x48005922, 0x48005922, 0x48005922, 0x48005922, 0x48008eef, + 0x48008eef, 0x48008eef, 0x48008eef, 0x48008eef, 0x4800c4bb, 0x4800c4bb, 0x4800c4bb, 0x4800c4bb, + 0x4800c4bb, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x48013055, 0x48013055, + 0x48013055, 0x48013055, 0x48013055, 0x48016622, 0x48016622, 0x48016622, 0x48016622, 0x48016622, + 0x48019bee, 0x48019bee, 0x48019bee, 0x48019bee, 0x48019bee, 0x4801d1bb, 0x4801d1bb, 0x4801d1bb, + 0x4801d1bb, 0x4801d1bb, 0x48020788, 0x48020788, 0x48020788, 0x48020788, 0x48020788, 0x48023d55, + 0x48023d55, 0x48023d55, 0x48023d55, 0x48023d55, 0x48027321, 0x48027321, 0x48027321, 0x48027321, + 0x48027321, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802debb, 0x4802debb, + 0x4802debb, 0x4802debb, 0x4802debb, 0x48031487, 0x48031487, 0x48031487, 0x48031487, 0x48031487, + 0x48034a54, 0x48034a54, 0x48034a54, 0x48034a54, 0x48034a54, 0x48038021, 0x48038021, 0x48038021, + 0x48038021, 0x48038021, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803ebba, + 0x4803ebba, 0x4803ebba, 0x4803ebba, 0x4803ebba, 0x48042187, 0x48042187, 0x48042187, 0x48042187, + 0x48042187, 0x48045754, 0x48045754, 0x48045754, 0x48045754, 0x48045754, 0x48048d21, 0x48048d21, + 0x48048d21, 0x48048d21, 0x48048d21, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, + 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x48052e87, 0x48052e87, 0x48052e87, + 0x48052e87, 0x48052e87, 0x48056454, 0x48056454, 0x48056454, 0x48056454, 0x48056454, 0x48059a20, + 0x48059a20, 0x48059a20, 0x48059a20, 0x48059a20, 0x4805cfed, 0x4805cfed, 0x4805cfed, 0x4805cfed, + 0x4805cfed, 0x480605ba, 0x480605ba, 0x480605ba, 0x480605ba, 0x480605ba, 0x48063b87, 0x48063b87, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbf7fff8e, 0xbf7fff8e, 0xbf7fff8e, 0xbf7fff8e, 0xb8ca4f7f, 0xb8ca4f7f, 0xb8ca4f7f, 0xb8ca4f7f, + 0xb8ca4f7f, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0xb91aa748, 0xb91aa748, + 0xb91aa748, 0xb91aa748, 0xb91aa748, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, + 0x39cd3b28, 0x39cd3b28, 0x39cd3b28, 0x39cd3b28, 0x39cd3b28, 0x3f7fff9f, 0x3f7fff9f, 0x3f7fff9f, + 0x3f7fff9f, 0x3f7fff9f, 0xba269155, 0xba269155, 0xba269155, 0xba269155, 0xba269155, 0xbf7fffad, + 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0x3a668516, 0x3a668516, 0x3a668516, 0x3a668516, + 0x3a668516, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0xba933c6b, 0xba933c6b, + 0xba933c6b, 0xba933c6b, 0xba933c6b, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, + 0x3ab3364a, 0x3ab3364a, 0x3ab3364a, 0x3ab3364a, 0x3ab3364a, 0x3f7fffcf, 0x3f7fffcf, 0x3f7fffcf, + 0x3f7fffcf, 0x3f7fffcf, 0xbad33029, 0xbad33029, 0xbad33029, 0xbad33029, 0xbad33029, 0xbf7fffd8, + 0xbf7fffd8, 0xbf7fffd8, 0xbf7fffd8, 0xbf7fffd8, 0x3af32a07, 0x3af32a07, 0x3af32a07, 0x3af32a07, + 0x3af32a07, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0xbb0991f2, 0xbb0991f2, + 0xbb0991f2, 0xbb0991f2, 0xbb0991f2, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, + 0x3b198ee0, 0x3b198ee0, 0x3b198ee0, 0x3b198ee0, 0x3b198ee0, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0xbb298bcd, 0xbb298bcd, 0xbb298bcd, 0xbb298bcd, 0xbb298bcd, 0xbf7ffe91, + 0xbf7ffe91, 0xbf7ffe91, 0xbf7ffe91, 0xbf7ffe91, 0xbba33b6f, 0xbba33b6f, 0xbba33b6f, 0xbba33b6f, + 0xbba33b6f, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0xbb4985a5, 0xbb4985a5, + 0xbb4985a5, 0xbb4985a5, 0xbb4985a5, 0xbf7ffe59, 0xbf7ffe59, 0xbf7ffe59, 0xbf7ffe59, 0xbf7ffe59, + 0xbb933e8a, 0xbb933e8a, 0xbb933e8a, 0xbb933e8a, 0xbb933e8a, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0xbb697f7b, 0xbb697f7b, 0xbb697f7b, 0xbb697f7b, 0xbb697f7b, 0xbf7ffe1d, + 0xbf7ffe1d, 0xbf7ffe1d, 0xbf7ffe1d, 0xbf7ffe1d, 0xbb8341a3, 0xbb8341a3, 0xbb8341a3, 0xbb8341a3, + 0xbb8341a3, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xbb84bca6, 0xbb84bca6, + 0xbb84bca6, 0xbb84bca6, 0xbb84bca6, 0xbf7ffe22, 0xbf7ffe22, 0xbf7ffe22, 0xbf7ffe22, 0xbf7ffe22, + 0xbb668974, 0xbb668974, 0xbb668974, 0xbb668974, 0xbb668974, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0xbb94b98d, 0xbb94b98d, 0xbb94b98d, 0xbb94b98d, 0xbb94b98d, 0xbf7ffe5e, + 0xbf7ffe5e, 0xbf7ffe5e, 0xbf7ffe5e, 0xbf7ffe5e, 0xbb468f9e, 0xbb468f9e, 0xbb468f9e, 0xbb468f9e, + 0xbb468f9e, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0xbba4b672, 0xbba4b672, + 0xbba4b672, 0xbba4b672, 0xbba4b672, 0xbf7ffe96, 0xbf7ffe96, 0xbf7ffe96, 0xbf7ffe96, 0xbf7ffe96, + 0xbb2695c6, 0xbb2695c6, 0xbb2695c6, 0xbb2695c6, 0xbb2695c6, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0xbbb4b354, 0xbbb4b354, 0xbbb4b354, 0xbbb4b354, 0xbbb4b354, 0xbf7ffeca, + 0xbf7ffeca, 0xbf7ffeca, 0xbf7ffeca, 0xbf7ffeca, 0xbb069bea, 0xbb069bea, 0xbb069bea, 0xbb069bea, + 0xbb069bea, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0xbbc4b033, 0xbbc4b033, +] )) ), + +################ chunk 16384 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x48063b87, 0x48063b87, 0x48063b87, 0x48067153, 0x48067153, 0x48067153, 0x48067153, 0x48067153, + 0x4806a720, 0x4806a720, 0x4806a720, 0x4806a720, 0x4806a720, 0x4806dced, 0x4806dced, 0x4806dced, + 0x4806dced, 0x4806dced, 0x480712ba, 0x480712ba, 0x480712ba, 0x480712ba, 0x480712ba, 0x48074886, + 0x48074886, 0x48074886, 0x48074886, 0x48074886, 0x48077e53, 0x48077e53, 0x48077e53, 0x48077e53, + 0x48077e53, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807e9ed, 0x4807e9ed, + 0x4807e9ed, 0x4807e9ed, 0x4807e9ed, 0x48081fb9, 0x48081fb9, 0x48081fb9, 0x48081fb9, 0x48081fb9, + 0x48085586, 0x48085586, 0x48085586, 0x48085586, 0x48085586, 0x48088b53, 0x48088b53, 0x48088b53, + 0x48088b53, 0x48088b53, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808f6ec, + 0x4808f6ec, 0x4808f6ec, 0x4808f6ec, 0x4808f6ec, 0x48092cb9, 0x48092cb9, 0x48092cb9, 0x48092cb9, + 0x48092cb9, 0x48096286, 0x48096286, 0x48096286, 0x48096286, 0x48096286, 0x48099852, 0x48099852, + 0x48099852, 0x48099852, 0x48099852, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, + 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a39b9, 0x480a39b9, 0x480a39b9, + 0x480a39b9, 0x480a39b9, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480aa552, + 0x480aa552, 0x480aa552, 0x480aa552, 0x480aa552, 0x480adb1f, 0x480adb1f, 0x480adb1f, 0x480adb1f, + 0x480adb1f, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b46b8, 0x480b46b8, + 0x480b46b8, 0x480b46b8, 0x480b46b8, 0x480b7c85, 0x480b7c85, 0x480b7c85, 0x480b7c85, 0x480b7c85, + 0x480bb252, 0x480bb252, 0x480bb252, 0x480bb252, 0x480bb252, 0x480be81f, 0x480be81f, 0x480be81f, + 0x480be81f, 0x480be81f, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c53b8, + 0x480c53b8, 0x480c53b8, 0x480c53b8, 0x480c53b8, 0x480c8985, 0x480c8985, 0x480c8985, 0x480c8985, + 0x480c8985, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cf51e, 0x480cf51e, + 0x480cf51e, 0x480cf51e, 0x480cf51e, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, + 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d9685, 0x480d9685, 0x480d9685, + 0x480d9685, 0x480d9685, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480e021e, + 0x480e021e, 0x480e021e, 0x480e021e, 0x480e021e, 0x480e37eb, 0x480e37eb, 0x480e37eb, 0x480e37eb, + 0x480e37eb, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480ea384, 0x480ea384, + 0x480ea384, 0x480ea384, 0x480ea384, 0x480ed951, 0x480ed951, 0x480ed951, 0x480ed951, 0x480ed951, + 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f44eb, 0x480f44eb, 0x480f44eb, + 0x480f44eb, 0x480f44eb, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480fb084, + 0x480fb084, 0x480fb084, 0x480fb084, 0x480fb084, 0x480fe651, 0x480fe651, 0x480fe651, 0x480fe651, + 0x480fe651, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x481051ea, 0x481051ea, + 0x481051ea, 0x481051ea, 0x481051ea, 0x481087b7, 0x481087b7, 0x481087b7, 0x481087b7, 0x481087b7, + 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810f350, 0x4810f350, 0x4810f350, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbbc4b033, 0xbbc4b033, 0xbbc4b033, 0xbf7ffef9, 0xbf7ffef9, 0xbf7ffef9, 0xbf7ffef9, 0xbf7ffef9, + 0xbacd4419, 0xbacd4419, 0xbacd4419, 0xbacd4419, 0xbacd4419, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0xbbd4ad0f, 0xbbd4ad0f, 0xbbd4ad0f, 0xbbd4ad0f, 0xbbd4ad0f, 0xbf7fff25, + 0xbf7fff25, 0xbf7fff25, 0xbf7fff25, 0xbf7fff25, 0xba8d505b, 0xba8d505b, 0xba8d505b, 0xba8d505b, + 0xba8d505b, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0xbbe4a9e7, 0xbbe4a9e7, + 0xbbe4a9e7, 0xbbe4a9e7, 0xbbe4a9e7, 0xbf7fff4d, 0xbf7fff4d, 0xbf7fff4d, 0xbf7fff4d, 0xbf7fff4d, + 0xba1ab935, 0xba1ab935, 0xba1ab935, 0xba1ab935, 0xba1ab935, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, + 0x3f7fff9d, 0x3f7fff9d, 0xbbf4a6bd, 0xbbf4a6bd, 0xbbf4a6bd, 0xbbf4a6bd, 0xbbf4a6bd, 0xbf7fff71, + 0xbf7fff71, 0xbf7fff71, 0xbf7fff71, 0xbf7fff71, 0xb8d68d90, 0xb8d68d90, 0xb8d68d90, 0xb8d68d90, + 0xb8d68d90, 0x3f7fff7f, 0x3f7fff7f, 0x3f7fff7f, 0x3f7fff7f, 0x3f7fff7f, 0x3bfb5b1c, 0x3bfb5b1c, + 0x3bfb5b1c, 0x3bfb5b1c, 0x3bfb5b1c, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, + 0x39ca2ba3, 0x39ca2ba3, 0x39ca2ba3, 0x39ca2ba3, 0x39ca2ba3, 0x3f7fff5d, 0x3f7fff5d, 0x3f7fff5d, + 0x3f7fff5d, 0x3f7fff5d, 0x3beb5e49, 0x3beb5e49, 0x3beb5e49, 0x3beb5e49, 0x3beb5e49, 0xbf7fffad, + 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0x3a64fd54, 0x3a64fd54, 0x3a64fd54, 0x3a64fd54, + 0x3a64fd54, 0x3f7fff36, 0x3f7fff36, 0x3f7fff36, 0x3f7fff36, 0x3f7fff36, 0x3bdb6172, 0x3bdb6172, + 0x3bdb6172, 0x3bdb6172, 0x3bdb6172, 0xbf7fffc4, 0xbf7fffc4, 0xbf7fffc4, 0xbf7fffc4, 0xbf7fffc4, + 0x3ab27269, 0x3ab27269, 0x3ab27269, 0x3ab27269, 0x3ab27269, 0x3f7fff0c, 0x3f7fff0c, 0x3f7fff0c, + 0x3f7fff0c, 0x3f7fff0c, 0x3bcb6497, 0x3bcb6497, 0x3bcb6497, 0x3bcb6497, 0x3bcb6497, 0xbf7fffd8, + 0xbf7fffd8, 0xbf7fffd8, 0xbf7fffd8, 0xbf7fffd8, 0x3af26626, 0x3af26626, 0x3af26626, 0x3af26626, + 0x3af26626, 0x3f7ffede, 0x3f7ffede, 0x3f7ffede, 0x3f7ffede, 0x3f7ffede, 0x3bbb67b9, 0x3bbb67b9, + 0x3bbb67b9, 0x3bbb67b9, 0x3bbb67b9, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, + 0x3b192cef, 0x3b192cef, 0x3b192cef, 0x3b192cef, 0x3b192cef, 0x3f7ffeac, 0x3f7ffeac, 0x3f7ffeac, + 0x3f7ffeac, 0x3f7ffeac, 0x3bab6ad8, 0x3bab6ad8, 0x3bab6ad8, 0x3bab6ad8, 0x3bab6ad8, 0xbf7ffff4, + 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b3926c9, 0x3b3926c9, 0x3b3926c9, 0x3b3926c9, + 0x3b3926c9, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3b9b6df5, 0x3b9b6df5, + 0x3b9b6df5, 0x3b9b6df5, 0x3b9b6df5, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, + 0x3b5920a0, 0x3b5920a0, 0x3b5920a0, 0x3b5920a0, 0x3b5920a0, 0x3f7ffe3c, 0x3f7ffe3c, 0x3f7ffe3c, + 0x3f7ffe3c, 0x3f7ffe3c, 0x3b8b710f, 0x3b8b710f, 0x3b8b710f, 0x3b8b710f, 0x3b8b710f, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b791a74, 0x3b791a74, 0x3b791a74, 0x3b791a74, + 0x3b791a74, 0x3f7ffe02, 0x3f7ffe02, 0x3f7ffe02, 0x3f7ffe02, 0x3f7ffe02, 0x3b76e84e, 0x3b76e84e, + 0x3b76e84e, 0x3b76e84e, 0x3b76e84e, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, + 0x3b8c8a22, 0x3b8c8a22, 0x3b8c8a22, 0x3b8c8a22, 0x3b8c8a22, 0x3f7ffe40, 0x3f7ffe40, 0x3f7ffe40, +] )) ), + +################ chunk 16896 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4810f350, 0x4810f350, 0x4811291d, 0x4811291d, 0x4811291d, 0x4811291d, 0x4811291d, 0x48115eea, + 0x48115eea, 0x48115eea, 0x48115eea, 0x48115eea, 0x481194b7, 0x481194b7, 0x481194b7, 0x481194b7, + 0x481194b7, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x48120050, 0x48120050, + 0x48120050, 0x48120050, 0x48120050, 0x4812361d, 0x4812361d, 0x4812361d, 0x4812361d, 0x4812361d, + 0x48126bea, 0x48126bea, 0x48126bea, 0x48126bea, 0x48126bea, 0x4812a1b6, 0x4812a1b6, 0x4812a1b6, + 0x4812a1b6, 0x4812a1b6, 0x4812d783, 0x4812d783, 0x4812d783, 0x4812d783, 0x4812d783, 0x48130d50, + 0x48130d50, 0x48130d50, 0x48130d50, 0x48130d50, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, + 0x4813431d, 0x481378e9, 0x481378e9, 0x481378e9, 0x481378e9, 0x481378e9, 0x4813aeb6, 0x4813aeb6, + 0x4813aeb6, 0x4813aeb6, 0x4813aeb6, 0x4813e483, 0x4813e483, 0x4813e483, 0x4813e483, 0x4813e483, + 0x48141a50, 0x48141a50, 0x48141a50, 0x48141a50, 0x48141a50, 0x4814501c, 0x4814501c, 0x4814501c, + 0x4814501c, 0x4814501c, 0x481485e9, 0x481485e9, 0x481485e9, 0x481485e9, 0x481485e9, 0x4814bbb6, + 0x4814bbb6, 0x4814bbb6, 0x4814bbb6, 0x4814bbb6, 0x4814f183, 0x4814f183, 0x4814f183, 0x4814f183, + 0x4814f183, 0x4815274f, 0x4815274f, 0x4815274f, 0x4815274f, 0x4815274f, 0x48155d1c, 0x48155d1c, + 0x48155d1c, 0x48155d1c, 0x48155d1c, 0x481592e9, 0x481592e9, 0x481592e9, 0x481592e9, 0x481592e9, + 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815fe82, 0x4815fe82, 0x4815fe82, + 0x4815fe82, 0x4815fe82, 0x4816344f, 0x4816344f, 0x4816344f, 0x4816344f, 0x4816344f, 0x48166a1c, + 0x48166a1c, 0x48166a1c, 0x48166a1c, 0x48166a1c, 0x48169fe9, 0x48169fe9, 0x48169fe9, 0x48169fe9, + 0x48169fe9, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x48170b82, 0x48170b82, + 0x48170b82, 0x48170b82, 0x48170b82, 0x4817414f, 0x4817414f, 0x4817414f, 0x4817414f, 0x4817414f, + 0x4817771b, 0x4817771b, 0x4817771b, 0x4817771b, 0x4817771b, 0x4817ace8, 0x4817ace8, 0x4817ace8, + 0x4817ace8, 0x4817ace8, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x48181882, + 0x48181882, 0x48181882, 0x48181882, 0x48181882, 0x48184e4e, 0x48184e4e, 0x48184e4e, 0x48184e4e, + 0x48184e4e, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818b9e8, 0x4818b9e8, + 0x4818b9e8, 0x4818b9e8, 0x4818b9e8, 0x4818efb5, 0x4818efb5, 0x4818efb5, 0x4818efb5, 0x4818efb5, + 0x48192581, 0x48192581, 0x48192581, 0x48192581, 0x48192581, 0x48195b4e, 0x48195b4e, 0x48195b4e, + 0x48195b4e, 0x48195b4e, 0x44800000, 0x44802000, 0x447fc000, 0x44801000, 0x447fe000, 0x45000000, + 0x45001000, 0x44ffe000, 0x45000800, 0x44fff000, 0x45800000, 0x45800800, 0x457ff000, 0x45800400, + 0x457ff800, 0x46000000, 0x46000400, 0x45fff800, 0x46000200, 0x45fffc00, 0x46800000, 0x46800200, + 0x467ffc00, 0x46800100, 0x467ffe00, 0x47000000, 0x47000100, 0x46fffe00, 0x47000080, 0x46ffff00, + 0x47800000, 0x47800080, 0x477fff00, 0x47800040, 0x477fff80, 0x48000000, 0x48000040, 0x47ffff80, + 0x48000020, 0x47ffffc0, 0x48800000, 0x48800020, 0x487fffc0, 0x48800010, 0x487fffe0, 0x49000000, + 0x49000010, 0x48ffffe0, 0x49000008, 0x48fffff0, 0x49800000, 0x49800008, 0x497ffff0, 0x49800004, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffe40, 0x3f7ffe40, 0x3b56ee7a, 0x3b56ee7a, 0x3b56ee7a, 0x3b56ee7a, 0x3b56ee7a, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3b9c8708, 0x3b9c8708, 0x3b9c8708, 0x3b9c8708, + 0x3b9c8708, 0x3f7ffe7a, 0x3f7ffe7a, 0x3f7ffe7a, 0x3f7ffe7a, 0x3f7ffe7a, 0x3b36f4a3, 0x3b36f4a3, + 0x3b36f4a3, 0x3b36f4a3, 0x3b36f4a3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, + 0x3bac83eb, 0x3bac83eb, 0x3bac83eb, 0x3bac83eb, 0x3bac83eb, 0x3f7ffeb0, 0x3f7ffeb0, 0x3f7ffeb0, + 0x3f7ffeb0, 0x3f7ffeb0, 0x3b16fac9, 0x3b16fac9, 0x3b16fac9, 0x3b16fac9, 0x3b16fac9, 0xbf7fffe7, + 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, + 0x3bbc80cb, 0x3f7ffee2, 0x3f7ffee2, 0x3f7ffee2, 0x3f7ffee2, 0x3f7ffee2, 0x3aee01d8, 0x3aee01d8, + 0x3aee01d8, 0x3aee01d8, 0x3aee01d8, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, + 0x3bcc7da9, 0x3bcc7da9, 0x3bcc7da9, 0x3bcc7da9, 0x3bcc7da9, 0x3f7fff0f, 0x3f7fff0f, 0x3f7fff0f, + 0x3f7fff0f, 0x3f7fff0f, 0x3aae0e1c, 0x3aae0e1c, 0x3aae0e1c, 0x3aae0e1c, 0x3aae0e1c, 0xbf7fffc3, + 0xbf7fffc3, 0xbf7fffc3, 0xbf7fffc3, 0xbf7fffc3, 0x3bdc7a83, 0x3bdc7a83, 0x3bdc7a83, 0x3bdc7a83, + 0x3bdc7a83, 0x3f7fff39, 0x3f7fff39, 0x3f7fff39, 0x3f7fff39, 0x3f7fff39, 0x3a5c34b8, 0x3a5c34b8, + 0x3a5c34b8, 0x3a5c34b8, 0x3a5c34b8, 0xbf7fffab, 0xbf7fffab, 0xbf7fffab, 0xbf7fffab, 0xbf7fffab, + 0x3bec775a, 0x3bec775a, 0x3bec775a, 0x3bec775a, 0x3bec775a, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, + 0x3f7fff5f, 0x3f7fff5f, 0x39b89a6c, 0x39b89a6c, 0x39b89a6c, 0x39b89a6c, 0x39b89a6c, 0xbf7fff8f, + 0xbf7fff8f, 0xbf7fff8f, 0xbf7fff8f, 0xbf7fff8f, 0x3bfc742e, 0x3bfc742e, 0x3bfc742e, 0x3bfc742e, + 0x3bfc742e, 0x3f7fff81, 0x3f7fff81, 0x3f7fff81, 0x3f7fff81, 0x3f7fff81, 0xb90e6937, 0xb90e6937, + 0xb90e6937, 0xb90e6937, 0xb90e6937, 0xbf7fff6f, 0xbf7fff6f, 0xbf7fff6f, 0xbf7fff6f, 0xbf7fff6f, + 0xbbf38dab, 0xbbf38dab, 0xbbf38dab, 0xbbf38dab, 0xbbf38dab, 0x3f7fff9f, 0x3f7fff9f, 0x3f7fff9f, + 0x3f7fff9f, 0x3f7fff9f, 0xba2381d1, 0xba2381d1, 0xba2381d1, 0xba2381d1, 0xba2381d1, 0xbf7fff4a, + 0xbf7fff4a, 0xbf7fff4a, 0xbf7fff4a, 0xbf7fff4a, 0xbbe390d6, 0xbbe390d6, 0xbbe390d6, 0xbbe390d6, + 0xbbe390d6, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0xba91b4a9, 0xba91b4a9, + 0xba91b4a9, 0xba91b4a9, 0xba91b4a9, 0xbf7fff22, 0xbf7fff22, 0xbf7fff22, 0xbf7fff22, 0xbf7fff22, + 0xbbd393fd, 0xbbd393fd, 0xbbd393fd, 0xbbd393fd, 0xbbd393fd, 0x3f7fffcf, 0x3f7fffcf, 0x3f7fffcf, + 0x3f7fffcf, 0x3f7fffcf, 0xbe225693, 0x3f3ec3b0, 0xbf6a9ec9, 0x3eab2109, 0xbf1ccc0f, 0xbea04902, + 0x3f21498c, 0xbf77e3c6, 0x3e38ed82, 0xbf3ae53b, 0xbf183a75, 0x3eb5e31c, 0xbf7f7136, 0xbe0baad1, + 0xbf6844e2, 0xbf74c7c4, 0xbe8a5cae, 0xbf43546a, 0xbf32e0e7, 0xbf7ac05a, 0xbf0f5821, 0xbf7fede2, + 0x3eca0fc1, 0xbf637c1f, 0xbdc0dd22, 0x3f6d87fe, 0x3f50acf8, 0x3e4001b8, 0x3f7e399a, 0x3f22ae77, + 0x3f312b34, 0xbe6f14f9, 0x3f7b3848, 0x3e85c64e, 0x3f7412b7, 0xbf7fc5ec, 0xbf0120b4, 0xbf13430a, + 0xbf5b4bce, 0xbf65a0c3, 0xbdac404e, 0xbf624969, 0x3f4b0513, 0xbf0d3193, 0x3ecece12, 0x3e2ba40f, + 0x3f6b8da8, 0xbf3d2f33, 0x3f1ea75e, 0xbea6adb3, 0x3ea93666, 0x3f790661, 0xbf1d9959, 0x3f3e15d9, +] )) ), + +################ chunk 17408 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x497ffff8, 0x4a000000, 0x4a000004, 0x49fffff8, 0x4a000002, 0x49fffffc, 0x4a800000, 0x4a800002, + 0x4a7ffffc, 0x4a800001, 0x4a7ffffe, 0x4b000000, 0x4b000001, 0x4afffffe, 0x4b000000, 0x4affffff, + 0x4b800000, 0x4b800000, 0x4b7fffff, 0x4b800000, 0x4b800000, 0x4c000000, 0x4c000000, 0x4c000000, + 0x4c000000, 0x4c000000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4d000000, + 0x4d000000, 0x4d000000, 0x4d000000, 0x4d000000, 0x4d800000, 0x4d800000, 0x4d800000, 0x4d800000, + 0x4d800000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e800000, 0x4e800000, + 0x4e800000, 0x4e800000, 0x4e800000, 0x4f000000, 0x4f000000, 0x4f000000, 0x4f000000, 0x4f000000, + 0x4f800000, 0x4f800000, 0x4f800000, 0x4f800000, 0x4f800000, 0x50000000, 0x50000000, 0x50000000, + 0x50000000, 0x50000000, 0x50800000, 0x50800000, 0x50800000, 0x50800000, 0x50800000, 0x51000000, + 0x51000000, 0x51000000, 0x51000000, 0x51000000, 0x51800000, 0x51800000, 0x51800000, 0x51800000, + 0x51800000, 0x52000000, 0x52000000, 0x52000000, 0x52000000, 0x52000000, 0x52800000, 0x52800000, + 0x52800000, 0x52800000, 0x52800000, 0x53000000, 0x53000000, 0x53000000, 0x53000000, 0x53000000, + 0x53800000, 0x53800000, 0x53800000, 0x53800000, 0x53800000, 0x54000000, 0x54000000, 0x54000000, + 0x54000000, 0x54000000, 0x54800000, 0x54800000, 0x54800000, 0x54800000, 0x54800000, 0x55000000, + 0x55000000, 0x55000000, 0x55000000, 0x55000000, 0x55800000, 0x55800000, 0x55800000, 0x55800000, + 0x55800000, 0x56000000, 0x56000000, 0x56000000, 0x56000000, 0x56000000, 0x56800000, 0x56800000, + 0x56800000, 0x56800000, 0x56800000, 0x57000000, 0x57000000, 0x57000000, 0x57000000, 0x57000000, + 0x57800000, 0x57800000, 0x57800000, 0x57800000, 0x57800000, 0x58000000, 0x58000000, 0x58000000, + 0x58000000, 0x58000000, 0x58800000, 0x58800000, 0x58800000, 0x58800000, 0x58800000, 0x447a0000, + 0x44898000, 0x44610000, 0x447a4000, 0x4479c000, 0x461c4000, 0x462be000, 0x460ca000, 0x461c4400, + 0x461c3c00, 0x47c35000, 0x47d6d800, 0x47afc800, 0x47c35080, 0x47c34f80, 0x49742400, 0x49864700, + 0x495bba00, 0x49742410, 0x497423f0, 0x4b189680, 0x4b27d8c0, 0x4b095440, 0x4b189681, 0x4b18967f, + 0x4cbebc20, 0x4cd1cef0, 0x4caba950, 0x4cbebc20, 0x4cbebc20, 0x4e6e6b28, 0x4e832156, 0x4e5693a4, + 0x4e6e6b28, 0x4e6e6b28, 0x501502f9, 0x5023e9ac, 0x50061c46, 0x501502f9, 0x501502f9, 0x51ba43b7, + 0x51cce416, 0x51a7a358, 0x51ba43b7, 0x51ba43b7, 0x5368d4a5, 0x53800e8e, 0x53518c2e, 0x5368d4a5, + 0x5368d4a5, 0x551184e7, 0x55201231, 0x5502f79d, 0x551184e7, 0x551184e7, 0x56b5e621, 0x56c816be, + 0x56a3b584, 0x56b5e621, 0x56b5e621, 0x58635fa9, 0x587a1c6d, 0x584ca2e5, 0x58635fa9, 0x58635fa9, + 0x5a0e1bca, 0x5a1c51c4, 0x59ffcb9e, 0x5a0e1bca, 0x5a0e1bca, 0x5bb1a2bc, 0x5bc36635, 0x5b9fdf43, + 0x5bb1a2bc, 0x5bb1a2bc, 0x5d5e0b6b, 0x5d743fc3, 0x5d47d714, 0x5d5e0b6b, 0x5d5e0b6b, 0x44fa0000, + 0x469c4000, 0x453b8000, 0x46ea6000, 0x459c4000, 0x47435000, 0x45fa0000, 0x479c4000, 0x464b2000, + 0x47fde800, 0x46a41000, 0x484d1400, 0x4704d000, 0x48a60400, 0x4756d800, 0x49064700, 0x47add400, + 0x49594900, 0x480ca000, 0x49afc800, 0x48638a00, 0x4a0e3640, 0x48b81500, 0x4a661a40, 0x4914ed00, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbe265983, 0x3f1fb444, 0x3f7ea5a5, 0xbea423d5, 0x3f6c134a, 0x3e30ed67, 0x3f79a214, 0x3f369f1a, + 0x3eae4435, 0x3f764698, 0x3f3fdf21, 0x3edd4fa3, 0xbf067728, 0x3f7e0a54, 0x3edd4fa3, 0x3f4fc8cd, + 0xbf47917c, 0xbf47917c, 0xbf72bf60, 0xbf47917c, 0xbf47917c, 0xbf79fd0a, 0xbf79fd0a, 0xbf79fd0a, + 0xbf79fd0a, 0xbf79fd0a, 0x3ed76dd7, 0x3ed76dd7, 0x3ed76dd7, 0x3ed76dd7, 0x3ed76dd7, 0xbf436e65, + 0xbf436e65, 0xbf436e65, 0xbf436e65, 0xbf436e65, 0xbf7c777c, 0xbf7c777c, 0xbf7c777c, 0xbf7c777c, + 0xbf7c777c, 0x3ea733e0, 0x3ea733e0, 0x3ea733e0, 0x3ea733e0, 0x3ea733e0, 0xbf1e091b, 0xbf1e091b, + 0xbf1e091b, 0xbf1e091b, 0xbf1e091b, 0xbf78a7c9, 0xbf78a7c9, 0xbf78a7c9, 0xbf78a7c9, 0xbf78a7c9, + 0xbeec8981, 0xbeec8981, 0xbeec8981, 0xbeec8981, 0xbeec8981, 0x3f51c81c, 0x3f51c81c, 0x3f51c81c, + 0x3f51c81c, 0x3f51c81c, 0x3f70779b, 0x3f70779b, 0x3f70779b, 0x3f70779b, 0x3f70779b, 0xbf24f963, + 0xbf24f963, 0xbf24f963, 0xbf24f963, 0xbf24f963, 0x3f7c4c9e, 0x3f7c4c9e, 0x3f7c4c9e, 0x3f7c4c9e, + 0x3f7c4c9e, 0x3eaafa2b, 0x3eaafa2b, 0x3eaafa2b, 0x3eaafa2b, 0x3eaafa2b, 0xbf212984, 0xbf212984, + 0xbf212984, 0xbf212984, 0xbf212984, 0xbf7a6f90, 0xbf7a6f90, 0xbf7a6f90, 0xbf7a6f90, 0xbf7a6f90, + 0xbecfb891, 0xbecfb891, 0xbecfb891, 0xbecfb891, 0xbecfb891, 0x3f3ddb99, 0x3f3ddb99, 0x3f3ddb99, + 0x3f3ddb99, 0x3f3ddb99, 0x3f7eb742, 0x3f7eb742, 0x3f7eb742, 0x3f7eb742, 0x3f7eb742, 0xbe4bd8b6, + 0xbe4bd8b6, 0xbe4bd8b6, 0xbe4bd8b6, 0xbe4bd8b6, 0x3ec7c443, 0x3ec7c443, 0x3ec7c443, 0x3ec7c443, + 0x3ec7c443, 0x3f37ef0c, 0x3f37ef0c, 0x3f37ef0c, 0x3f37ef0c, 0x3f37ef0c, 0x3f7fdd77, 0x3f7fdd77, + 0x3f7fdd77, 0x3f7fdd77, 0x3f7fdd77, 0xbd84e24a, 0xbd84e24a, 0xbd84e24a, 0xbd84e24a, 0xbd84e24a, + 0x3e049a9b, 0x3e049a9b, 0x3e049a9b, 0x3e049a9b, 0x3e049a9b, 0x3e837cc6, 0x3e837cc6, 0x3e837cc6, + 0x3e837cc6, 0x3e837cc6, 0x3efe27af, 0x3efe27af, 0x3efe27af, 0x3efe27af, 0x3efe27af, 0x3f53ae61, + 0x3edb4578, 0x3f7f7009, 0x3f6b8481, 0xbcd8c438, 0xbe9c797d, 0xbf758d68, 0x3f1d8de9, 0xbf7761c0, + 0x3f22d698, 0x3d126d55, 0x3e8af267, 0xbeadcd5e, 0xbf52558e, 0x3f5c393b, 0xbeb33259, 0x3ec43a55, + 0x3ea1efb8, 0x3f1961ba, 0xbf7a33be, 0x3ed7520a, 0x3f362410, 0x3d9c7d01, 0xbf0945a2, 0x3f7d9c33, + 0x3f6e7fe5, 0xbf7f8178, 0xbf3142f1, 0x3f6e7fe5, 0x3f6e7fe5, 0x3f0bbc65, 0x3f150ecc, 0xbf7a9d1c, + 0x3f0bbc65, 0x3f0bbc65, 0xbef99a64, 0x3c3b662d, 0x3f5861fe, 0xbef99a64, 0xbef99a64, 0x3f7f840e, + 0x3f6aa031, 0x3f756b3e, 0x3f7f840e, 0x3f7f840e, 0xbcaa6b01, 0x3e5a4eb1, 0xbe81de03, 0xbcaa6b01, + 0xbcaa6b01, 0x3f78083e, 0x3f6adda3, 0x3f1d3928, 0x3f78083e, 0x3f78083e, 0x3f77970f, 0x3e2d9996, + 0xbeac88f4, 0x3f77970f, 0x3f77970f, 0x3f7e933f, 0x3daca466, 0x3e951b6a, 0x3f7e933f, 0x3f7e933f, + 0xbefe3f08, 0x3f7d6eb1, 0xbf5eb4af, 0xbefe3f08, 0xbefe3f08, 0xbf11e9aa, 0xbf7cff7f, 0x3e5002fc, + 0xbf11e9aa, 0xbf11e9aa, 0xbe5df089, 0x3f62c5b2, 0xbdfea72c, 0xbe5df089, 0xbe5df089, 0x3f6e1712, + 0x3f14fcf4, 0x3e607356, 0xbf4d7b7b, 0xbf7ceb5e, 0xbf7ff587, 0x3f7f72a4, 0x3f1c55c4, 0x3db74116, + 0x3f47e486, 0x3f7fed46, 0xbe727baf, 0x3f7e5a47, 0xbf68146e, 0xbe0c44e5, 0x3f7b10c5, 0xbf77fbb3, + 0xbf1750b7, 0x3f6cf046, 0x3f2cf280, 0x3f18ba91, 0x3ddf826b, 0x3f04529c, 0x3f40835f, 0xbdc465ec, +] )) ), + +################ chunk 17920 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4aba2840, 0x4970f780, 0x4b169ab0, 0x49c2f240, 0x4b73aed0, 0x4a1db700, 0x4bc524c0, 0x4a7f3020, + 0x4c1f7e14, 0x4ace7390, 0x4c81083a, 0x4b2705d0, 0x4cd0c744, 0x47c54400, 0x49769500, 0x4b1a1d20, + 0x439ea683, 0x431ea683, 0x47c92c00, 0x497b7700, 0x4b1d2a60, 0x43a1cac2, 0x4321cac2, 0x47d0fc00, + 0x49829d80, 0x4b2344e0, 0x43a81341, 0x43281341, 0x47d4e400, 0x49850e80, 0x4b265220, 0x43ab3780, + 0x432b3780, 0x47dcb400, 0x4989f080, 0x4b2c6ca0, 0x43b17fff, 0x43317fff, 0x47f80c00, 0x499b0780, + 0x4b41c960, 0x43c77dbb, 0x43477dbb, 0x47ffdc00, 0x499fe980, 0x4b47e3e0, 0x43cdc63a, 0x434dc63a, + 0x4805ca00, 0x49a73c80, 0x4b510ba0, 0x43d732f8, 0x435732f8, 0x4807be00, 0x49a9ad80, 0x4b5418e0, + 0x43da5737, 0x435a5737, 0x48118200, 0x49b5e280, 0x4b635b20, 0x43ea0c75, 0x436a0c75, 0x48137600, + 0x49b85380, 0x4b666860, 0x43ed30b4, 0x436d30b4, 0x48195200, 0x49bfa680, 0x4b6f9020, 0x43f69d72, + 0x43769d72, 0x481f2e00, 0x49c6f980, 0x4b78b7e0, 0x44000518, 0x43800518, 0x48231600, 0x49cbdb80, + 0x4b7ed260, 0x44032958, 0x43832958, 0x4828f200, 0x49d32e80, 0x4b83fd10, 0x4407dfb7, 0x4387dfb7, + 0x482ece00, 0x49da8180, 0x4b8890f0, 0x440c9616, 0x438c9616, 0x4830c200, 0x49dcf280, 0x4b8a1790, + 0x440e2836, 0x438e2836, 0x483a8600, 0x49e92780, 0x4b91b8b0, 0x441602d4, 0x439602d4, 0x483c7a00, + 0x49eb9880, 0x4b933f50, 0x441794f4, 0x439794f4, 0x48406200, 0x49f07a80, 0x4b964c90, 0x441ab933, + 0x439ab933, 0x48425600, 0x49f2eb80, 0x4b97d330, 0x441c4b53, 0x439c4b53, 0x484e0e00, 0x4a00c8c0, + 0x4ba0faf0, 0x4425b811, 0x43a5b811, 0x4859c600, 0x4a081bc0, 0x4baa22b0, 0x442f24cf, 0x43af24cf, + 0x485dae00, 0x4a0a8cc0, 0x4bad2ff0, 0x4432490f, 0x43b2490f, 0x485fa200, 0x4a0bc540, 0x4baeb690, + 0x4433db2f, 0x43b3db2f, 0x48638a00, 0x4a0e3640, 0x4bb1c3d0, 0x4436ff6e, 0x43b6ff6e, 0x48696600, + 0x4a11dfc0, 0x4bb657b0, 0x443bb5cd, 0x43bbb5cd, 0x486b5a00, 0x4a131840, 0x4bb7de50, 0x443d47ed, + 0x43bd47ed, 0x48751e00, 0x4a1932c0, 0x4bbf7f70, 0x4445228b, 0x43c5228b, 0x487afa00, 0x4a1cdc40, + 0x4bc41350, 0x4449d8ea, 0x43c9d8ea, 0x48806b00, 0x4a2085c0, 0x4bc8a730, 0x444e8f4a, 0x43ce8f4a, + 0x48835900, 0x4a242f40, 0x4bcd3b10, 0x445345a9, 0x43d345a9, 0x48845300, 0x4a2567c0, 0x4bcec1b0, + 0x4454d7c8, 0x43d4d7c8, 0x48874100, 0x4a291140, 0x4bd35590, 0x44598e28, 0x43d98e28, 0x48893500, + 0x4a2b8240, 0x4bd662d0, 0x445cb267, 0x43dcb267, 0x488a2f00, 0x4a2cbac0, 0x4bd7e970, 0x445e4487, + 0x43de4487, 0x488f1100, 0x4a32d540, 0x4bdf8a90, 0x44661f25, 0x43e61f25, 0x4895e700, 0x4a3b60c0, + 0x4bea38f0, 0x44711e03, 0x43f11e03, 0x4897db00, 0x4a3dd1c0, 0x4bed4630, 0x44744243, 0x43f44243, + 0x4898d500, 0x4a3f0a40, 0x4beeccd0, 0x4475d462, 0x43f5d462, 0x489ac900, 0x4a417b40, 0x4bf1da10, + 0x4478f8a2, 0x43f8f8a2, 0x48a19f00, 0x4a4a06c0, 0x4bfc8870, 0x4481fbc0, 0x4401fbc0, 0x48a48d00, + 0x4a4db040, 0x4c008e28, 0x448456ef, 0x440456ef, 0x48a96f00, 0x4a53cac0, 0x4c045eb8, 0x4488443f, + 0x4408443f, 0x48aa6900, 0x4a550340, 0x4c052208, 0x44890d4f, 0x44090d4f, 0x48ac5d00, 0x4a577440, + 0x4c06a8a8, 0x448a9f6e, 0x440a9f6e, 0x48af4b00, 0x4a5b1dc0, 0x4c08f298, 0x448cfa9e, 0x440cfa9e, + 0x48b33300, 0x4a5fffc0, 0x4c0bffd8, 0x44901edd, 0x44101edd, 0x45800000, 0x45800000, 0x45800000, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f51c77e, 0xbedd64d0, 0x3f789ddc, 0x3eb019fd, 0x3eb8f3d3, 0x3f375624, 0xbf7de0d1, 0xbf699ad7, + 0x3f60da75, 0x3f6e085c, 0xbf164189, 0x3d36400d, 0x3edc7010, 0xbf4e662e, 0x3d405c8d, 0xbee7c9f9, + 0xb7782347, 0x3f800000, 0xbe820307, 0xbf0b0c04, 0xbf03e87d, 0xb60c48ee, 0xbf800000, 0xbef394ea, + 0xbf784f61, 0xbf21d58d, 0xb6f1e04a, 0xbf800000, 0xbf24aab4, 0xbf25aed3, 0xbf2f97f4, 0x36b841cd, + 0x3f800000, 0xbd5c6f3b, 0x3f034624, 0xbf485a8e, 0x34c85f9f, 0x3f800000, 0xbf661672, 0xbf7c2002, + 0xbf7c408c, 0xb61916d0, 0xbf800000, 0x3f74a965, 0xbe1d5380, 0xbf7fe5c3, 0xb6f8473b, 0xbf800000, + 0x3f7d60e1, 0x3f7d8cd7, 0xbf7b92b6, 0x3443e110, 0x3f800000, 0xbe6c7b16, 0x3f399fe0, 0xbf778b08, + 0x37582090, 0xbf800000, 0x3f0469fd, 0xbf3fcee4, 0xbf510c12, 0xb77e8a38, 0x3f800000, 0x3f1b1c2a, + 0xbe6538db, 0xbf45f45e, 0xb625e4b3, 0xbf800000, 0x3f635086, 0x3f7f6d36, 0xbf1edb8b, 0x36ab73ea, + 0x3f800000, 0x3f7fd59f, 0xbeb43221, 0xbee0f42e, 0x3754ed17, 0xbf800000, 0xbf347434, 0xbf7fe022, + 0xbe9d1937, 0xb7c07869, 0xbf800000, 0xbf70c7ed, 0x3ea2f2c4, 0xbdc701ed, 0xb780ded8, 0x3f800000, + 0xbf7ed5e0, 0x3f50db9b, 0x3def80e6, 0xb7028a8f, 0xbf800000, 0x3e8dea50, 0x3ea760b9, 0x3e401c41, + 0xb7d6bcc2, 0x3f800000, 0xbf0ebc0a, 0xbeb8918d, 0x3f04ff54, 0x36f7b769, 0xbf800000, 0xbf1132dd, + 0x3e7fb385, 0x3f144973, 0xb72f1340, 0x3f800000, 0xbe187d47, 0x3f7f4269, 0x3f308483, 0x377b0ed6, + 0x3f800000, 0xbf5d6d4e, 0x3f5ae6c1, 0x3f3d5081, 0xb63f8079, 0xbf800000, 0xbf6fc0a3, 0xbeda3872, + 0x3f73d890, 0x374e8625, 0xbf800000, 0xbea5440a, 0xbe141248, 0x3f7e2b10, 0x37e67635, 0xbf800000, + 0x3f61edb2, 0xbf7bb57d, 0x3f773730, 0xb708f180, 0xbf800000, 0x3de789d8, 0xbf67daa7, 0x3f71d547, + 0xb7d9f03b, 0x3f800000, 0x3f18ba91, 0x3ddf826b, 0x3f6364b3, 0xb51be5ea, 0x3f800000, 0x3e48b661, + 0x3f6b95fc, 0x3f452520, 0x36eae986, 0xbf800000, 0x3f570885, 0x3f0546fc, 0x3f38f8ef, 0xb7357a32, + 0x3f800000, 0xbf224a9b, 0xbf0d0178, 0x3edeaa0d, 0x37b9ed83, 0xbf800000, 0xbf6760e7, 0x3f7543d0, + 0x3e6ecefa, 0x37f98714, 0x3f800000, 0xbf800000, 0xbb08944f, 0x3caab641, 0xb7c6df5b, 0xbf800000, + 0xbf676c96, 0xbf74f4ff, 0xbe451be2, 0xb78745ca, 0x3f800000, 0xbd8603ed, 0xbf1be986, 0xbe8633a8, + 0x37e342bc, 0xbf800000, 0xbef8ceba, 0x3f6f6586, 0xbeec5131, 0xb7dd23b3, 0x3f800000, 0xbe787a08, + 0x3f231238, 0xbf155298, 0xb5812a80, 0x3f800000, 0xbf5025e8, 0x3d8e1373, 0xbf23cc73, 0xb79d8a22, + 0xbf800000, 0x3f18a4a4, 0xbdd705b6, 0xbf5e4bbf, 0x376e40f4, 0x3f800000, 0xbed2c7ef, 0xbf644f84, + 0xbf7ff4f6, 0x3741b843, 0xbf800000, 0x3f6c640e, 0xbf374313, 0xbf7e0359, 0xb7ca12d3, 0xbf800000, + 0x3c90be57, 0xbe33ffac, 0xbf7b16dc, 0x37a075b2, 0x3f800000, 0x3f2ba5df, 0x3f60065d, 0xbf71699f, + 0xb78a7943, 0x3f800000, 0x3f796b78, 0xbf4390c6, 0xbf2ae89f, 0xb7a0bd9b, 0xbf800000, 0x3f7a1ea9, + 0x3f56999d, 0xbefcd3cc, 0x384f6dfb, 0x3f800000, 0xbf7ed344, 0xbf517919, 0xbe220610, 0xb8263cb7, + 0xbf800000, 0x3ee8d778, 0xbf7ffd7f, 0xbdb2baa1, 0xb870f874, 0x3f800000, 0xbf70d133, 0xbea0ec7e, + 0x3d63cd5d, 0x37f32023, 0x3f800000, 0xbf348793, 0x3f7fe815, 0x3e88a823, 0xb7cd464c, 0xbf800000, + 0xbf40f796, 0xbf466c2b, 0x3f072a7b, 0x37dcdbca, 0xbf800000, 0xbf183a75, 0xbf183a75, 0xbf183a75, +] )) ), + +################ chunk 18432 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x45800000, 0x46000000, 0x46000000, 0x46000000, 0x46000000, 0x46800000, 0x46800000, 0x46800000, + 0x46800000, 0x47000000, 0x47000000, 0x47000000, 0x47000000, 0x47800000, 0x47800000, 0x47800000, + 0x47800000, 0x48000000, 0x48000000, 0x48000000, 0x48000000, 0x48800000, 0x48800000, 0x48800000, + 0x48800000, 0x49000000, 0x49000000, 0x49000000, 0x49000000, 0x49800000, 0x49800000, 0x49800000, + 0x49800000, 0x4a25e927, 0x4bcf6371, 0x4d819e27, 0x49aca22c, 0x4b57cab8, 0x4c843514, 0x4bafac5d, + 0x4544597b, 0x4546aa6a, 0x45c4597b, 0x45c6aa6a, 0x4613431d, 0x4614ffd0, 0x4644597b, 0x4646aa6a, + 0x46756fda, 0x46785505, 0x4693431d, 0x4694ffd0, 0x46abce4c, 0x46add51d, 0x46c4597b, 0x46c6aa6a, + 0x46dce4ab, 0x46df7fb8, 0x46f56fda, 0x46f85505, 0x4706fd85, 0x47089529, 0x4713431d, 0x4714ffd0, + 0x471f88b4, 0x47216a76, 0x472bce4c, 0x472dd51d, 0x473813e4, 0x473a3fc4, 0x4744597b, 0x4746aa6a, + 0x47509f13, 0x47531511, 0x475ce4ab, 0x475f7fb8, 0x47692a43, 0x476bea5e, 0x47756fda, 0x47785505, + 0x4780dab9, 0x47825fd6, 0x4786fd85, 0x47889529, 0x478d2051, 0x478eca7c, 0x4793431d, 0x4794ffd0, + 0x479965e8, 0x479b3523, 0x479f88b4, 0x47a16a76, 0x47a5ab80, 0x47a79fca, 0x47abce4c, 0x47add51d, + 0x47b1f118, 0x47b40a70, 0x47b813e4, 0x47ba3fc4, 0x47be36b0, 0x47c07517, 0x47c4597b, 0x47c6aa6a, + 0x47ca7c47, 0x47ccdfbe, 0x47d09f13, 0x47d31511, 0x47d6c1df, 0x47d94a64, 0x47dce4ab, 0x47df7fb8, + 0x47e30777, 0x47e5b50b, 0x47e92a43, 0x47ebea5e, 0x47ef4d0e, 0x47f21fb2, 0x47f56fda, 0x47f85505, + 0x47fb92a6, 0x47fe8a58, 0x4800dab9, 0x48025fd6, 0x4803ec1f, 0x48057a7f, 0x4806fd85, 0x48089529, + 0x480a0eeb, 0x480bafd3, 0x480d2051, 0x480eca7c, 0x481031b7, 0x4811e526, 0x4813431d, 0x4814ffd0, + 0x48165482, 0x48181a79, 0x481965e8, 0x481b3523, 0x481c774e, 0x481e4fcd, 0x481f88b4, 0x48216a76, + 0x48229a1a, 0x48248520, 0x4825ab80, 0x48279fca, 0x4828bce6, 0x482aba73, 0x482bce4c, 0x482dd51d, + 0x482edfb2, 0x4830efc7, 0x4831f118, 0x48340a70, 0x4835027e, 0x4837251a, 0x483813e4, 0x483a3fc4, + 0x483b254a, 0x483d5a6d, 0x483e36b0, 0x48407517, 0x48414815, 0x48438fc1, 0x4844597b, 0x4846aa6a, + 0x48476ae1, 0x4849c514, 0x484a7c47, 0x484cdfbe, 0x484d8dad, 0x484ffa67, 0x48509f13, 0x48531511, + 0x4853b079, 0x48562fbb, 0x4856c1df, 0x48594a64, 0x4859d345, 0x485c650e, 0x485ce4ab, 0x485f7fb8, + 0x485ff611, 0x48629a61, 0x48630777, 0x4865b50b, 0x486618dd, 0x4868cfb5, 0x48692a43, 0x486bea5e, + 0x486c3ba8, 0x486f0508, 0x486f4d0e, 0x48721fb2, 0x48725e74, 0x48753a5b, 0x48756fda, 0x48785505, + 0x48788140, 0x487b6fae, 0x487b92a6, 0x487e8a58, 0x487ea40c, 0x4880d281, 0x4880dab9, 0x48825fd6, + 0x4882636c, 0x4883ed2b, 0x4883ec1f, 0x48857a7f, 0x488574d2, 0x488707d4, 0x4886fd85, 0x48889529, + 0x48888638, 0x488a227e, 0x488a0eeb, 0x488bafd3, 0x488b979e, 0x488d3d28, 0x488d2051, 0x488eca7c, + 0x488ea904, 0x489057d1, 0x489031b7, 0x4891e526, 0x4891ba6a, 0x4893727b, 0x4893431d, 0x4894ffd0, + 0x4894cbcf, 0x48968d25, 0x48965482, 0x48981a79, 0x4897dd35, 0x4899a7ce, 0x489965e8, 0x489b3523, + 0x489aee9b, 0x489cc278, 0x489c774e, 0x489e4fcd, 0x489e0001, 0x489fdd22, 0x489f88b4, 0x48a16a76, + 0x48a11167, 0x48a2f7cb, 0x48a29a1a, 0x48a48520, 0x48a422cd, 0x48a61275, 0x48a5ab80, 0x48a79fca, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbf183a75, 0xbf74c7c4, 0xbf74c7c4, 0xbf74c7c4, 0xbf74c7c4, 0xbf0f5821, 0xbf0f5821, 0xbf0f5821, + 0xbf0f5821, 0x3f6d87fe, 0x3f6d87fe, 0x3f6d87fe, 0x3f6d87fe, 0x3f312b34, 0x3f312b34, 0x3f312b34, + 0x3f312b34, 0xbf7fc5ec, 0xbf7fc5ec, 0xbf7fc5ec, 0xbf7fc5ec, 0xbdac404e, 0xbdac404e, 0xbdac404e, + 0xbdac404e, 0x3e2ba40f, 0x3e2ba40f, 0x3e2ba40f, 0x3e2ba40f, 0x3ea93666, 0x3ea93666, 0x3ea93666, + 0x3ea93666, 0xbe12024a, 0xbf4d5423, 0x3ede42ac, 0x3ed76962, 0xbf4ed869, 0x3f69a0ff, 0xbf52772e, + 0xb90254a0, 0xbf191063, 0xb98254a0, 0xbf7561bf, 0x39bc810f, 0xbf705bc6, 0xba0254a0, 0xbf0be025, + 0xb9c5d390, 0x3d7f3a24, 0x3a3c810e, 0x3f257521, 0xb9105062, 0x3f797394, 0xba82549f, 0x3f6a4ce7, + 0x38d60cbb, 0x3efcec19, 0xba45d390, 0xbdfebb2c, 0x39b32e8e, 0xbf317d0d, 0x3abc810b, 0xbf7c82b8, + 0xbab3c981, 0xbf634d8f, 0xb9905062, 0xbee03e0e, 0x3a5742a5, 0x3e3d725c, 0xbb02549b, 0x3f3cced0, + 0xba69e7a7, 0x3f7eab97, 0x39560cba, 0x3f5be86b, 0x3aaa7700, 0x3ec2a9dc, 0xbac5d38c, 0xbe7cc0c8, + 0xb9d87893, 0xbf46bdd1, 0x3a332e8d, 0xbf7fcf15, 0x3ae94cab, 0xbf529b20, 0x3b3c80ff, 0xbea6327a, + 0xbb7ba412, 0x3e9d85e6, 0xbb33c976, 0x3f512225, 0xbad7dd97, 0x3f7ff1d9, 0xba105062, 0x3f499759, + 0x3a0f1a75, 0x3e854944, 0x3ad742a1, 0xbeba2d25, 0x3b337bfb, 0xbf598852, 0xbb82548a, 0xbf7f0250, + 0xbb3cce7a, 0xbf3fdd67, 0xbae9e7a1, 0xbe4f62e4, 0xba34647a, 0x3ed9cc93, 0x39d60cba, 0x3f6129ec, + 0x3ac53896, 0x3f7d38f9, 0x3b2a76f7, 0x3f340b82, 0xbb86d70a, 0x3e1377d8, 0xbb45d37d, 0xbef4eec0, + 0xbafbf1ab, 0xbf68d6ad, 0xba587892, 0xbf7a8acf, 0x398de489, 0xbf276956, 0x3ab32e8b, 0xbd9e1c93, + 0x3b2171f2, 0x3f0799cb, 0x3b694c93, 0x3f6f7615, 0x3b989390, 0x3f767193, 0x3bbc80cb, 0x3f1d3297, + 0xbc0fc852, 0x3c249470, 0xbbfba398, 0xbf15e1ea, 0xbbd7b679, 0xbf73cfea, 0xbbb3c949, 0xbf713b41, + 0xbb8fdc0b, 0xbf0f4490, 0xbb57dd83, 0x3d2a32a9, 0xbb1002df, 0x3f237ca7, 0xba905060, 0x3f788143, + 0xb69af629, 0x3f6c7d59, 0x3a8f1a74, 0x3f00b0ce, 0x3b0f67e9, 0xbdde6162, 0x3b57428d, 0xbf2d6e82, + 0x3b8f8e90, 0xbf7c1323, 0x3bb37bcf, 0xbf655ea5, 0xbc144ac9, 0xbeea34c3, 0xbc025446, 0x3e335417, + 0xbbe0bb72, 0x3f39b0ce, 0xbbbcce46, 0x3f7e0af9, 0xbb98e10b, 0x3f5d369a, 0xbb69e789, 0x3ecb16af, + 0xbb220ce8, 0xbe67191a, 0xbab46477, 0xbf451c4b, 0xb992bc3b, 0xbf7f976f, 0x3a560cb9, 0xbf5645ab, + 0x3afabbbf, 0xbeab0dac, 0x3b453887, 0x3e94cc75, 0x3b868990, 0x3f4d4658, 0x3baa76d1, 0x3f7ffc39, + 0xbc18cd40, 0x3f4c606d, 0xbc06d6c0, 0x3e91ee51, 0xbbe9c06a, 0xbeb5603b, 0xbbc5d342, 0xbf571678, + 0xbba1e60b, 0xbf7f38e3, 0xbb7bf18d, 0xbf418ec1, 0xbb3416f1, 0xbe61427e, 0xbad8788d, 0x3ecdd57c, + 0xba11864e, 0x3f5df68b, 0x3a0de489, 0x3f7d4e4f, 0x3ad6a7aa, 0x3f35dd2d, 0x3b332e80, 0x3e1da3c4, + 0x3b7b091c, 0xbeecdd69, 0x3ba171d2, 0xbf6607dc, 0x3bc55f0a, 0xbf7bcf2b, 0x3be94c32, 0xbf295937, + 0x3c069ca4, 0xbdb29d5e, 0x3c189324, 0x3f0569aa, 0x3c2a8998, 0x3f6d0f13, 0x3c3c7fff, 0x3f78241b, + 0xbc98c1dd, 0x3f2254fd, 0xbc8fc6e7, 0x3ca49250, 0xbc86cbe5, 0xbf13ca4a, 0xbc7ba1b2, 0xbf73040f, + 0xbc69ab86, 0xbf7359fe, 0xbc57b547, 0xbf14aa88, 0xbc45bef7, 0x3c823270, 0xbc33c898, 0x3f217ff3, + 0xbc21d22b, 0x3f77dfec, 0xbc0fdbb0, 0x3f6d765e, 0xbbfbca56, 0x3f06541a, 0xbbd7dd37, 0xbdaa0d07, +] )) ), + +################ chunk 18944 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x48a73433, 0x48a92d1e, 0x48a8bce6, 0x48aaba73, 0x48aa4599, 0x48ac47c8, 0x48abce4c, 0x48add51d, + 0x48ad56ff, 0x48af6272, 0x48aedfb2, 0x48b0efc7, 0x48b06865, 0x48b27d1b, 0x48b1f118, 0x48b40a70, + 0x48b379cb, 0x48b597c5, 0x48b5027e, 0x48b7251a, 0x48b68b31, 0x48b8b26f, 0x48b813e4, 0x48ba3fc4, + 0x48b99c97, 0x48bbcd18, 0x48bb254a, 0x48bd5a6d, 0x48bcadfd, 0x48bee7c2, 0x48be36b0, 0x48c07517, + 0x48bfbf62, 0x48c2026c, 0x48c14815, 0x48c38fc1, 0x48c2d0c8, 0x48c51d15, 0x48c4597b, 0x48c6aa6a, + 0x48c5e22e, 0x48c837bf, 0x48c76ae1, 0x48c9c514, 0x48c8f394, 0x48cb5269, 0x48ca7c47, 0x48ccdfbe, + 0x48cc04fa, 0x48ce6d12, 0x48cd8dad, 0x48cffa67, 0x48cf1660, 0x48d187bc, 0x48d09f13, 0x48d31511, + 0x48d227c6, 0x48d4a266, 0x48d3b079, 0x48d62fbb, 0x48d5392c, 0x48d7bd0f, 0x48d6c1df, 0x48d94a64, + 0x48d84a92, 0x48dad7b9, 0x48d9d345, 0x48dc650e, 0x48db5bf8, 0x48ddf263, 0x48dce4ab, 0x48df7fb8, + 0x48de6d5e, 0x48e10d0c, 0x48dff611, 0x48e29a61, 0x48e17ec4, 0x48e427b6, 0x48e30777, 0x48e5b50b, + 0x48e4902a, 0x48e74260, 0x48e618dd, 0x48e8cfb5, 0x48e7a190, 0x48ea5d09, 0x48e92a43, 0x48ebea5e, + 0x48eab2f5, 0x48ed77b3, 0x48ec3ba8, 0x48ef0508, 0x48edc45b, 0x48f0925d, 0x48ef4d0e, 0x48f21fb2, + 0x48f0d5c1, 0x48f3ad06, 0x48f25e74, 0x48f53a5b, 0x48f3e727, 0x48f6c7b0, 0x48f56fda, 0x48f85505, + 0x48f6f88d, 0x48f9e25a, 0x48f88140, 0x48fb6fae, 0x48fa09f3, 0x48fcfd03, 0x48fb92a6, 0x48fe8a58, + 0x48fd1b59, 0x49000bd6, 0x48fea40c, 0x4900d281, 0x4900165f, 0x4901992b, 0x4900dab9, 0x49025fd6, + 0x49019f12, 0x49032680, 0x4902636c, 0x4903ed2b, 0x490327c5, 0x4904b3d5, 0x4903ec1f, 0x49057a7f, + 0x4904b078, 0x4906412a, 0x490574d2, 0x490707d4, 0x4906392b, 0x4907ce7f, 0x4906fd85, 0x49089529, + 0x4907c1de, 0x49095bd3, 0x49088638, 0x490a227e, 0x49094a91, 0x490ae928, 0x490a0eeb, 0x490bafd3, + 0x490ad344, 0x490c767d, 0x490b979e, 0x490d3d28, 0x490c5bf7, 0x490e03d2, 0x490d2051, 0x490eca7c, + 0x490de4aa, 0x490f9127, 0x490ea904, 0x491057d1, 0x490f6d5d, 0x49111e7c, 0x491031b7, 0x4911e526, + 0x4910f610, 0x4912abd0, 0x4911ba6a, 0x4913727b, 0x49127ec3, 0x49143925, 0x4913431d, 0x4914ffd0, + 0x49140776, 0x4915c67a, 0x4914cbcf, 0x49168d25, 0x49159029, 0x491753cf, 0x49165482, 0x49181a79, + 0x491718dc, 0x4918e124, 0x4917dd35, 0x4919a7ce, 0x4918a18f, 0x491a6e79, 0x491965e8, 0x491b3523, + 0x491a2a42, 0x491bfbcd, 0x491aee9b, 0x491cc278, 0x491bb2f5, 0x491d8922, 0x491c774e, 0x491e4fcd, + 0x491d3ba8, 0x491f1677, 0x491e0001, 0x491fdd22, 0x491ec45b, 0x4920a3cc, 0x491f88b4, 0x49216a76, + 0x49204d0e, 0x49223121, 0x49211167, 0x4922f7cb, 0x4921d5c1, 0x4923be76, 0x49229a1a, 0x49248520, + 0x49235e74, 0x49254bca, 0x492422cd, 0x49261275, 0x4924e727, 0x4926d91f, 0x4925ab80, 0x49279fca, + 0x49266fda, 0x49286674, 0x49273433, 0x49292d1e, 0x4927f88d, 0x4929f3c9, 0x4928bce6, 0x492aba73, + 0x49298140, 0x492b811e, 0x492a4599, 0x492c47c8, 0x492b09f2, 0x492d0e73, 0x492bce4c, 0x492dd51d, + 0x492c92a5, 0x492e9bc7, 0x492d56ff, 0x492f6272, 0x492e1b58, 0x4930291c, 0x492edfb2, 0x4930efc7, + 0x492fa40b, 0x4931b671, 0x49306865, 0x49327d1b, 0x49312cbe, 0x493343c6, 0x4931f118, 0x49340a70, + 0x4932b571, 0x4934d11b, 0x493379cb, 0x493597c5, 0x49343e24, 0x49365e70, 0x4935027e, 0x4937251a, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbbb3f007, 0xbf2e7ac9, 0xbb9002c9, 0xbf7b9d0a, 0xbb582afe, 0xbf66800b, 0xbb10505a, 0xbeeec48d, + 0xba90eb56, 0x3e19645e, 0xb71af629, 0x3f351b32, 0x3a8e7f7e, 0x3f7e3717, 0x3b0f1a6e, 0x3f5e7f13, + 0x3b56f513, 0x3ecfccb1, 0x3b8f67d3, 0xbe5d10c6, 0x3bb35511, 0xbf40da50, 0x3bd74241, 0xbf7f22e3, + 0x3bfb2f61, 0xbf557cb9, 0x3c0f8e36, 0xbeafe473, 0x3c2184b0, 0x3e8fdeba, 0x3c337b1e, 0x3f4bba56, + 0xbc9d442b, 0x3f7ff8b1, 0xbc94493b, 0x3f50442c, 0xbc8b4e3f, 0x3e8f30bc, 0xbc825338, 0xbeb08ea2, + 0xbc72b04d, 0xbf55aeaf, 0xbc60ba18, 0xbf7fa663, 0xbc4ec3d0, 0xbf45cb5a, 0xbc3ccd79, 0xbe7ad341, + 0xbc2ad712, 0x3ed0724d, 0xbc18e09e, 0x3f5eabd8, 0xbc06ea1e, 0x3f7e2c58, 0xbbe9e727, 0x3f3a6db8, + 0xbbc5f9ff, 0x3e378ed8, 0xbba20cc8, 0xbee122cf, 0xbb7c3f08, 0xbf66a76b, 0xbb34646c, 0xbf7b8c46, + 0xbad91383, 0xbf2e386d, 0xba12bc3a, 0xbde6ec31, 0x3a0cae9d, 0x3eff8581, 0x3ad60cb4, 0x3f6a8014, + 0x3b32e105, 0x3f77c935, 0x3b7abba1, 0x3f213997, 0x3ba14b15, 0x3d3b5f1e, 0x3bc5384d, 0xbf0e604e, + 0x3be92575, 0xbf70dea5, 0x3c068945, 0xbf754fad, 0x3c187fc5, 0xbf138040, 0x3c2a763a, 0x3cafe5ce, + 0xbca1c676, 0x3f1c5927, 0xbc98cb8c, 0x3f762693, 0xbc8fd096, 0x3f6fd6cc, 0xbc86d594, 0x3f0be0bd, + 0xbc7bb510, 0xbdb56f97, 0xbc69bee4, 0xbf299d24, 0xbc57c8a5, 0xbf7a51c1, 0xbc45d256, 0xbf694879, + 0xbc33dbf7, 0xbefa507a, 0xbc21e589, 0x3e1f09ec, 0xbc0fef0f, 0x3f361cea, 0xbbfbf113, 0x3f7d5b5c, + 0xbbd803f4, 0x3f5dc955, 0xbbb416c4, 0x3edbbdea, 0xbd11fd4a, 0xbe62a412, 0xbb587879, 0xbf3c77cc, + 0xbd090352, 0xbf7f3fe2, 0xba91864c, 0xbf5d2dbc, 0xbd000930, 0xbebc2d26, 0x3a8de488, 0x3e929c05, + 0xbcee1dca, 0x3f47ae8a, 0x3b56a798, 0x3f7ffd22, 0xbcdc28ea, 0x3f5404ca, 0x3bb32e54, 0x3e9bc2b4, + 0xbcca33c4, 0xbeb33c68, 0x3bfb08a3, 0xbf51fe4a, 0xbcb83e5e, 0xbf7f9241, 0x3c217152, 0xbf49e695, + 0xbca648be, 0xbe754824, 0x3c455e1f, 0x3eb5812f, 0xbc9452ea, 0x3f5b5b1d, 0x3c694aae, 0x3f7dffba, + 0xbc825ce7, 0x3f3eded0, 0x3c869b7a, 0x3e31ef23, 0xbc60cd76, 0xbed5423b, 0x3c989172, 0xbf63ba30, + 0xbc3ce0d7, 0xbf7b475f, 0x3caa873b, 0xbf32fa3e, 0xbc18f3fd, 0xbddb9096, 0x3cbc7ccd, 0x3ef40c93, + 0xbbea0de4, 0x3f6b11d3, 0xbd18bb11, 0x3f7b0b56, 0xbba23385, 0x3f2646a2, 0xbd0fc13c, 0x3d2489d0, + 0xbb34b1e7, 0xbf08de4d, 0xbd06c739, 0xbf715989, 0xba13f227, 0xbf771bfb, 0xbcfb9a19, 0xbf18d2ac, + 0x3ad571be, 0x3cdd97c6, 0xbce9a570, 0x3f1717fc, 0x3b7a6e26, 0x3f768a0c, 0xbcd7b07e, 0x3f720ec6, + 0x3bc5118f, 0x3f0aaded, 0xbcc5bb47, 0xbd022e3a, 0x3c0675e7, 0xbf24a2e2, 0xbcb3c5d3, 0xbf7a9d5c, + 0x3c2a62db, 0xbf6be98c, 0xbca1d025, 0xbef7d181, 0x3c4e4f9a, 0x3dca775e, 0xbc8fda45, 0x3f316f54, + 0x3c723c18, 0x3f7d8ec3, 0xbc7bc86e, 0x3f64b36b, 0x3c8b1425, 0x3ed9287c, 0xbc57dc04, 0xbe2976b4, + 0x3c9d0a12, 0xbf3d6e84, 0xbc33ef55, 0xbf7f5ad8, 0x3caeffcd, 0xbf5c74ba, 0xbc10026e, 0xbeb98440, + 0x3cc0f552, 0x3e6cedaf, 0xbbd82ab1, 0x3f489291, 0xbd167f0b, 0x3f7f7020, 0xbb905044, 0x3f533703, + 0xbd0d852b, 0x3e990969, 0xbb10eb51, 0xbe97a94b, 0xbd048b1d, 0xbf52ce98, 0xb79af629, 0xbf7ffff8, + 0xbcf721cd, 0xbf4904f6, 0x3b0e7f78, 0xbe6fbb13, 0xbce52d12, 0x3eb82c4d, 0x3b8f1a58, 0x3f5c16c3, + 0xbcd3380e, 0x3f7f67ac, 0x3bd6f4c7, 0x3f3dea5e, 0xbcc142c7, 0x3e6b03c2, 0x3c0f6779, 0xbed7da42, +] )) ), + +################ chunk 19456 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4935c6d7, 0x4937ebc4, 0x49368b31, 0x4938b26f, 0x49374f8a, 0x49397919, 0x493813e4, 0x493a3fc4, + 0x4938d83d, 0x493b066e, 0x49399c97, 0x493bcd18, 0x493a60f0, 0x493c93c3, 0x493b254a, 0x493d5a6d, + 0x493be9a3, 0x493e2118, 0x493cadfd, 0x493ee7c2, 0x493d7256, 0x493fae6d, 0x493e36b0, 0x49407517, + 0x493efb09, 0x49413bc1, 0x493fbf62, 0x4942026c, 0x494083bc, 0x4942c916, 0x49414815, 0x49438fc1, + 0x49420c6f, 0x4944566b, 0x4942d0c8, 0x49451d15, 0x49439522, 0x4945e3c0, 0x4944597b, 0x4946aa6a, + 0x49451dd5, 0x49477115, 0x4945e22e, 0x494837bf, 0x4946a688, 0x4948fe6a, 0x49476ae1, 0x4949c514, + 0x49482f3b, 0x494a8bbe, 0x4948f394, 0x494b5269, 0x4949b7ee, 0x494c1913, 0x494a7c47, 0x494cdfbe, + 0x494b40a1, 0x494da668, 0x494c04fa, 0x494e6d12, 0x494cc954, 0x494f33bd, 0x494d8dad, 0x494ffa67, + 0x494e5207, 0x4950c112, 0x494f1660, 0x495187bc, 0x494fdaba, 0x49524e66, 0x49509f13, 0x49531511, + 0x4951636d, 0x4953dbbb, 0x495227c6, 0x4954a266, 0x4952ec20, 0x49556910, 0x4953b079, 0x49562fbb, + 0x495474d2, 0x4956f665, 0x4955392c, 0x4957bd0f, 0x4955fd85, 0x495883ba, 0x4956c1df, 0x49594a64, + 0x49578638, 0x495a110f, 0x49584a92, 0x495ad7b9, 0x49590eeb, 0x495b9e63, 0x4959d345, 0x495c650e, + 0x495a979e, 0x495d2bb8, 0x495b5bf8, 0x495df263, 0x495c2051, 0x495eb90d, 0x495ce4ab, 0x495f7fb8, + 0x495da904, 0x49604662, 0x495e6d5e, 0x49610d0c, 0x495f31b7, 0x4961d3b7, 0x495ff611, 0x49629a61, + 0x4960ba6a, 0x4963610c, 0x49617ec4, 0x496427b6, 0x4962431d, 0x4964ee60, 0x49630777, 0x4965b50b, + 0x4963cbd0, 0x49667bb5, 0x4964902a, 0x49674260, 0x49655483, 0x4968090a, 0x496618dd, 0x4968cfb5, + 0x4966dd36, 0x4969965f, 0x4967a190, 0x496a5d09, 0x496865e9, 0x496b23b4, 0x49692a43, 0x496bea5e, + 0x4969ee9c, 0x496cb109, 0x496ab2f5, 0x496d77b3, 0x496b774f, 0x496e3e5d, 0x496c3ba8, 0x496f0508, + 0x496d0002, 0x496fcbb2, 0x496dc45b, 0x4970925d, 0x496e88b5, 0x49715907, 0x496f4d0e, 0x49721fb2, + 0x49701168, 0x4972e65c, 0x4970d5c1, 0x4973ad06, 0x49719a1b, 0x497473b1, 0x49725e74, 0x49753a5b, + 0x497322ce, 0x49760106, 0x4973e727, 0x4976c7b0, 0x4974ab81, 0x49778e5a, 0x49756fda, 0x49785505, + 0x49763434, 0x49791baf, 0x4976f88d, 0x4979e25a, 0x4977bce7, 0x497aa904, 0x49788140, 0x497b6fae, + 0x4979459a, 0x497c3659, 0x497a09f3, 0x497cfd03, 0x497ace4d, 0x497dc3ae, 0x497b92a6, 0x497e8a58, + 0x497c5700, 0x497f5103, 0x497d1b59, 0x49800bd6, 0x497ddfb3, 0x49806f2c, 0x497ea40c, 0x4980d281, + 0x497f6865, 0x498135d6, 0x4980165f, 0x4981992b, 0x4980788c, 0x4981fc81, 0x4980dab9, 0x49825fd6, + 0x49813ce6, 0x4982c32b, 0x49819f12, 0x49832680, 0x4982013f, 0x498389d5, 0x4982636c, 0x4983ed2b, + 0x4982c599, 0x49845080, 0x498327c5, 0x4984b3d5, 0x498389f2, 0x4985172a, 0x4983ec1f, 0x49857a7f, + 0x49844e4c, 0x4985ddd5, 0x4984b078, 0x4986412a, 0x498512a5, 0x4986a47f, 0x498574d2, 0x498707d4, + 0x4985d6ff, 0x49876b29, 0x4986392b, 0x4987ce7f, 0x49869b58, 0x498831d4, 0x4986fd85, 0x49889529, + 0x49875fb2, 0x4988f87e, 0x4987c1de, 0x49895bd3, 0x4988240b, 0x4989bf29, 0x49888638, 0x498a227e, + 0x4988e865, 0x498a85d3, 0x49894a91, 0x498ae928, 0x4989acbe, 0x498b4c7e, 0x498a0eeb, 0x498bafd3, + 0x498a7117, 0x498c1328, 0x498ad344, 0x498c767d, 0x498b3571, 0x498cd9d2, 0x498b979e, 0x498d3d28, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbcaf4d44, 0xbf646053, 0x3c335461, 0xbf7da7eb, 0xbc9d5789, 0xbf31f414, 0x3c574111, 0xbe278617, + 0xbc8b619d, 0x3ef68e83, 0x3c7b2d7d, 0x3f6ba1b4, 0xbc72d70a, 0x3f7ac2bb, 0x3c8f8ccd, 0x3f252fef, + 0xbc4eea8d, 0x3dc68d41, 0x3ca182ae, 0xbf0a12c6, 0xbc2afdcf, 0xbf6c1a50, 0x3cb3785c, 0xbf76bb77, + 0xbc0710db, 0xbf17acb3, 0xbd1d3cc0, 0xbcf4a292, 0xbbc6477a, 0x3f183e92, 0xbd144303, 0x3f7237a1, + 0xbb7cd9fe, 0x3f7196c7, 0xbd0b4917, 0x3f097a01, 0xbada496f, 0xbd190570, 0xbd024eff, 0xbf25ba3f, + 0x3a0a42c4, 0xbf773cc0, 0xbcf2a97c, 0xbf6b5a9e, 0x3b32460f, 0xbf0873de, 0xbce0b4ae, 0x3dd5d592, + 0x3ba0fd9a, 0x3f327635, 0xbccebf99, 0x3f7b23dd, 0x3be8d7fa, 0x3f640e33, 0xbcbcca43, 0x3ef32f29, + 0x3c185908, 0xbe2f1887, 0xbcaad4b2, 0xbf3e63ba, 0x3c3c45e4, 0xbf7de875, 0xbc98deea, 0xbf5bb9f7, + 0x3c603284, 0xbed45d45, 0xbc86e8f2, 0x3e727bb8, 0x3c820f6e, 0x3f4974ff, 0xbc69e5a1, 0x3f7f8753, + 0x3c940572, 0x3f52678d, 0xbc45f913, 0x3eb495b6, 0x3ca5fb47, 0xbe9a6334, 0xbc220c46, 0xbf4a33df, + 0xbd23fa59, 0xbf7ffe99, 0xbbfc3e8d, 0xbf4821bc, 0xbd1b00c1, 0xbe93fd40, 0xbbb4643f, 0x3ebad5f3, + 0xbd1206f8, 0x3f544b3b, 0xbb59136f, 0x3f7f4dbc, 0xbd090d00, 0x3f3cf469, 0xba92bc39, 0x3e657332, + 0xbd0012de, 0xbeda7090, 0x3a8cae9b, 0xbf5d6d02, 0xbcee3127, 0xbf7d7589, 0x3b560ca2, 0xbf3c2287, + 0xbcdc3c47, 0xbe21e275, 0x3bb2e0d9, 0x3ef90e7c, 0xbcca4721, 0x3f658ea3, 0x3bfabb29, 0x3f7a7822, + 0xbcb851bc, 0x3f300bbc, 0x3c214a95, 0x3dbb2ce7, 0xbca65c1c, 0xbf0b4626, 0x3c453762, 0xbf6ca6b6, + 0xbc946648, 0xbf7658fc, 0x3c6923f2, 0xbf23294b, 0xbc827045, 0xbcc6f173, 0x3c86881c, 0x3f0c4a17, + 0xbc60f433, 0x3f72ad08, 0x3c987e15, 0x3f711cdc, 0xbc3d0794, 0x3f158a1b, 0x3caa73dd, 0xbd2fdb6d, + 0xbc191aba, 0xbf1a5bea, 0xbd21be63, 0xbf779a9e, 0xbbea5b5f, 0xbf6ac9d0, 0xbd18c4be, 0xbf073def, + 0xbba28100, 0x3de13212, 0xbd0fcae9, 0x3f27bb2c, 0xbb354cdd, 0x3f7b69c6, 0xbd06d0e7, 0x3f6a4d7a, + 0xba165dff, 0x3ef0aa9e, 0xbcfbad75, 0xbe34b8f6, 0x3ad43bd2, 0xbf345866, 0xbce9b8cd, 0xbf7e1618, + 0x3b79d330, 0xbf62d802, 0xbcd7c3db, 0xbed1c2f6, 0x3bc4c414, 0x3e7807d3, 0xbcc5cea5, 0x3f402500, + 0x3c064f29, 0x3f7f9c7d, 0xbcb3d930, 0x3f5a5c20, 0x3c2a3c1e, 0x3eb1e8a8, 0xbca1e383, 0xbe9d1be2, + 0x3c4e28dd, 0xbf4b1354, 0xbc8feda3, 0xbf7ffb30, 0x3c72155c, 0xbf50e3a4, 0xbc7bef2b, 0xbe91408b, + 0x3c8b00c7, 0x3e9f6a0e, 0xbc5802c0, 0x3f5d88c9, 0x3c9cf6b4, 0x3f7ff6b1, 0xbc341612, 0x3f467984, + 0xbd287be8, 0x3e5fe0cd, 0xbd91e58b, 0xbedd0521, 0xbd1f826a, 0xbf55c215, 0xbbd8782c, 0xbf7f1870, + 0x3cd2d73c, 0xbf3b29ca, 0xbd88efb1, 0xbe1c3d89, 0xbd0d8ed9, 0x3efb8c78, 0xbb118647, 0x3f5ebd39, + 0x3cf6c0ff, 0x3f7d1316, 0xbd7ff257, 0x3f2f018e, 0xbcf7352a, 0x3dafcb0f, 0x3b0de482, 0xbf0c7869, + 0x3d0d54c5, 0xbf66b6b2, 0xbd6e0409, 0xbf79e8fa, 0xbcd34b6b, 0xbf220edf, 0x3bd6a74c, 0xbc993ebd, + 0x3d1f4859, 0x3f1a8816, 0xbd5c148e, 0x3f6da547, 0xbcaf60a1, 0x3f759dc5, 0x3c332da4, 0x3f1460b7, + 0x3d313b24, 0xbd46b003, 0xbd4a23fe, 0xbf27e500, 0xbc8b74fb, 0xbf7380f4, 0x3c7b06c1, 0xbf70366e, + 0x3d432d0f, 0xbf0606eb, 0xbd383270, 0x3dec8cc6, 0xbc4f114a, 0x3f1c750d, 0x3ca16f50, 0x3f7842f0, + 0xbd9542c3, 0x3f69b937, 0xbd263ff9, 0x3eee2427, 0xbc073799, 0xbe3a57f3, 0x3cc55a75, 0xbf29b787, +] )) ), + +################ chunk 19968 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x498bf9ca, 0x498da07d, 0x498c5bf7, 0x498e03d2, 0x498cbe24, 0x498e6727, 0x498d2051, 0x498eca7c, + 0x498d827d, 0x498f2dd2, 0x498de4aa, 0x498f9127, 0x498e46d7, 0x498ff47c, 0x498ea904, 0x499057d1, + 0x498f0b30, 0x4990bb26, 0x498f6d5d, 0x49911e7c, 0x498fcf8a, 0x499181d1, 0x499031b7, 0x4991e526, + 0x499093e3, 0x4992487b, 0x4990f610, 0x4992abd0, 0x4991583d, 0x49930f26, 0x4991ba6a, 0x4993727b, + 0x49921c96, 0x4993d5d0, 0x49927ec3, 0x49943925, 0x4992e0f0, 0x49949c7a, 0x4993431d, 0x4994ffd0, + 0x4993a549, 0x49956325, 0x49940776, 0x4995c67a, 0x499469a3, 0x499629cf, 0x4994cbcf, 0x49968d25, + 0x49952dfc, 0x4996f07a, 0x49959029, 0x499753cf, 0x4995f256, 0x4997b724, 0x49965482, 0x49981a79, + 0x4996b6af, 0x49987dcf, 0x499718dc, 0x4998e124, 0x49977b09, 0x49994479, 0x4997dd35, 0x4999a7ce, + 0x49983f62, 0x499a0b23, 0x4998a18f, 0x499a6e79, 0x499903bc, 0x499ad1ce, 0x499965e8, 0x499b3523, + 0x4999c815, 0x499b9878, 0x499a2a42, 0x499bfbcd, 0x499a8c6f, 0x499c5f23, 0x499aee9b, 0x499cc278, + 0x499b50c8, 0x499d25cd, 0x499bb2f5, 0x499d8922, 0x499c1522, 0x499dec77, 0x499c774e, 0x499e4fcd, + 0x499cd97b, 0x499eb322, 0x499d3ba8, 0x499f1677, 0x499d9dd5, 0x499f79cc, 0x499e0001, 0x499fdd22, + 0x499e622e, 0x49a04077, 0x499ec45b, 0x49a0a3cc, 0x499f2688, 0x49a10721, 0x499f88b4, 0x49a16a76, + 0x499feae1, 0x49a1cdcc, 0x49a04d0e, 0x49a23121, 0x49a0af3a, 0x49a29476, 0x49a11167, 0x49a2f7cb, + 0x49a17394, 0x49a35b20, 0x49a1d5c1, 0x49a3be76, 0x49a237ed, 0x49a421cb, 0x49a29a1a, 0x49a48520, + 0x49a2fc47, 0x49a4e875, 0x49a35e74, 0x49a54bca, 0x49a3c0a0, 0x49a5af20, 0x49a422cd, 0x49a61275, + 0x49a484fa, 0x49a675ca, 0x49a4e727, 0x49a6d91f, 0x49a54953, 0x49a73c74, 0x49a5ab80, 0x49a79fca, + 0x49a60dad, 0x49a8031f, 0x49a66fda, 0x49a86674, 0x49a6d206, 0x49a8c9c9, 0x49a73433, 0x49a92d1e, + 0x49a79660, 0x49a99074, 0x49a7f88d, 0x49a9f3c9, 0x49a85ab9, 0x49aa571e, 0x49a8bce6, 0x49aaba73, + 0x49a91f13, 0x49ab1dc9, 0x49a98140, 0x49ab811e, 0x49a9e36c, 0x49abe473, 0x49aa4599, 0x49ac47c8, + 0x49aaa7c6, 0x49acab1d, 0x49ab09f2, 0x49ad0e73, 0x49ab6c1f, 0x49ad71c8, 0x49abce4c, 0x49add51d, + 0x49ac3079, 0x49ae3872, 0x49ac92a5, 0x49ae9bc7, 0x49acf4d2, 0x49aeff1d, 0x49ad56ff, 0x49af6272, + 0x49adb92c, 0x49afc5c7, 0x49ae1b58, 0x49b0291c, 0x49ae7d85, 0x49b08c71, 0x49aedfb2, 0x49b0efc7, + 0x49af41df, 0x49b1531c, 0x49afa40b, 0x49b1b671, 0x49b00638, 0x49b219c6, 0x49b06865, 0x49b27d1b, + 0x49b0ca92, 0x49b2e071, 0x49b12cbe, 0x49b343c6, 0x49b18eeb, 0x49b3a71b, 0x49b1f118, 0x49b40a70, + 0x49b25345, 0x49b46dc6, 0x49b2b571, 0x49b4d11b, 0x49b3179e, 0x49b53470, 0x49b379cb, 0x49b597c5, + 0x49b3dbf8, 0x49b5fb1a, 0x49b43e24, 0x49b65e70, 0x49b4a051, 0x49b6c1c5, 0x49b5027e, 0x49b7251a, + 0x49b564aa, 0x49b7886f, 0x49b5c6d7, 0x49b7ebc4, 0x49b62904, 0x49b84f1a, 0x49b68b31, 0x49b8b26f, + 0x49b6ed5d, 0x49b915c4, 0x49b74f8a, 0x49b97919, 0x49b7b1b7, 0x49b9dc6e, 0x49b813e4, 0x49ba3fc4, + 0x49b87610, 0x49baa319, 0x49b8d83d, 0x49bb066e, 0x49b93a6a, 0x49bb69c3, 0x49b99c97, 0x49bbcd18, + 0x49b9fec3, 0x49bc306e, 0x49ba60f0, 0x49bc93c3, 0x49bac31d, 0x49bcf718, 0x49bb254a, 0x49bd5a6d, + 0x49bb8776, 0x49bdbdc2, 0x49bbe9a3, 0x49be2118, 0x49bc4bd0, 0x49be846d, 0x49bcadfd, 0x49bee7c2, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbd8c4d2d, 0xbf7be5bb, 0xbd144cb1, 0xbf622da0, 0xbb7d74f4, 0xbecf26fc, 0x3ce944a0, 0x3e7d91f3, + 0xbd8356e7, 0x3f3635ad, 0xbd0258ad, 0x3f7e6521, 0x3a07d6eb, 0x3f599c64, 0x3d0696d3, 0x3eaf3a2f, + 0xbd74bff5, 0xbe9fd34f, 0xbce0c80b, 0xbf41e10b, 0x3ba0b01f, 0xbf7fbe3e, 0x3d188aac, 0xbf500f6c, + 0xbd62d0e9, 0xbe8e82ad, 0xbcbcdda1, 0x3ec024c2, 0x3c18324b, 0x3f4cac20, 0x3d2a7dc5, 0x3f7fef82, + 0xbd50e0be, 0x3f4591c4, 0xbc98f248, 0x3e5a4ca0, 0x3c600bc7, 0xbedf97ee, 0x3d3c7007, 0xbf568a72, + 0xbd3eef8d, 0xbf7ef8b5, 0xbc6a0c5d, 0xbf3a2f90, 0x3c93f214, 0xbe16975e, 0xbd989fe0, 0x3ec4a0f2, + 0xbd2cfd6b, 0x3f5f7095, 0xbc223303, 0x3f7cdaf4, 0x3cb7dd8a, 0x3f2df5fa, 0xbd8faa90, 0x3da467d0, + 0xbd1b0a6e, 0xbee3f1de, 0xbbb4b1ba, 0xbf67543d, 0x3cdbc819, 0xbf7998b2, 0xbd86b48a, 0xbf20f327, + 0xbd0916ae, 0xbc5715a0, 0xba93f225, 0x3f011d8d, 0x3cffb192, 0x3f6e2c4c, 0xbd7b7bb6, 0x3f7535b4, + 0xbcee4484, 0x3f133624, 0x3b5571ac, 0xbd5d8304, 0x3d11cce5, 0xbf0facce, 0xbd698d1b, 0xbf73f0d5, + 0xbcca5a7e, 0xbf6fb70c, 0x3bfa6dae, 0xbf04ced6, 0x3d23c048, 0x3df7e598, 0xbd579d59, 0x3f1d95db, + 0xbca66f7a, 0x3f789b2d, 0x3c4510a6, 0x3f692317, 0x3d35b2de, 0x3eeb9bca, 0xbd45ac88, 0xbd821d64, + 0xbc8283a3, 0xbf2ac89d, 0x3c8674be, 0xbf7c25ee, 0x3d47a48e, 0xbf618170, 0xbd33babd, 0xbecc895b, + 0xbc3d2e51, 0x3e059155, 0x3caa607f, 0x3f3735ce, 0xbd9307d9, 0x3f7e8d00, 0xbd21c810, 0x3f58daeb, + 0xbbeaa8da, 0x3eac8a50, 0x3cce4b6a, 0xbe497976, 0xbd8a1216, 0xbf42cf0f, 0xbd0fd497, 0xbf7fcd9a, + 0xbb35e7d3, 0xbf4f398a, 0x3cf23551, 0xbe8bc3ac, 0xbd811ba5, 0x3e863c42, 0xbcfbc0d2, 0x3f4d86f4, + 0x3ad305e6, 0x3f7fe649, 0x3d0b0f03, 0x3f44a872, 0xbd704924, 0x3e54b6b5, 0xbcd7d738, 0xbea72081, + 0x3bc4769a, 0xbf575118, 0x3d1d02af, 0xbf7ed6f3, 0xbd5e59ce, 0xbf3933da, 0xbcb3ec8e, 0xbe10f000, + 0x3c2a1561, 0x3ec7436a, 0x3d2ef594, 0x3f602228, 0xbd4c6960, 0x3f7ca0cf, 0xbc900101, 0x3f2ce904, + 0x3c71ee9f, 0x3e4b3834, 0x3d40e79d, 0xbee67fd1, 0xbd3a77f0, 0xbf67eff0, 0xbc58297d, 0xbf79466d, + 0x3c9ce356, 0xbf1fd628, 0xbd966507, 0xbe07551e, 0xbd288596, 0x3f0258ca, 0xbc104fe8, 0x3f6eb16a, + 0x3cc0ce97, 0x3f74cbae, 0xbd8d6f89, 0x3f120a65, 0xbd169267, 0x3d85aaf5, 0xbb90eb39, 0xbf10dae2, + 0x3ce4b8e5, 0xbf745ec5, 0xbd847958, 0xbf6f35c1, 0xbd049e7a, 0xbf0395b2, 0xb81af629, 0x3afbbcc7, + 0x3d045109, 0x3f1eb568, 0xbd770502, 0x3f78f16f, 0xbce553cb, 0x3f688b1c, 0x3b8e7f62, 0x3ee9118d, + 0x3d1644f9, 0xbd8d844e, 0xbd65161b, 0xbf2bd856, 0xbcc16982, 0xbf7c641f, 0x3c0f19ff, 0xbf60d375, + 0x3d28382b, 0xbf017fe1, 0xbd532614, 0x3e0b3afa, 0xbc9d7e45, 0x3f383479, 0x3c56f398, 0x3f7eb2d6, + 0x3d3a2a8a, 0x3f5817b9, 0xbd413502, 0x3ee4bdd1, 0xbc732483, 0xbe4f12bd, 0x3c8f6611, 0xbf43bb85, + 0xbd99c21c, 0xbf7fdaeb, 0xbd2f42fd, 0xbf4e6203, 0xbc2b4b49, 0xbec57343, 0x3cb351a1, 0x3e88fd7a, + 0xbd90cce3, 0x3f4e6025, 0xbd1d501b, 0x3f7fdb06, 0xbbc6e270, 0x3f43bd8e, 0x3cd73c4f, 0x3ea5444b, + 0xbd87d6f4, 0xbea9d31d, 0xbd0b5c73, 0xbf581608, 0xbadcb547, 0xbf7eb328, 0x3cfb25ee, 0xbf3836aa, + 0xbd7dc0b4, 0xbe845625, 0xbcf2d036, 0x3ec9e44c, 0x3b311023, 0x3f60d1f2, 0x3d0f8728, 0x3f7c64a6, + 0xbd6bd23f, 0x3f2bdaac, 0xbccee654, 0x3e459dd0, 0x3be83d05, 0xbee90bee, 0x3d217aa5, 0xbf6889ca, +] )) ), + +################ chunk 20480 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x49bd1029, 0x49bf4b17, 0x49bd7256, 0x49bfae6d, 0x49bdd483, 0x49c011c2, 0x49be36b0, 0x49c07517, + 0x49be98dc, 0x49c0d86c, 0x49befb09, 0x49c13bc1, 0x49bf5d36, 0x49c19f17, 0x49bfbf62, 0x49c2026c, + 0x49c0218f, 0x49c265c1, 0x49c083bc, 0x49c2c916, 0x49c0e5e9, 0x49c32c6b, 0x49c14815, 0x49c38fc1, + 0x49c1aa42, 0x49c3f316, 0x49c20c6f, 0x49c4566b, 0x49c26e9c, 0x49c4b9c0, 0x49c2d0c8, 0x49c51d15, + 0x49c332f5, 0x49c5806b, 0x49c39522, 0x49c5e3c0, 0x49c3f74f, 0x49c64715, 0x49c4597b, 0x49c6aa6a, + 0x49c4bba8, 0x49c70dbf, 0x49c51dd5, 0x49c77115, 0x49c58002, 0x49c7d46a, 0x49c5e22e, 0x49c837bf, + 0x49c6445b, 0x49c89b14, 0x49c6a688, 0x49c8fe6a, 0x49c708b5, 0x49c961bf, 0x49c76ae1, 0x49c9c514, + 0x49c7cd0e, 0x49ca2869, 0x49c82f3b, 0x49ca8bbe, 0x49c89168, 0x49caef14, 0x49c8f394, 0x49cb5269, + 0x49c955c1, 0x49cbb5be, 0x49c9b7ee, 0x49cc1913, 0x49ca1a1a, 0x49cc7c68, 0x49ca7c47, 0x49ccdfbe, + 0x49cade74, 0x49cd4313, 0x49cb40a1, 0x49cda668, 0x49cba2cd, 0x49ce09bd, 0x49cc04fa, 0x49ce6d12, + 0x49cc6727, 0x49ced068, 0x49ccc954, 0x49cf33bd, 0x49cd2b80, 0x49cf9712, 0x49cd8dad, 0x49cffa67, + 0x49cdefda, 0x49d05dbc, 0x49ce5207, 0x49d0c112, 0x49ceb433, 0x49d12467, 0x49cf1660, 0x49d187bc, + 0x49cf788d, 0x49d1eb11, 0x49cfdaba, 0x49d24e66, 0x49d03ce6, 0x49d2b1bc, 0x49d09f13, 0x49d31511, + 0x49d10140, 0x49d37866, 0x49d1636d, 0x49d3dbbb, 0x49d1c599, 0x49d43f11, 0x49d227c6, 0x49d4a266, + 0x49d289f3, 0x49d505bb, 0x49d2ec20, 0x49d56910, 0x49d34e4c, 0x49d5cc65, 0x49d3b079, 0x49d62fbb, + 0x49d412a6, 0x49d69310, 0x49d474d2, 0x49d6f665, 0x49d4d6ff, 0x49d759ba, 0x49d5392c, 0x49d7bd0f, + 0x49d59b59, 0x49d82065, 0x49d5fd85, 0x49d883ba, 0x49d65fb2, 0x49d8e70f, 0x49d6c1df, 0x49d94a64, + 0x49d7240c, 0x49d9adb9, 0x49d78638, 0x49da110f, 0x49d7e865, 0x49da7464, 0x49d84a92, 0x49dad7b9, + 0x49d8acbf, 0x49db3b0e, 0x49d90eeb, 0x49db9e63, 0x49d97118, 0x49dc01b9, 0x49d9d345, 0x49dc650e, + 0x49da3572, 0x49dcc863, 0x49da979e, 0x49dd2bb8, 0x49daf9cb, 0x49dd8f0e, 0x49db5bf8, 0x49ddf263, + 0x49dbbe25, 0x49de55b8, 0x49dc2051, 0x49deb90d, 0x49dc827e, 0x49df1c62, 0x49dce4ab, 0x49df7fb8, + 0x49dd46d8, 0x49dfe30d, 0x49dda904, 0x49e04662, 0x49de0b31, 0x49e0a9b7, 0x49de6d5e, 0x49e10d0c, + 0x49decf8b, 0x49e17062, 0x49df31b7, 0x49e1d3b7, 0x49df93e4, 0x49e2370c, 0x49dff611, 0x49e29a61, + 0x49e0583d, 0x49e2fdb6, 0x49e0ba6a, 0x49e3610c, 0x49e11c97, 0x49e3c461, 0x49e17ec4, 0x49e427b6, + 0x49e1e0f0, 0x49e48b0b, 0x49e2431d, 0x49e4ee60, 0x49e2a54a, 0x49e551b6, 0x49e30777, 0x49e5b50b, + 0x49e369a3, 0x49e61860, 0x49e3cbd0, 0x49e67bb5, 0x49e42dfd, 0x49e6df0a, 0x49e4902a, 0x49e74260, + 0x49e4f256, 0x49e7a5b5, 0x49e55483, 0x49e8090a, 0x49e5b6b0, 0x49e86c5f, 0x49e618dd, 0x49e8cfb5, + 0x49e67b09, 0x49e9330a, 0x49e6dd36, 0x49e9965f, 0x49e73f63, 0x49e9f9b4, 0x49e7a190, 0x49ea5d09, + 0x49e803bc, 0x49eac05f, 0x49e865e9, 0x49eb23b4, 0x49e8c816, 0x49eb8709, 0x49e92a43, 0x49ebea5e, + 0x49e98c6f, 0x49ec4db3, 0x49e9ee9c, 0x49ecb109, 0x49ea50c9, 0x49ed145e, 0x49eab2f5, 0x49ed77b3, + 0x49eb1522, 0x49eddb08, 0x49eb774f, 0x49ee3e5d, 0x49ebd97c, 0x49eea1b3, 0x49ec3ba8, 0x49ef0508, + 0x49ec9dd5, 0x49ef685d, 0x49ed0002, 0x49efcbb2, 0x49ed622f, 0x49f02f07, 0x49edc45b, 0x49f0925d, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbd59e2a2, 0xbf78f22b, 0xbcaafb6d, 0xbf3685a2, 0x3c3bf86a, 0xbe01aabd, 0x3d336d55, 0x3f0392fd, + 0xbd47f1f2, 0x3f6f34a2, 0xbc870faf, 0x3f745fb5, 0x3c81e8b2, 0x3f2a0cc2, 0xbd9d1f14, 0x3d7486a3, + 0xbd360045, 0xbf1207ce, 0xbc46468c, 0xbf74cac2, 0x3ca5d48c, 0xbf6eb28e, 0xbd942a23, 0xbf1ccf2c, + 0xbd240db4, 0x3bf5c452, 0xbbfcd982, 0x3f1fd3b1, 0x3cc9bf94, 0x3f7945b5, 0xbd8b3478, 0x3f67f146, + 0xbd121a53, 0x3f0edc2f, 0xbb5a495b, 0xbd98ea17, 0x3ceda99e, 0xbf2ce6b0, 0xbd823e1c, 0xbf7ca04c, + 0xbd00263b, 0xbf6023ae, 0x3a8a42c3, 0xbf0043ef, 0x3d08c93e, 0x3e10e382, 0xbd728e3a, 0x3f3931ac, + 0xbcdc6301, 0x3f7ed6a6, 0x3bb245e3, 0x3f66e7fb, 0x3d1abd01, 0x3ee22e9d, 0xbd609f09, 0xbe54aa5d, + 0xbcb87877, 0xbf44a66c, 0x3c20fd1b, 0xbf7fe633, 0x3d2cb001, 0xbf5ef54c, 0xbd4eaebd, 0xbec2cfb5, + 0xbc948d04, 0x3e8bbd9a, 0x3c68d679, 0x3f4f37b0, 0xbda07bf1, 0x3f7fcdb9, 0xbd3cbd6d, 0x3f5600b1, + 0xbc6141ac, 0x3ea28f72, 0x3c985759, 0xbeac845f, 0xbd978749, 0xbf58d93e, 0xbd2acb2f, 0xbf7e8d55, + 0xbc196834, 0xbf4c1488, 0x3cbc42b5, 0xbe819322, 0xbd8e91e2, 0x3ecc8392, 0xbd18d81a, 0x3f617ff2, + 0xbba31bf6, 0x3f7c267a, 0x3ce02d24, 0x3f413c49, 0xbd859bc8, 0x3e4001da, 0xbd06e443, 0xbeeb9630, + 0xba1b35b0, 0xbf6921ca, 0x3d020b3c, 0xbf789bee, 0xbd794a09, 0xbf358481, 0xbce9df86, 0xbdf7fea6, + 0x3b789d45, 0x3f04cc23, 0x3d13ff42, 0x3f6fb5f1, 0xbd675b49, 0x3f7bb85e, 0xbcc5f55f, 0x3f28fabe, + 0x3c0601af, 0x3d5db56a, 0x3d25f28e, 0xbf133390, 0xbd556b65, 0xbf7534cc, 0xbca20a3f, 0xbf78050a, + 0x3c4ddb64, 0xbf1bad81, 0xbda3d8b2, 0x3c564bbe, 0xbd437a74, 0x3f20f0b3, 0xbc7c3ca4, 0x3f7997ff, + 0x3c8ada0b, 0x3f7332cd, 0xbd9ae454, 0x3f0dac2e, 0xbd31888c, 0xbda44ea8, 0xbc34638c, 0xbf2df3aa, + 0x3caec5b4, 0xbf7cda76, 0xbd91ef34, 0xbf6d473a, 0xbd1f95c5, 0xbefe0dee, 0xbbd91321, 0x3e168ae3, + 0x3cd2b082, 0x3f3a2d66, 0xbd88f95b, 0x3f7ef86d, 0xbd0da234, 0x3f66492c, 0xbb12bc33, 0x3edf9d9b, + 0x3cf69a46, 0xbe5a404c, 0xbd8002d6, 0xbf458fc3, 0xbcf75be3, 0xbf7d388e, 0x3b0cae96, 0xbf5e40b7, + 0x3d0d4169, 0xbec02a9b, 0xbd6e175f, 0x3e8e7c9e, 0xbcd37225, 0x3f500d95, 0x3bd60c57, 0x3f7f2d19, + 0x3d1f34fe, 0x3f553729, 0xbd5c27e6, 0x3e9fd94e, 0xbcaf875d, 0xbeaf3441, 0x3c32e02a, 0xbf599aba, + 0x3d3127c9, 0xbf7ffa74, 0xbd4a3757, 0xbf4b36f4, 0xbc8b9bb7, 0xbe7d9e2d, 0x3c7ab948, 0x3ecf2137, + 0xbd9e4144, 0x3f622c25, 0xbd3845ca, 0x3f7f9fb0, 0xbc4f5ec3, 0x3f404baa, 0x3ca14895, 0x3e3a645c, + 0xbd954c6b, 0xbeee1e91, 0xbd265354, 0xbf69b7ed, 0xbc078513, 0xbf7e1d37, 0x3cc533ba, 0xbf3481ee, + 0xbd8c56d7, 0xbdeca5d8, 0xbd14600c, 0x3f06043b, 0xbb7eaadf, 0x3f703557, 0x3ce91de7, 0x3f7b74c8, + 0xbd836091, 0x3f27e762, 0xbd026c09, 0x3d46e26d, 0x3a02ff3a, 0xbf145e25, 0x3d068377, 0xbf6ab275, + 0xbd74d34b, 0xbf77a976, 0xbce0eec5, 0xbf1a8a9a, 0x3ba0152a, 0x3c98d9cf, 0x3d187751, 0x3f220c6d, + 0xbd62e440, 0x3f710929, 0xbcbd045c, 0x3f72bfa5, 0x3c17e4d1, 0x3f0c7b0c, 0x3d2a6a6b, 0xbdafb1ea, + 0xbd50f417, 0xbf2eff40, 0xbc991904, 0xbf764909, 0x3c5fbe4e, 0xbf6cbd04, 0xbda19e17, 0xbefb91f7, + 0xbd3f02e6, 0x3e1c3110, 0xbc6a59d6, 0x3f3b27a3, 0x3c93cb58, 0x3f7a6c01, 0xbd98a988, 0x3f65a887, + 0xbd2d10c5, 0x3edd0ad1, 0xbc22807d, 0xbe5fd47d, 0x3cb7b6cf, 0xbf467785, 0xbd8fb439, 0xbf7d6d48, +] )) ), + +################ chunk 20992 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x49ee2688, 0x49f0f5b2, 0x49ee88b5, 0x49f15907, 0x49eeeae2, 0x49f1bc5c, 0x49ef4d0e, 0x49f21fb2, + 0x49efaf3b, 0x49f28307, 0x49f01168, 0x49f2e65c, 0x49f07395, 0x49f349b1, 0x49f0d5c1, 0x49f3ad06, + 0x49f137ee, 0x49f4105c, 0x49f19a1b, 0x49f473b1, 0x49f1fc48, 0x49f4d706, 0x49f25e74, 0x49f53a5b, + 0x49f2c0a1, 0x49f59db0, 0x49f322ce, 0x49f60106, 0x49f384fb, 0x49f6645b, 0x49f3e727, 0x49f6c7b0, + 0x49f44954, 0x49f72b05, 0x49f4ab81, 0x49f78e5a, 0x49f50dad, 0x49f7f1b0, 0x49f56fda, 0x49f85505, + 0x49f5d207, 0x49f8b85a, 0x49f63434, 0x49f91baf, 0x49f69660, 0x49f97f04, 0x49f6f88d, 0x49f9e25a, + 0x49f75aba, 0x49fa45af, 0x49f7bce7, 0x49faa904, 0x49f81f13, 0x49fb0c59, 0x49f88140, 0x49fb6fae, + 0x49f8e36d, 0x49fbd304, 0x49f9459a, 0x49fc3659, 0x49f9a7c6, 0x49fc99ae, 0x49fa09f3, 0x49fcfd03, + 0x49fa6c20, 0x49fd6059, 0x49face4d, 0x49fdc3ae, 0x49fb3079, 0x49fe2703, 0x49fb92a6, 0x49fe8a58, + 0x49fbf4d3, 0x49feedad, 0x49fc5700, 0x49ff5103, 0x49fcb92c, 0x49ffb458, 0x49fd1b59, 0x4a000bd6, + 0x49fd7d86, 0x4a003d81, 0x49fddfb3, 0x4a006f2c, 0x49fe41df, 0x4a00a0d6, 0x49fea40c, 0x4a00d281, + 0x49ff0639, 0x4a01042c, 0x49ff6865, 0x4a0135d6, 0x49ffca92, 0x4a016781, 0x4a00165f, 0x4a01992b, + 0x4a004776, 0x4a01cad6, 0x4a00788c, 0x4a01fc81, 0x4a00a9a3, 0x4a022e2b, 0x4a00dab9, 0x4a025fd6, + 0x4a010bcf, 0x4a029180, 0x4a013ce6, 0x4a02c32b, 0x4a016dfc, 0x4a02f4d6, 0x4a019f12, 0x4a032680, + 0x4a01d029, 0x4a03582b, 0x4a02013f, 0x4a0389d5, 0x4a023256, 0x4a03bb80, 0x4a02636c, 0x4a03ed2b, + 0x4a029482, 0x4a041ed5, 0x4a02c599, 0x4a045080, 0x4a02f6af, 0x4a04822a, 0x4a0327c5, 0x4a04b3d5, + 0x4a0358dc, 0x4a04e580, 0x4a0389f2, 0x4a05172a, 0x4a03bb09, 0x4a0548d5, 0x4a03ec1f, 0x4a057a7f, + 0x4a041d35, 0x4a05ac2a, 0x4a044e4c, 0x4a05ddd5, 0x4a047f62, 0x4a060f7f, 0x4a04b078, 0x4a06412a, + 0x4a04e18f, 0x4a0672d4, 0x4a0512a5, 0x4a06a47f, 0x4a0543bb, 0x4a06d62a, 0x4a0574d2, 0x4a0707d4, + 0x4a05a5e8, 0x4a07397f, 0x4a05d6ff, 0x4a076b29, 0x4a060815, 0x4a079cd4, 0x4a06392b, 0x4a07ce7f, + 0x4a066a42, 0x4a080029, 0x4a069b58, 0x4a0831d4, 0x4a06cc6e, 0x4a08637e, 0x4a06fd85, 0x4a089529, + 0x4a072e9b, 0x4a08c6d4, 0x4a075fb2, 0x4a08f87e, 0x4a0790c8, 0x4a092a29, 0x4a07c1de, 0x4a095bd3, + 0x4a07f2f5, 0x4a098d7e, 0x4a08240b, 0x4a09bf29, 0x4a085521, 0x4a09f0d3, 0x4a088638, 0x4a0a227e, + 0x4a08b74e, 0x4a0a5428, 0x4a08e865, 0x4a0a85d3, 0x4a09197b, 0x4a0ab77e, 0x4a094a91, 0x4a0ae928, + 0x4a097ba8, 0x4a0b1ad3, 0x4a09acbe, 0x4a0b4c7e, 0x4a09ddd4, 0x4a0b7e28, 0x4a0a0eeb, 0x4a0bafd3, + 0x4a0a4001, 0x4a0be17d, 0x4a0a7117, 0x4a0c1328, 0x4a0aa22e, 0x4a0c44d3, 0x4a0ad344, 0x4a0c767d, + 0x4a0b045b, 0x4a0ca828, 0x4a0b3571, 0x4a0cd9d2, 0x4a0b6687, 0x4a0d0b7d, 0x4a0b979e, 0x4a0d3d28, + 0x4a0bc8b4, 0x4a0d6ed2, 0x4a0bf9ca, 0x4a0da07d, 0x4a0c2ae1, 0x4a0dd227, 0x4a0c5bf7, 0x4a0e03d2, + 0x4a0c8d0e, 0x4a0e357d, 0x4a0cbe24, 0x4a0e6727, 0x4a0cef3a, 0x4a0e98d2, 0x4a0d2051, 0x4a0eca7c, + 0x4a0d5167, 0x4a0efc27, 0x4a0d827d, 0x4a0f2dd2, 0x4a0db394, 0x4a0f5f7c, 0x4a0de4aa, 0x4a0f9127, + 0x4a0e15c1, 0x4a0fc2d1, 0x4a0e46d7, 0x4a0ff47c, 0x4a0e77ed, 0x4a102627, 0x4a0ea904, 0x4a1057d1, + 0x4a0eda1a, 0x4a10897c, 0x4a0f0b30, 0x4a10bb26, 0x4a0f3c47, 0x4a10ecd1, 0x4a0f6d5d, 0x4a111e7c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbd1b1dc9, 0xbf5d8a5d, 0xbbb54caf, 0xbebd83f8, 0x3cdba15f, 0x3e913a7e, 0xbd86be34, 0x3f3ccce4, + 0xbd092a0a, 0x3f7f4965, 0xba965dfe, 0x3f546bed, 0x3cff8ada, 0x3e9d21e3, 0xbd7b8f0c, 0xbeb1e2bd, + 0xbcee6b3d, 0xbf47fd36, 0x3b543bc0, 0xbf7ffe31, 0x3d11b989, 0xbf4a57c1, 0xbd69a072, 0xbe781411, + 0xbcca8139, 0x3ed1bd35, 0x3bf9d2b9, 0x3f52462e, 0x3d23acee, 0x3f7f8ada, 0xbd57b0b1, 0x3f3f5983, + 0xbca69635, 0x3e34c561, 0x3c44c32c, 0xbef0a50c, 0xbda4face, 0xbf5b9be7, 0xbd45bfe1, 0xbf7defe6, + 0xbc82aa60, 0xbf337dea, 0x3c864e02, 0xbde14b28, 0xbd9c068a, 0x3f073b41, 0xbd33ce17, 0x3f63f394, + 0xbc3d7bcb, 0x3f7b2f31, 0x3caa39c4, 0x3f26d2ae, 0xbd931182, 0x3d300dda, 0xbd21db6b, 0xbf15878c, + 0xbbeb43cf, 0xbf6b4390, 0x3cce24b0, 0xbf774be9, 0xbd8a1bc0, 0xbf196677, 0xbd0fe7f3, 0x3cc68c87, + 0xbb371dbf, 0x3f09489b, 0x3cf20e98, 0x3f718363, 0xbd812550, 0x3f724a8e, 0xbcfbe78b, 0x3f0b48cb, + 0x3ad09a0d, 0xbdbb13c5, 0x3d0afba7, 0xbf177d86, 0xbd705c7a, 0xbf76abd5, 0xbcd7fdf2, 0xbf5e09a9, + 0x3bc3dba4, 0xbef913ff, 0x3d1cef53, 0x3d0a0b0c, 0xbd5e6d25, 0x3f3c2063, 0xbcb41349, 0x3f7ab6ec, + 0x3c29c7e7, 0x3f717f6e, 0xbda85767, 0x3eda7645, 0xbd4c7cb9, 0xbdce614a, 0xbe1186a6, 0xbf475db3, + 0x3c71a126, 0xbf7d9ffd, 0xbd9f6370, 0xbf6b3edb, 0x3da2864d, 0xbebadbd3, 0xbc5876f6, 0x3e2b6728, + 0xbdd8689e, 0x3f51b463, 0x3d52c55b, 0x3f7f63a8, 0xbd2898f0, 0x3f63ee25, 0xbe08a13e, 0x3e9a6938, + 0x3cc0a7dc, 0xbe6ed763, 0xbd8d7933, 0xbf5b187d, 0x3db46cd0, 0xbf7fffe3, 0xbb91862f, 0xbf5b95c4, + 0xbdc6899d, 0xbe7287fb, 0x3d76a455, 0x3e9899a9, 0xbd04b1d6, 0x3f637f23, 0xbdff724c, 0x3f7f73fa, + 0x3d043dad, 0x3f523f5f, 0xbd771857, 0x3e2f24f6, 0x3dc64fc7, 0xbeb9171a, 0x3b8de46c, 0xbf6ade9d, + 0xbdb4a6b3, 0xbf7dc08f, 0x3d8d3f3a, 0xbf47f5c2, 0xbcc1903d, 0xbdd5eeab, 0xbded9d13, 0x3ed8be6d, + 0x3d2824d1, 0x3f712e64, 0xbd53396c, 0x3f7ae799, 0xbe1331f2, 0x3f3cc4d4, 0x3c56a61e, 0x3d1937e0, + 0xbda2c03a, 0xbef76b06, 0x3d9f2981, 0xbf76672c, 0xbc7371fc, 0xbf76ec63, 0xbddbc32c, 0xbf30b988, + 0x3d4c08a5, 0x3cf43daa, 0xbd2f5657, 0x3f0a7cb3, 0xbe0a4d11, 0x3f7a82e9, 0x3cb32ae6, 0x3f71d389, + 0xbd90d68c, 0x3f23e1cd, 0x3db110a5, 0xbdc67423, 0xbbc77d65, 0xbf18a3b0, 0xbdc9e4f0, 0xbf7d7cdb, + 0x3d6fe874, 0xbf6ba2ef, 0xbd0b6fcf, 0xbf164c7c, 0xbe016576, 0x3e2779a4, 0x3cfaff36, 0x3f261a1a, + 0xbd7dd409, 0x3f7f5191, 0x3dc2f44d, 0x3f6461c0, 0x3b2fda37, 0x3f08094e, 0xbdb802bb, 0xbe6af77a, + 0x3d89e1c5, 0xbf32d05e, 0xbccf0d0e, 0xbf77ac7c, 0xbdf0f69f, 0xbf5c185f, 0x3d21674a, 0xbef25184, + 0xbd59f5fa, 0x3e96b2c0, 0xbe14dd25, 0x3f3eb7c7, 0x3c3baaf0, 0x3f7b7705, 0xbda61ce7, 0x3f52d063, + 0x3d9bcc99, 0x3ed3781b, 0xbc87366b, 0xbeb73b70, 0xbddf1d92, 0xbf49c291, 0x3d454bcb, 0xbf7e1ea9, + 0xbd36139f, 0xbf489487, 0xbe0bf8cb, 0xbeb3aa11, 0x3ca5add0, 0x3ed6f028, 0xbd9433cc, 0x3f53e3f5, + 0x3dadb45b, 0x3f7fa055, 0xbbfd7477, 0x3f3d70a3, 0xbdcd4020, 0x3e930c30, 0x3d692c69, 0xbef5ac3c, + 0xbd122daf, 0xbf5d103b, 0xbe0311b0, 0xbf7ffa4b, 0x3ced82e5, 0xbf31719a, 0xbd8247c7, 0xbe63886a, + 0x3dbf98b1, 0x3f09a60f, 0x3a87d6ea, 0x3f653cc7, 0xbdbb5ea3, 0x3f7f2c24, 0x3d868438, 0x3f24a54d, + 0xbcdc89bb, 0x3e1ff13d, 0xbdf45001, 0xbf17d6c4, 0x3d1aa9a6, 0xbf6c6024, 0xbd60b261, 0xbf7d36cd, +] )) ), + +################ chunk 21504 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4a0f9e73, 0x4a115026, 0x4a0fcf8a, 0x4a1181d1, 0x4a1000a0, 0x4a11b37b, 0x4a1031b7, 0x4a11e526, + 0x4a1062cd, 0x4a1216d1, 0x4a1093e3, 0x4a12487b, 0x4a10c4fa, 0x4a127a26, 0x4a10f610, 0x4a12abd0, + 0x4a112726, 0x4a12dd7b, 0x4a11583d, 0x4a130f26, 0x4a118953, 0x4a1340d0, 0x4a11ba6a, 0x4a13727b, + 0x4a11eb80, 0x4a13a425, 0x4a121c96, 0x4a13d5d0, 0x4a124dad, 0x4a14077b, 0x4a127ec3, 0x4a143925, + 0x4a12afd9, 0x4a146ad0, 0x4a12e0f0, 0x4a149c7a, 0x4a131206, 0x4a14ce25, 0x4a13431d, 0x4a14ffd0, + 0x4a137433, 0x4a15317a, 0x4a13a549, 0x4a156325, 0x4a13d660, 0x4a1594d0, 0x4a140776, 0x4a15c67a, + 0x4a14388c, 0x4a15f825, 0x4a1469a3, 0x4a1629cf, 0x4a149ab9, 0x4a165b7a, 0x4a14cbcf, 0x4a168d25, + 0x4a14fce6, 0x4a16becf, 0x4a152dfc, 0x4a16f07a, 0x4a155f13, 0x4a172224, 0x4a159029, 0x4a1753cf, + 0x4a15c13f, 0x4a17857a, 0x4a15f256, 0x4a17b724, 0x4a16236c, 0x4a17e8cf, 0x4a165482, 0x4a181a79, + 0x4a168599, 0x4a184c24, 0x4a16b6af, 0x4a187dcf, 0x4a16e7c6, 0x4a18af79, 0x4a1718dc, 0x4a18e124, + 0x4a1749f2, 0x4a1912ce, 0x4a177b09, 0x4a194479, 0x4a17ac1f, 0x4a197624, 0x4a17dd35, 0x4a19a7ce, + 0x4a180e4c, 0x4a19d979, 0x4a183f62, 0x4a1a0b23, 0x4a187079, 0x4a1a3cce, 0x4a18a18f, 0x4a1a6e79, + 0x4a18d2a5, 0x4a1aa023, 0x4a1903bc, 0x4a1ad1ce, 0x4a1934d2, 0x4a1b0378, 0x4a1965e8, 0x4a1b3523, + 0x4a1996ff, 0x4a1b66ce, 0x4a19c815, 0x4a1b9878, 0x4a19f92c, 0x4a1bca23, 0x4a1a2a42, 0x4a1bfbcd, + 0x4a1a5b58, 0x4a1c2d78, 0x4a1a8c6f, 0x4a1c5f23, 0x4a1abd85, 0x4a1c90cd, 0x4a1aee9b, 0x4a1cc278, + 0x4a1b1fb2, 0x4a1cf422, 0x4a1b50c8, 0x4a1d25cd, 0x4a1b81de, 0x4a1d5778, 0x4a1bb2f5, 0x4a1d8922, + 0x4a1be40b, 0x4a1dbacd, 0x4a1c1522, 0x4a1dec77, 0x4a1c4638, 0x4a1e1e22, 0x4a1c774e, 0x4a1e4fcd, + 0x4a1ca865, 0x4a1e8177, 0x4a1cd97b, 0x4a1eb322, 0x4a1d0a91, 0x4a1ee4cc, 0x4a1d3ba8, 0x4a1f1677, + 0x4a1d6cbe, 0x4a1f4822, 0x4a1d9dd5, 0x4a1f79cc, 0x4a1dceeb, 0x4a1fab77, 0x4a1e0001, 0x4a1fdd22, + 0x4a1e3118, 0x4a200ecc, 0x4a1e622e, 0x4a204077, 0x4a1e9344, 0x4a207221, 0x4a1ec45b, 0x4a20a3cc, + 0x4a1ef571, 0x4a20d577, 0x4a1f2688, 0x4a210721, 0x4a1f579e, 0x4a2138cc, 0x4a1f88b4, 0x4a216a76, + 0x4a1fb9cb, 0x4a219c21, 0x4a1feae1, 0x4a21cdcc, 0x4a201bf7, 0x4a21ff76, 0x4a204d0e, 0x4a223121, + 0x4a207e24, 0x4a2262cb, 0x4a20af3a, 0x4a229476, 0x4a20e051, 0x4a22c621, 0x4a211167, 0x4a22f7cb, + 0x4a21427e, 0x4a232976, 0x4a217394, 0x4a235b20, 0x4a21a4aa, 0x4a238ccb, 0x4a21d5c1, 0x4a23be76, + 0x4a2206d7, 0x4a23f020, 0x4a2237ed, 0x4a2421cb, 0x4a226904, 0x4a245375, 0x4a229a1a, 0x4a248520, + 0x4a22cb31, 0x4a24b6cb, 0x4a22fc47, 0x4a24e875, 0x4a232d5d, 0x4a251a20, 0x4a235e74, 0x4a254bca, + 0x4a238f8a, 0x4a257d75, 0x4a23c0a0, 0x4a25af20, 0x4a23f1b7, 0x4a25e0ca, 0x4a2422cd, 0x4a261275, + 0x4a2453e4, 0x4a26441f, 0x4a2484fa, 0x4a2675ca, 0x4a24b610, 0x4a26a775, 0x4a24e727, 0x4a26d91f, + 0x4a25183d, 0x4a270aca, 0x4a254953, 0x4a273c74, 0x4a257a6a, 0x4a276e1f, 0x4a25ab80, 0x4a279fca, + 0x4a25dc96, 0x4a27d174, 0x4a260dad, 0x4a28031f, 0x4a263ec3, 0x4a2834c9, 0x4a266fda, 0x4a286674, + 0x4a26a0f0, 0x4a28981f, 0x4a26d206, 0x4a28c9c9, 0x4a27031d, 0x4a28fb74, 0x4a273433, 0x4a292d1e, + 0x4a276549, 0x4a295ec9, 0x4a279660, 0x4a299074, 0x4a27c776, 0x4a29c21e, 0x4a27f88d, 0x4a29f3c9, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbe16883c, 0xbf171a88, 0x3c20afa1, 0xbdb74214, 0xbda97976, 0x3f2557d3, 0x3d986f95, 0x3f727211, + 0xbc94b3c0, 0x3f7a1c8b, 0xbde277d1, 0x3f08e0f8, 0x3d3e8ece, 0x3cb736be, 0xbd3cd0c7, 0xbf32199e, + 0xbe0da46d, 0xbf776b86, 0x3c98309d, 0xbf75e0f4, 0xbd9790f2, 0xbef4121f, 0x3daa57f2, 0x3d37b762, + 0xbc19b5ae, 0x3f3e0d61, 0xbdd09b2b, 0x3f7b46c4, 0x3d627035, 0x3f7088ee, 0xbd18eb75, 0x3ed547f7, + 0xbe04bdd3, 0xbde51acf, 0x3ce0066a, 0xbf492549, 0xbd85a572, 0xbf7dff55, 0x3dbc3cf4, 0xbf6a1aa7, + 0xba200d62, 0xbeb58716, 0xbdbeba6a, 0x3e36a872, 0x3d832693, 0x3f2903b6, 0xbcea0640, 0x3f7f9212, + 0xbdf7a937, 0x3f629d90, 0x3d13ebe7, 0x3e94f436, 0xbd676ea0, 0xbe79f030, 0xbe18333a, 0xbf358cec, + 0x3c05b435, 0xbf7ffd2a, 0xbdacd5e7, 0xbf5a1a52, 0x3d951277, 0xbe676a0d, 0xbca230fa, 0x3e9e0b67, + 0xbde5d1e8, 0x3f41441d, 0x3d37d1af, 0x3f7f4020, 0xbd438dcd, 0x3f509ac7, 0xbe0f4ff5, 0x3e23dffb, + 0x3c8ab34f, 0xbebe67e1, 0xbd9aedfd, 0xbf4c1bbc, 0x3da6fb6a, 0xbf7d5bd0, 0xbc34b106, 0xbf4629ec, + 0xbdd3f612, 0xbdbf30ad, 0x3d5bb3d8, 0x3edde819, 0xbd1fa920, 0x3f56073e, 0xbe0669dd, 0x3f7a526a, + 0x3cd289c7, 0x3f3ad3d3, 0xbd890305, 0x3cd710e1, 0x3db8e114, 0xbefc679c, 0xbb13f21f, 0xbf5efb29, + 0xbdc2160f, 0xbf762770, 0x3d7f91ae, 0xbf2ea59b, 0xbcf7829c, 0x3d27ccde, 0xbdfb0241, 0x3f0ce192, + 0x3d0d2e0d, 0x3f66ed22, 0xbd6e2ab5, 0x3f70dfb6, 0x3dcac31a, 0x3f21ad5b, 0x3bd57161, 0xbddd3008, + 0xbdb0323a, 0xbf1aec5d, 0x3d91b53d, 0xbf6dd3f8, 0xbcafae18, 0xbf6a8157, 0xbde92bd5, 0xbf13fa13, + 0x3d31146f, 0x3e32bce1, 0xbd4a4ab0, 0x3f2843f0, 0xbe10fb63, 0x3f73a7ae, 0x3c7a6bcf, 0x3f6313b2, + 0xbd9e4aec, 0x3f059b9d, 0x3da39ec5, 0xbe7612fa, 0xbc4fac3d, 0xbf34d8dd, 0xbdd750d2, 0xbf786189, + 0x3d54f754, 0xbf5a9f5c, 0xbd2666ae, 0xbeed4530, 0xbe0815d0, 0x3e9c2635, 0x3cc50cff, 0x3f409c96, + 0xbd8c6080, 0x3f7bfc0e, 0x3db58514, 0x3f512e20, 0xbb7fe0cb, 0x3ece40ac, 0xbdc57191, 0xbe01da19, + 0x3d78d608, 0xbf4b817e, 0xbd027f66, 0xbf7e7315, 0xbdfe5b1e, 0xbf46cae8, 0x3d06701b, 0xbeae4d90, + 0xbd74e6a1, 0x3e45ccaa, 0x3dc767cf, 0x3f557afb, 0x3b9f7a34, 0x3f7fc3c2, 0xbdb38e6d, 0x3f3b81ba, + 0x3d8e57ea, 0x3e8d90d2, 0xbcbd2b16, 0xbe846d35, 0xbdec859a, 0xbf5e7d84, 0x3d2a5710, 0xbf7fec91, + 0xbd51076f, 0xbf2f5fa2, 0xbe12a6b8, 0xbe58609f, 0x3c5f70d5, 0x3ea55ae3, 0xbda1a7bf, 0x3f667eab, + 0x3da04203, 0x3f7eed51, 0xbc6aa74f, 0x3f2272ab, 0xbddaab6c, 0x3e14a54c, 0x3d4e3aab, 0xbec58949, + 0xbd2d241f, 0xbf6d7530, 0xbe09c1ab, 0xbf7cc72b, 0x3cb79014, 0xbf14c9c9, 0xbd8fbde2, 0xbda07c09, + 0x3db228f3, 0x3ee4d32c, 0xbbb5e7a5, 0x3f735903, 0xbdc8ccf0, 0x3f797c9a, 0x3d721a35, 0x3f0674c7, + 0xbd093d66, 0x3c379e9e, 0xbe00d9e7, 0xbf018a2d, 0x3cff6421, 0xbf782354, 0xbd7ba261, 0xbf75116e, + 0x3dc40c62, 0xbeef0878, 0x3b5305d4, 0x3d655ddd, 0xbdb6ea80, 0x3f1014ea, 0x3d8afa7e, 0x3f7bce9a, + 0xbccaa7f3, 0x3f6f8ac2, 0xbdefdf34, 0x3ed012dd, 0x3d239993, 0xbdfbcd06, 0xbd57c409, 0xbf1df8fa, + 0xbe1451f3, 0xbf7e5694, 0x3c4475b2, 0xbf68eefc, 0xbda50475, 0xbeb02c8f, 0x3d9ce524, 0x3e41e3ea, + 0xbc82d11c, 0x3f2b264c, 0xbdde05df, 0x3f7fb856, 0x3d477ddc, 0x3f6145c1, 0xbd33e171, 0x3e8f7a74, + 0xbe0b6d6d, 0xbe828083, 0x3caa1309, 0xbf378da1, 0xbd931b2b, 0xbf7ff247, 0x3daeccb3, 0xbf5897ed, +] )) ), + +################ chunk 22016 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4a2829a3, 0x4a2a2574, 0x4a285ab9, 0x4a2a571e, 0x4a288bd0, 0x4a2a88c9, 0x4a28bce6, 0x4a2aba73, + 0x4a28edfc, 0x4a2aec1e, 0x4a291f13, 0x4a2b1dc9, 0x4a295029, 0x4a2b4f73, 0x4a298140, 0x4a2b811e, + 0x4a29b256, 0x4a2bb2c8, 0x4a29e36c, 0x4a2be473, 0x4a2a1483, 0x4a2c161e, 0x4a2a4599, 0x4a2c47c8, + 0x4a2a76af, 0x4a2c7973, 0x4a2aa7c6, 0x4a2cab1d, 0x4a2ad8dc, 0x4a2cdcc8, 0x4a2b09f2, 0x4a2d0e73, + 0x4a2b3b09, 0x4a2d401d, 0x4a2b6c1f, 0x4a2d71c8, 0x4a2b9d36, 0x4a2da372, 0x4a2bce4c, 0x4a2dd51d, + 0x4a2bff62, 0x4a2e06c8, 0x4a2c3079, 0x4a2e3872, 0x4a2c618f, 0x4a2e6a1d, 0x4a2c92a5, 0x4a2e9bc7, + 0x4a2cc3bc, 0x4a2ecd72, 0x4a2cf4d2, 0x4a2eff1d, 0x4a2d25e9, 0x4a2f30c7, 0x4a2d56ff, 0x4a2f6272, + 0x4a2d8815, 0x4a2f941c, 0x4a2db92c, 0x4a2fc5c7, 0x4a2dea42, 0x4a2ff772, 0x4a2e1b58, 0x4a30291c, + 0x4a2e4c6f, 0x4a305ac7, 0x4a2e7d85, 0x4a308c71, 0x4a2eae9c, 0x4a30be1c, 0x4a2edfb2, 0x4a30efc7, + 0x4a2f10c8, 0x4a312171, 0x4a2f41df, 0x4a31531c, 0x4a2f72f5, 0x4a3184c6, 0x4a2fa40b, 0x4a31b671, + 0x4a2fd522, 0x4a31e81c, 0x4a300638, 0x4a3219c6, 0x4a30374e, 0x4a324b71, 0x4a306865, 0x4a327d1b, + 0x4a30997b, 0x4a32aec6, 0x4a30ca92, 0x4a32e071, 0x4a30fba8, 0x4a33121b, 0x4a312cbe, 0x4a3343c6, + 0x4a315dd5, 0x4a337570, 0x4a318eeb, 0x4a33a71b, 0x4a31c001, 0x4a33d8c6, 0x4a31f118, 0x4a340a70, + 0x4a32222e, 0x4a343c1b, 0x4a325345, 0x4a346dc6, 0x4a32845b, 0x4a349f70, 0x4a32b571, 0x4a34d11b, + 0x4a32e688, 0x4a3502c5, 0x4a33179e, 0x4a353470, 0x4a3348b4, 0x4a35661b, 0x4a3379cb, 0x4a3597c5, + 0x4a33aae1, 0x4a35c970, 0x4a33dbf8, 0x4a35fb1a, 0x4a340d0e, 0x4a362cc5, 0x4a343e24, 0x4a365e70, + 0x4a346f3b, 0x4a36901a, 0x4a34a051, 0x4a36c1c5, 0x4a34d167, 0x4a36f36f, 0x4a35027e, 0x4a37251a, + 0x4a353394, 0x4a3756c5, 0x4a3564aa, 0x4a37886f, 0x4a3595c1, 0x4a37ba1a, 0x4a35c6d7, 0x4a37ebc4, + 0x4a35f7ee, 0x4a381d6f, 0x4a362904, 0x4a384f1a, 0x4a365a1a, 0x4a3880c4, 0x4a368b31, 0x4a38b26f, + 0x4a36bc47, 0x4a38e419, 0x4a36ed5d, 0x4a3915c4, 0x4a371e74, 0x4a39476f, 0x4a374f8a, 0x4a397919, + 0x4a3780a1, 0x4a39aac4, 0x4a37b1b7, 0x4a39dc6e, 0x4a37e2cd, 0x4a3a0e19, 0x4a3813e4, 0x4a3a3fc4, + 0x4a3844fa, 0x4a3a716e, 0x4a387610, 0x4a3aa319, 0x4a38a727, 0x4a3ad4c3, 0x4a38d83d, 0x4a3b066e, + 0x4a390954, 0x4a3b3819, 0x4a393a6a, 0x4a3b69c3, 0x4a396b80, 0x4a3b9b6e, 0x4a399c97, 0x4a3bcd18, + 0x4a39cdad, 0x4a3bfec3, 0x4a39fec3, 0x4a3c306e, 0x4a3a2fda, 0x4a3c6218, 0x4a3a60f0, 0x4a3c93c3, + 0x4a3a9206, 0x4a3cc56d, 0x4a3ac31d, 0x4a3cf718, 0x4a3af433, 0x4a3d28c3, 0x4a3b254a, 0x4a3d5a6d, + 0x4a3b5660, 0x4a3d8c18, 0x4a3b8776, 0x4a3dbdc2, 0x4a3bb88d, 0x4a3def6d, 0x4a3be9a3, 0x4a3e2118, + 0x4a3c1ab9, 0x4a3e52c2, 0x4a3c4bd0, 0x4a3e846d, 0x4a3c7ce6, 0x4a3eb618, 0x4a3cadfd, 0x4a3ee7c2, + 0x4a3cdf13, 0x4a3f196d, 0x4a3d1029, 0x4a3f4b17, 0x4a3d4140, 0x4a3f7cc2, 0x4a3d7256, 0x4a3fae6d, + 0x4a3da36c, 0x4a3fe017, 0x4a3dd483, 0x4a4011c2, 0x4a3e0599, 0x4a40436c, 0x4a3e36b0, 0x4a407517, + 0x4a3e67c6, 0x4a40a6c2, 0x4a3e98dc, 0x4a40d86c, 0x4a3ec9f3, 0x4a410a17, 0x4a3efb09, 0x4a413bc1, + 0x4a3f2c1f, 0x4a416d6c, 0x4a3f5d36, 0x4a419f17, 0x4a3f8e4c, 0x4a41d0c1, 0x4a3fbf62, 0x4a42026c, + 0x49bfbf63, 0x49bfbf63, 0x49bfbf63, 0x47f12065, 0x49712065, 0x489965e8, 0x4884ba86, 0x490cebfb, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbbebdec4, 0xbee66a80, 0xbdcc282c, 0x3ea3781a, 0x3d6b5e38, 0x3f4320a0, 0xbd0ffb4f, 0x3f7f0423, + 0xbe028629, 0x3f4eef8a, 0x3cf1e7de, 0x3ec72d6c, 0xbd812efa, 0xbec3b297, 0x3dc0b0d1, 0xbf4dd1e6, + 0x3ace2e35, 0xbf7ceefd, 0xbdba4673, 0xbf4457c4, 0x3d879cf9, 0xbea709f0, 0xbcd824ac, 0x3ee30ab1, + 0xbdf338a3, 0x3f579514, 0x3d1cdbf8, 0x3f79b540, 0xbd5e807d, 0x3f38dcde, 0xbe15fd14, 0x3e862538, + 0x3c297a6d, 0xbf00ae13, 0xbda8610e, 0xbf605ede, 0x3d998829, 0xbf755aa5, 0xbc904e79, 0xbf2c8c1d, + 0xbde1602b, 0xbe494aa5, 0x3d40c0eb, 0x3f0f41f3, 0xbd3a9ea4, 0x3f68251b, 0xbe0d1917, 0x3f6fe436, + 0x3c9c95df, 0x3f1f73c2, 0xbd967859, 0x3e0561ff, 0x3dab7054, 0xbf1d3019, 0xbc10eadc, 0xbf6edecc, + 0xbdcf8343, 0xbf695846, 0x3d64a211, 0xbf11a2f2, 0xbd16b91d, 0xbd81be17, 0xbe043253, 0x3f2a686a, + 0x3ce46b71, 0x3f748429, 0xbd848cad, 0x3f61be66, 0x3dbd551e, 0x3f0329aa, 0xb89af629, 0xbb7bbca9, + 0xbdbda244, 0xbf36db99, 0x3d843f5b, 0xbf790eab, 0xbce5a13e, 0xbf591f62, 0xbdf691e8, 0xbee8314c, + 0x3d161e42, 0x3d9170c8, 0xbd653cc9, 0x3f427b41, 0xbe17a819, 0x3f7c7910, 0x3c0e7f0a, 0x3f4f8532, + 0xbdabbd89, 0x3ec902aa, 0x3d962b13, 0xbe0d2db6, 0xbc9dcbbc, 0xbf4d39ee, 0xbde4ba4f, 0xbf7ebf65, + 0x3d3a03d7, 0xbf44faf3, 0xbd415bb5, 0xbea8eb81, 0xbe0ec4a7, 0x3e50ffb6, 0x3c8f1899, 0x3f570b33, + 0xbd99d56c, 0x3f7fdf08, 0x3da813d6, 0x3f5f6ac1, 0xbc2be63d, 0x3e8810f0, 0xbdd2de35, 0xbe89eff9, + 0x3d5de5c1, 0xbf5fe3b4, 0xbd1d76d1, 0xbf7fd6ad, 0xbe05de65, 0xbf5683ee, 0x3cd6eedb, 0xbe4d31ee, + 0xbd87ea48, 0x3eaac085, 0x3db9f94a, 0x3f67b936, 0xbae18cf8, 0x3f7ea65e, 0xbdc0fdf4, 0x3f4ca4f4, + 0x3d80e1a6, 0x3e09549e, 0xbcf31da8, 0xbecacb8b, 0xbdf9eb00, 0xbf6e82a9, 0x3d0f6071, 0xbf7c4f79, + 0xbd6bf8ec, 0xbf41d93f, 0xbe195304, 0xbd89b0e0, 0x3be7071b, 0x3ee9ebf8, 0xbdaf19e6, 0x3f743833, + 0x3d92cde3, 0x3f78d4b5, 0xbcab48e4, 0x3f362d4a, 0xbde8144a, 0x3849e5fe, 0x3d3346a1, 0xbf03fee6, + 0xbd4818a3, 0xbf78d33a, 0xbe10701e, 0xbf743a18, 0x3c819b3a, 0xbf29ae98, 0xbd9d3265, 0x3d897e84, + 0x3da4b73a, 0x3f126f1e, 0xbc46e17f, 0x3f7c4e68, 0xbdd63902, 0x3f6e84f4, 0x3d57294a, 0x3f1c6b9b, + 0xbd243469, 0xbe093b9b, 0xbe078a60, 0xbf2035f0, 0x3cc9721f, 0xbf7ea5b8, 0xbd8b47cb, 0xbf67bbe5, + 0x3db69d54, 0xbf0e73ab, 0xbb5cb533, 0x3e4d1934, 0xbdc45981, 0x3f2d436e, 0x3d7b07b6, 0x3f7fd674, + 0xbd004cf3, 0x3f5fe6c3, 0xbdfd43ec, 0x3effade3, 0x3d08a286, 0xbe8804c5, 0xbd72b4e6, 0xbf39887d, + 0xbe1afdd4, 0xbf7fdf3b, 0x3bb10ff8, 0xbf570e9f, 0xbdb27623, 0xbee14caa, 0x3d8f7098, 0x3ea8df98, + 0xbcb8c5ed, 0x3f44f6eb, 0xbdeb6e1c, 0x3f7ec004, 0x3d2c894c, 0x3f4d3db3, 0xbd4ed56e, 0x3ec1e6d0, + 0xbe121b7c, 0xbec8f70f, 0x3c683b87, 0xbf4f8180, 0xbda08f41, 0xbf7f1970, 0x3da15a82, 0xbf427f5b, + 0xbc61dc9e, 0xbea1a0a8, 0xbdd993a9, 0x3ee8260d, 0x3d506cac, 0x3f591c0a, 0xbd2af1e4, 0x3f7ff6e4, + 0xbe093643, 0x3f36e003, 0x3cbbf53f, 0x3e809f87, 0xbd8ea535, 0xbf03243f, 0x3db3413e, 0xbf61bb6c, + 0xbba451e1, 0xbf7fac3f, 0xbdc7b4ec, 0xbf2a6d1f, 0x3d744bf2, 0xbe3e1337, 0xbd070afc, 0x3f119dc2, + 0xbe004e56, 0x3f6955ad, 0x3d01e484, 0x3f7e39d5, 0xbd7970b4, 0x3f1d3514, 0xbe1ca888, 0x3df416fd, + 0x3d455f24, 0x3d455f24, 0x3d455f24, 0xbf7fa83d, 0x3ecdfeac, 0xbc7ba1b2, 0xbf739cf1, 0xbf7df5d7, +] )) ), + +################ chunk 22528 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x49536e96, 0x492ca22c, 0x4996b43f, 0x4b16b43f, 0x4a3fbf63, 0x4a25e927, 0x4ab026f9, 0x4b04251e, + 0x4ad7cab8, 0x4b3c614f, 0x4cbc614f, 0x4befaf3b, 0x4bcf6371, 0x4c5c30b8, 0x4ca52e66, 0x4c86deb3, + 0x4ceb79a3, 0x4e6b79a3, 0x4d95cd85, 0x4d819e27, 0x4e099e73, 0x4e4e79ff, 0x4e28965f, 0x4e932c06, + 0x50132c06, 0x4f3b40e6, 0x4f2205b0, 0x4fac060f, 0x50010c3f, 0x4fd2bbf7, 0x5037f707, 0x51b7f707, + 0x50ea1120, 0x50ca871c, 0x51570793, 0x51a14f4f, 0x5183b57b, 0x51e5f4c9, 0x5365f4c9, 0x52924ab4, + 0x527d28e4, 0x530664bc, 0x5349a323, 0x5324a2d9, 0x538fb8fe, 0x550fb8fe, 0x5436dd61, 0x541e398e, + 0x54a7fdeb, 0x54fc0bec, 0x54cdcb90, 0x5533a73d, 0x56b3a73d, 0x55e494b9, 0x55c5c7f2, 0x5651fd66, + 0x569d8773, 0x56809f3a, 0x56e0910c, 0x5860910c, 0x578edcf4, 0x577739ee, 0x58033e60, 0x5844e950, + 0x5820c708, 0x588c5aa8, 0x5a0c5aa8, 0x59329431, 0x591a8435, 0x59a40df8, 0x59f623a4, 0x59c8f8ca, + 0x5a2f7151, 0x5baf7152, 0x5adf393d, 0x5ac12542, 0x5b4d1175, 0x5b99d647, 0x5b7b36fd, 0xc39d1463, + 0xc39d1463, 0xc39d1463, 0xc39d1463, 0xc39d1463, 0xc41d1463, 0xc41d1463, 0xc41d1463, 0xc41d1463, + 0xc41d1463, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc49d1463, 0xc49d1463, + 0xc49d1463, 0xc49d1463, 0xc49d1463, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, + 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc50971d6, 0xc50971d6, 0xc50971d6, + 0xc50971d6, 0xc50971d6, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc530b6ef, + 0xc530b6ef, 0xc530b6ef, 0xc530b6ef, 0xc530b6ef, 0xc544597c, 0xc544597c, 0xc544597c, 0xc544597c, + 0xc544597c, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc56b9e94, 0xc56b9e94, + 0xc56b9e94, 0xc56b9e94, 0xc56b9e94, 0xc57f4121, 0xc57f4121, 0xc57f4121, 0xc57f4121, 0xc57f4121, + 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc593431d, 0xc593431d, 0xc593431d, + 0xc593431d, 0xc593431d, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc5a6e5a9, + 0xc5a6e5a9, 0xc5a6e5a9, 0xc5a6e5a9, 0xc5a6e5a9, 0xc5b0b6ef, 0xc5b0b6ef, 0xc5b0b6ef, 0xc5b0b6ef, + 0xc5b0b6ef, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5c4597c, 0xc5c4597c, + 0xc5c4597c, 0xc5c4597c, 0xc5c4597c, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, + 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5e1cd4e, 0xc5e1cd4e, 0xc5e1cd4e, + 0xc5e1cd4e, 0xc5e1cd4e, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5f56fda, + 0xc5f56fda, 0xc5f56fda, 0xc5f56fda, 0xc5f56fda, 0xc5ff4121, 0xc5ff4121, 0xc5ff4121, 0xc5ff4121, + 0xc5ff4121, 0xc6048933, 0xc6048933, 0xc6048933, 0xc6048933, 0xc6048933, 0xc60971d6, 0xc60971d6, + 0xc60971d6, 0xc60971d6, 0xc60971d6, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, + 0xc613431d, 0xc613431d, 0xc613431d, 0xc613431d, 0xc613431d, 0xc6182bc0, 0xc6182bc0, 0xc6182bc0, + 0xc6182bc0, 0xc6182bc0, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc621fd06, + 0xc621fd06, 0xc621fd06, 0xc621fd06, 0xc621fd06, 0xc626e5a9, 0xc626e5a9, 0xc626e5a9, 0xc626e5a9, + 0xc626e5a9, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc630b6ef, 0xc630b6ef, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7b3e83, 0xbe5c9741, 0xbef65816, 0xbf4455e0, 0x3dc52472, 0xbe12024a, 0x3f7f6b42, 0x3f7e75a4, + 0x3ee80b7b, 0xbf594820, 0xbf77b7d8, 0xbf02b78e, 0xbf4d5423, 0xbf3a610d, 0xbe72976f, 0x3f7ffd81, + 0xbf75dd9c, 0xbf45cec3, 0xbf7a474e, 0x3ede42ac, 0xbf748448, 0xbe28ec64, 0xbf35a361, 0xbf12c078, + 0xbf7c4061, 0xbf503ce1, 0xbf7d76c3, 0xbf0e8fe6, 0x3f4d7284, 0x3f2af506, 0x3dca436d, 0xbf361963, + 0x3dab52dd, 0x3f7ca583, 0x3e5d2995, 0x3ed47e82, 0x3e6cbc8e, 0xbf772fca, 0x3f5c4bf7, 0xbf3e344f, + 0x3f4cbd45, 0x3f490e5f, 0xbf04755a, 0xbf05d1b6, 0xbf74ba3b, 0xbf301fe5, 0xbf5e019f, 0xbf7e590e, + 0x3ec37c6e, 0xbf21b960, 0x3f4acedc, 0xbbb1ad31, 0xbd319f27, 0xbf48f0a8, 0xbf7eca4a, 0x3ed9aab5, + 0xbf721601, 0x3e8db267, 0xbf2a5017, 0x3ee36307, 0x3ef60685, 0xbf00710c, 0x3f57293e, 0xbf5fe2d4, + 0xbf59a073, 0x3f7d7614, 0x3f674440, 0xbf748f96, 0xbf0f1011, 0xbf0748c5, 0x3f7071ae, 0x3f2c0f98, + 0xbf6029c8, 0xbf760032, 0xbe432c52, 0x3ca94731, 0x3f6e31d4, 0xbf3f156a, 0xbf297a30, 0xb6c55799, + 0xb6c55799, 0xb6c55799, 0xb6c55799, 0xb6c55799, 0xb7455799, 0xb7455799, 0xb7455799, 0xb7455799, + 0xb7455799, 0x3757fc9b, 0x3757fc9b, 0x3757fc9b, 0x3757fc9b, 0x3757fc9b, 0xb7c55799, 0xb7c55799, + 0xb7c55799, 0xb7c55799, 0xb7c55799, 0xb87b56bf, 0xb87b56bf, 0xb87b56bf, 0xb87b56bf, 0xb87b56bf, + 0x37d7fc9b, 0x37d7fc9b, 0x37d7fc9b, 0x37d7fc9b, 0x37d7fc9b, 0x38e9a9ad, 0x38e9a9ad, 0x38e9a9ad, + 0x38e9a9ad, 0x38e9a9ad, 0xb8455799, 0xb8455799, 0xb8455799, 0xb8455799, 0xb8455799, 0x3821fd74, + 0x3821fd74, 0x3821fd74, 0x3821fd74, 0x3821fd74, 0xb8fb56bf, 0xb8fb56bf, 0xb8fb56bf, 0xb8fb56bf, + 0xb8fb56bf, 0xb80f5872, 0xb80f5872, 0xb80f5872, 0xb80f5872, 0xb80f5872, 0x3857fc9b, 0x3857fc9b, + 0x3857fc9b, 0x3857fc9b, 0x3857fc9b, 0xb8e0572c, 0xb8e0572c, 0xb8e0572c, 0xb8e0572c, 0xb8e0572c, + 0x3969a9ad, 0x3969a9ad, 0x3969a9ad, 0x3969a9ad, 0x3969a9ad, 0xb93c810f, 0xb93c810f, 0xb93c810f, + 0xb93c810f, 0xb93c810f, 0xb8c55799, 0xb8c55799, 0xb8c55799, 0xb8c55799, 0xb8c55799, 0xb70d6891, + 0xb70d6891, 0xb70d6891, 0xb70d6891, 0xb70d6891, 0x38a1fd74, 0x38a1fd74, 0x38a1fd74, 0x38a1fd74, + 0x38a1fd74, 0x392ad3fd, 0x392ad3fd, 0x392ad3fd, 0x392ad3fd, 0x392ad3fd, 0xb97b56bf, 0xb97b56bf, + 0xb97b56bf, 0xb97b56bf, 0xb97b56bf, 0xb921817c, 0xb921817c, 0xb921817c, 0xb921817c, 0xb921817c, + 0xb88f5872, 0xb88f5872, 0xb88f5872, 0xb88f5872, 0xb88f5872, 0x37914852, 0x37914852, 0x37914852, + 0x37914852, 0x37914852, 0x38d7fc9b, 0x38d7fc9b, 0x38d7fc9b, 0x38d7fc9b, 0x38d7fc9b, 0x3945d391, + 0x3945d391, 0x3945d391, 0x3945d391, 0x3945d391, 0xb960572c, 0xb960572c, 0xb960572c, 0xb960572c, + 0xb960572c, 0x39bcbf0b, 0x39bcbf0b, 0x39bcbf0b, 0x39bcbf0b, 0x39bcbf0b, 0x39e9a9ad, 0x39e9a9ad, + 0x39e9a9ad, 0x39e9a9ad, 0x39e9a9ad, 0xb9e96bb1, 0xb9e96bb1, 0xb9e96bb1, 0xb9e96bb1, 0xb9e96bb1, + 0xb9bc810f, 0xb9bc810f, 0xb9bc810f, 0xb9bc810f, 0xb9bc810f, 0xb98f966e, 0xb98f966e, 0xb98f966e, + 0xb98f966e, 0xb98f966e, 0xb9455799, 0xb9455799, 0xb9455799, 0xb9455799, 0xb9455799, 0xb8d704ab, + 0xb8d704ab, 0xb8d704ab, 0xb8d704ab, 0xb8d704ab, 0xb78d6891, 0xb78d6891, 0xb78d6891, 0xb78d6891, + 0xb78d6891, 0x38905062, 0x38905062, 0x38905062, 0x38905062, 0x38905062, 0x3921fd74, 0x3921fd74, +] )) ), + +################ chunk 23040 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0xc630b6ef, 0xc630b6ef, 0xc630b6ef, 0xc6359f92, 0xc6359f92, 0xc6359f92, 0xc6359f92, 0xc6359f92, + 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63f70d8, 0xc63f70d8, 0xc63f70d8, + 0xc63f70d8, 0xc63f70d8, 0xc644597c, 0xc644597c, 0xc644597c, 0xc644597c, 0xc644597c, 0xc649421f, + 0xc649421f, 0xc649421f, 0xc649421f, 0xc649421f, 0xc64e2ac2, 0xc64e2ac2, 0xc64e2ac2, 0xc64e2ac2, + 0xc64e2ac2, 0xc6531365, 0xc6531365, 0xc6531365, 0xc6531365, 0xc6531365, 0xc657fc08, 0xc657fc08, + 0xc657fc08, 0xc657fc08, 0xc657fc08, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, + 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc666b5f1, 0xc666b5f1, 0xc666b5f1, + 0xc666b5f1, 0xc666b5f1, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc6708737, + 0xc6708737, 0xc6708737, 0xc6708737, 0xc6708737, 0xc6756fda, 0xc6756fda, 0xc6756fda, 0xc6756fda, + 0xc6756fda, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67f4121, 0xc67f4121, + 0xc67f4121, 0xc67f4121, 0xc67f4121, 0xc68214e2, 0xc68214e2, 0xc68214e2, 0xc68214e2, 0xc68214e2, + 0xc6848933, 0xc6848933, 0xc6848933, 0xc6848933, 0xc6848933, 0xc686fd85, 0xc686fd85, 0xc686fd85, + 0xc686fd85, 0xc686fd85, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68be628, + 0xc68be628, 0xc68be628, 0xc68be628, 0xc68be628, 0xc68e5a7a, 0xc68e5a7a, 0xc68e5a7a, 0xc68e5a7a, + 0xc68e5a7a, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc693431d, 0xc693431d, + 0xc693431d, 0xc693431d, 0xc693431d, 0xc695b76e, 0xc695b76e, 0xc695b76e, 0xc695b76e, 0xc695b76e, + 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc69aa011, 0xc69aa011, 0xc69aa011, + 0xc69aa011, 0xc69aa011, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69f88b4, + 0xc69f88b4, 0xc69f88b4, 0xc69f88b4, 0xc69f88b4, 0xc6a1fd06, 0xc6a1fd06, 0xc6a1fd06, 0xc6a1fd06, + 0xc6a1fd06, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a6e5a9, 0xc6a6e5a9, + 0xc6a6e5a9, 0xc6a6e5a9, 0xc6a6e5a9, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, + 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6ae429e, 0xc6ae429e, 0xc6ae429e, + 0xc6ae429e, 0xc6ae429e, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b32b41, + 0xc6b32b41, 0xc6b32b41, 0xc6b32b41, 0xc6b32b41, 0xc6b59f92, 0xc6b59f92, 0xc6b59f92, 0xc6b59f92, + 0xc6b59f92, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6ba8835, 0xc6ba8835, + 0xc6ba8835, 0xc6ba8835, 0xc6ba8835, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, + 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6c1e52a, 0xc6c1e52a, 0xc6c1e52a, + 0xc6c1e52a, 0xc6c1e52a, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c6cdcd, + 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c9421f, 0xc6c9421f, 0xc6c9421f, 0xc6c9421f, + 0xc6c9421f, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6ce2ac2, 0xc6ce2ac2, + 0xc6ce2ac2, 0xc6ce2ac2, 0xc6ce2ac2, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, + 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d587b6, 0xc6d587b6, 0xc6d587b6, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3921fd74, 0x3921fd74, 0x3921fd74, 0x397bd2b7, 0x397bd2b7, 0x397bd2b7, 0x397bd2b7, 0x397bd2b7, + 0x39aad3fd, 0x39aad3fd, 0x39aad3fd, 0x39aad3fd, 0x39aad3fd, 0x39d7be9f, 0x39d7be9f, 0x39d7be9f, + 0x39d7be9f, 0x39d7be9f, 0xb9fb56bf, 0xb9fb56bf, 0xb9fb56bf, 0xb9fb56bf, 0xb9fb56bf, 0xb9ce6c1d, + 0xb9ce6c1d, 0xb9ce6c1d, 0xb9ce6c1d, 0xb9ce6c1d, 0xb9a1817c, 0xb9a1817c, 0xb9a1817c, 0xb9a1817c, + 0xb9a1817c, 0xb9692db5, 0xb9692db5, 0xb9692db5, 0xb9692db5, 0xb9692db5, 0xb90f5872, 0xb90f5872, + 0xb90f5872, 0xb90f5872, 0xb90f5872, 0xb8560cbb, 0xb8560cbb, 0xb8560cbb, 0xb8560cbb, 0xb8560cbb, + 0x38114852, 0x38114852, 0x38114852, 0x38114852, 0x38114852, 0x38fc4eb0, 0x38fc4eb0, 0x38fc4eb0, + 0x38fc4eb0, 0x38fc4eb0, 0x3957fc9b, 0x3957fc9b, 0x3957fc9b, 0x3957fc9b, 0x3957fc9b, 0x3998e8ef, + 0x3998e8ef, 0x3998e8ef, 0x3998e8ef, 0x3998e8ef, 0x39c5d390, 0x39c5d390, 0x39c5d390, 0x39c5d390, + 0x39c5d390, 0x39f2be32, 0x39f2be32, 0x39f2be32, 0x39f2be32, 0x39f2be32, 0xb9e0572c, 0xb9e0572c, + 0xb9e0572c, 0xb9e0572c, 0xb9e0572c, 0xb9b36c8a, 0xb9b36c8a, 0xb9b36c8a, 0xb9b36c8a, 0xb9b36c8a, + 0x3a3cbf0b, 0x3a3cbf0b, 0x3a3cbf0b, 0x3a3cbf0b, 0x3a3cbf0b, 0xb9332e8e, 0xb9332e8e, 0xb9332e8e, + 0xb9332e8e, 0xb9332e8e, 0x3a69a9ab, 0x3a69a9ab, 0x3a69a9ab, 0x3a69a9ab, 0x3a69a9ab, 0x34f7f042, + 0x34f7f042, 0x34f7f042, 0x34f7f042, 0x34f7f042, 0xba696baf, 0xba696baf, 0xba696baf, 0xba696baf, + 0xba696baf, 0x3934267f, 0x3934267f, 0x3934267f, 0x3934267f, 0x3934267f, 0xba3c810e, 0xba3c810e, + 0xba3c810e, 0xba3c810e, 0xba3c810e, 0x39b3e882, 0x39b3e882, 0x39b3e882, 0x39b3e882, 0x39b3e882, + 0xba0f966d, 0xba0f966d, 0xba0f966d, 0xba0f966d, 0xba0f966d, 0x3a06dee2, 0x3a06dee2, 0x3a06dee2, + 0x3a06dee2, 0x3a06dee2, 0xb9c55798, 0xb9c55798, 0xb9c55798, 0xb9c55798, 0xb9c55798, 0x3a33c984, + 0x3a33c984, 0x3a33c984, 0x3a33c984, 0x3a33c984, 0xb95704ab, 0xb95704ab, 0xb95704ab, 0xb95704ab, + 0xb95704ab, 0x3a60b424, 0x3a60b424, 0x3a60b424, 0x3a60b424, 0x3a60b424, 0xb80d6891, 0xb80d6891, + 0xb80d6891, 0xb80d6891, 0xb80d6891, 0xba726136, 0xba726136, 0xba726136, 0xba726136, 0xba726136, + 0x39105062, 0x39105062, 0x39105062, 0x39105062, 0x39105062, 0xba457695, 0xba457695, 0xba457695, + 0xba457695, 0xba457695, 0x39a1fd74, 0x39a1fd74, 0x39a1fd74, 0x39a1fd74, 0x39a1fd74, 0xba188bf4, + 0xba188bf4, 0xba188bf4, 0xba188bf4, 0xba188bf4, 0x39fbd2b7, 0x39fbd2b7, 0x39fbd2b7, 0x39fbd2b7, + 0x39fbd2b7, 0xb9d742a6, 0xb9d742a6, 0xb9d742a6, 0xb9d742a6, 0xb9d742a6, 0x3a2ad3fd, 0x3a2ad3fd, + 0x3a2ad3fd, 0x3a2ad3fd, 0x3a2ad3fd, 0xb97adac7, 0xb97adac7, 0xb97adac7, 0xb97adac7, 0xb97adac7, + 0x3a57be9d, 0x3a57be9d, 0x3a57be9d, 0x3a57be9d, 0x3a57be9d, 0xb88e6082, 0xb88e6082, 0xb88e6082, + 0xb88e6082, 0xb88e6082, 0xba7b56bd, 0xba7b56bd, 0xba7b56bd, 0xba7b56bd, 0xba7b56bd, 0x38d8f48b, + 0x38d8f48b, 0x38d8f48b, 0x38d8f48b, 0x38d8f48b, 0xba4e6c1c, 0xba4e6c1c, 0xba4e6c1c, 0xba4e6c1c, + 0xba4e6c1c, 0x39901266, 0x39901266, 0x39901266, 0x39901266, 0x39901266, 0xba21817b, 0xba21817b, + 0xba21817b, 0xba21817b, 0xba21817b, 0x39e9e7a9, 0x39e9e7a9, 0x39e9e7a9, 0x39e9e7a9, 0x39e9e7a9, + 0xb9e92db5, 0xb9e92db5, 0xb9e92db5, 0xb9e92db5, 0xb9e92db5, 0x3a21de76, 0x3a21de76, 0x3a21de76, +] )) ), + +################ chunk 23552 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0xc6d587b6, 0xc6d587b6, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6da7059, + 0xc6da7059, 0xc6da7059, 0xc6da7059, 0xc6da7059, 0xc6dce4ab, 0xc6dce4ab, 0xc6dce4ab, 0xc6dce4ab, + 0xc6dce4ab, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6e1cd4e, 0xc6e1cd4e, + 0xc6e1cd4e, 0xc6e1cd4e, 0xc6e1cd4e, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, + 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e92a43, 0xc6e92a43, 0xc6e92a43, + 0xc6e92a43, 0xc6e92a43, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6ee12e6, + 0xc6ee12e6, 0xc6ee12e6, 0xc6ee12e6, 0xc6ee12e6, 0xc6f08737, 0xc6f08737, 0xc6f08737, 0xc6f08737, + 0xc6f08737, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f56fda, 0xc6f56fda, + 0xc6f56fda, 0xc6f56fda, 0xc6f56fda, 0xc6f7e42c, 0x59800000, 0x59800000, 0x59800000, 0x5a000000, + 0x5a000000, 0x59329431, 0x591a8435, 0x58a0c708, 0x40c90fdb, 0x41490fdb, 0x41c90fdb, 0x493fbf56, + 0x4aefaf3a, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x441d1463, 0x441d1463, + 0x441d1463, 0x441d1463, 0x441d1463, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, + 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x44c4597c, 0x44c4597c, 0x44c4597c, + 0x44c4597c, 0x44c4597c, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x450971d6, + 0x450971d6, 0x450971d6, 0x450971d6, 0x450971d6, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, + 0x451d1463, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4544597c, 0x4544597c, + 0x4544597c, 0x4544597c, 0x4544597c, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, + 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x457f4121, 0x457f4121, 0x457f4121, + 0x457f4121, 0x457f4121, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x4593431d, + 0x4593431d, 0x4593431d, 0x4593431d, 0x4593431d, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, + 0x459d1463, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45b0b6ef, 0x45b0b6ef, + 0x45b0b6ef, 0x45b0b6ef, 0x45b0b6ef, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, + 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, + 0x45ce2ac2, 0x45ce2ac2, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45e1cd4e, + 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, + 0x45eb9e94, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45ff4121, 0x45ff4121, + 0x45ff4121, 0x45ff4121, 0x45ff4121, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x46048933, + 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, + 0x460e5a7a, 0x460e5a7a, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x46182bc0, + 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, + 0x461d1463, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4626e5a9, 0x4626e5a9, + 0x4626e5a9, 0x4626e5a9, 0x4626e5a9, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3a21de76, 0x3a21de76, 0xb98f5872, 0xb98f5872, 0xb98f5872, 0xb98f5872, 0xb98f5872, 0x3a4ec916, + 0x3a4ec916, 0x3a4ec916, 0x3a4ec916, 0x3a4ec916, 0xb8d60cbb, 0xb8d60cbb, 0xb8d60cbb, 0xb8d60cbb, + 0xb8d60cbb, 0x3a7bb3b7, 0x3a7bb3b7, 0x3a7bb3b7, 0x3a7bb3b7, 0x3a7bb3b7, 0x38914852, 0x38914852, + 0x38914852, 0x38914852, 0x38914852, 0xba5761a3, 0xba5761a3, 0xba5761a3, 0xba5761a3, 0xba5761a3, + 0x397c4eaf, 0x397c4eaf, 0x397c4eaf, 0x397c4eaf, 0x397c4eaf, 0xba2a7702, 0xba2a7702, 0xba2a7702, + 0xba2a7702, 0xba2a7702, 0x39d7fc9b, 0x39d7fc9b, 0x39d7fc9b, 0x39d7fc9b, 0x39d7fc9b, 0xb9fb18c3, + 0xb9fb18c3, 0xb9fb18c3, 0xb9fb18c3, 0xb9fb18c3, 0x3a18e8ef, 0x3a18e8ef, 0x3a18e8ef, 0x3a18e8ef, + 0x3a18e8ef, 0xb9a14380, 0xb9a14380, 0xb9a14380, 0xb9a14380, 0xb9a14380, 0x3a45d390, 0x3a45d390, + 0x3a45d390, 0x3a45d390, 0x3a45d390, 0xb90edc7a, 0x3f5fccb5, 0x3f5fccb5, 0x3f5fccb5, 0xbf595336, + 0xbf595336, 0xbf748f96, 0xbf0f1011, 0xbf6535eb, 0x343bbd2e, 0x34bbbd2e, 0x353bbd2e, 0xbf358fbb, + 0xbf17a45b, 0x36c55799, 0x36c55799, 0x36c55799, 0x36c55799, 0x36c55799, 0x37455799, 0x37455799, + 0x37455799, 0x37455799, 0x37455799, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, + 0x37c55799, 0x37c55799, 0x37c55799, 0x37c55799, 0x37c55799, 0x387b56bf, 0x387b56bf, 0x387b56bf, + 0x387b56bf, 0x387b56bf, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb8e9a9ad, + 0xb8e9a9ad, 0xb8e9a9ad, 0xb8e9a9ad, 0xb8e9a9ad, 0x38455799, 0x38455799, 0x38455799, 0x38455799, + 0x38455799, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0x38fb56bf, 0x38fb56bf, + 0x38fb56bf, 0x38fb56bf, 0x38fb56bf, 0x380f5872, 0x380f5872, 0x380f5872, 0x380f5872, 0x380f5872, + 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0x38e0572c, 0x38e0572c, 0x38e0572c, + 0x38e0572c, 0x38e0572c, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0x393c810f, + 0x393c810f, 0x393c810f, 0x393c810f, 0x393c810f, 0x38c55799, 0x38c55799, 0x38c55799, 0x38c55799, + 0x38c55799, 0x370d6891, 0x370d6891, 0x370d6891, 0x370d6891, 0x370d6891, 0xb8a1fd74, 0xb8a1fd74, + 0xb8a1fd74, 0xb8a1fd74, 0xb8a1fd74, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, + 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x3921817c, 0x3921817c, 0x3921817c, + 0x3921817c, 0x3921817c, 0x388f5872, 0x388f5872, 0x388f5872, 0x388f5872, 0x388f5872, 0xb7914852, + 0xb7914852, 0xb7914852, 0xb7914852, 0xb7914852, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, + 0xb8d7fc9b, 0xb945d391, 0xb945d391, 0xb945d391, 0xb945d391, 0xb945d391, 0x3960572c, 0x3960572c, + 0x3960572c, 0x3960572c, 0x3960572c, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, + 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0x39e96bb1, 0x39e96bb1, 0x39e96bb1, + 0x39e96bb1, 0x39e96bb1, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x398f966e, + 0x398f966e, 0x398f966e, 0x398f966e, 0x398f966e, 0x39455799, 0x39455799, 0x39455799, 0x39455799, + 0x39455799, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x378d6891, 0x378d6891, + 0x378d6891, 0x378d6891, 0x378d6891, 0xb8905062, 0xb8905062, 0xb8905062, 0xb8905062, 0xb8905062, +] )) ), +] +cos_float64_t = [ + +################ chunk 0 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5434d, 0x4073a28c59d54329, 0x4083a28c59d5433b, 0x4083a28c59d5433b, 0x4083a28c59d5433b, + 0x4083a28c59d54344, 0x4083a28c59d54332, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4e1, 0x408d73d286bfe4d0, 0x4093a28c59d5433b, + 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433f, 0x4093a28c59d54337, 0x40988b2f704a940a, 0x40988b2f704a940a, 0x40988b2f704a940a, 0x40988b2f704a940e, + 0x40988b2f704a9405, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4dd, 0x409d73d286bfe4d4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, + 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad6, 0x40a12e3ace9a9ad1, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433d, 0x40a3a28c59d54339, + 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba5, 0x40a616dde50feba0, 0x40a88b2f704a940a, 0x40a88b2f704a940a, 0x40a88b2f704a940a, + 0x40a88b2f704a940c, 0x40a88b2f704a9408, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c73, 0x40aaff80fb853c6f, 0x40ad73d286bfe4d8, + 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4db, 0x40ad73d286bfe4d6, 0x40afe82411fa8d40, 0x40afe82411fa8d40, 0x40afe82411fa8d40, 0x40afe82411fa8d42, + 0x40afe82411fa8d3e, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad5, 0x40b12e3ace9a9ad2, 0x40b268639437ef07, 0x40b268639437ef07, + 0x40b268639437ef07, 0x40b268639437ef08, 0x40b268639437ef06, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433c, 0x40b3a28c59d5433a, + 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f729770, 0x40b4dcb51f72976e, 0x40b616dde50feba2, 0x40b616dde50feba2, 0x40b616dde50feba2, + 0x40b616dde50feba3, 0x40b616dde50feba1, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd7, 0x40b75106aaad3fd5, 0x40b88b2f704a940a, + 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940b, 0x40b88b2f704a9409, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, 0x40b9c55835e7e83e, + 0x40b9c55835e7e83c, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c72, 0x40baff80fb853c70, 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, + 0x40bc39a9c12290a5, 0x40bc39a9c12290a6, 0x40bc39a9c12290a4, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4da, 0x40bd73d286bfe4d7, + 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390d, 0x40beadfb4c5d390b, 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, + 0x40bfe82411fa8d41, 0x40bfe82411fa8d3f, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0b9, 0x40c12e3ace9a9ad4, + 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad3, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, 0x40c1cb4f316944ee, + 0x40c1cb4f316944ed, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef08, 0x40c268639437ef07, 0x40c30577f7069921, 0x40c30577f7069921, + 0x40c30577f7069921, 0x40c30577f7069922, 0x40c30577f7069921, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433c, 0x40c3a28c59d5433a, + 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed54, 0x40c4dcb51f72976f, 0x40c4dcb51f72976f, 0x40c4dcb51f72976f, + 0x40c4dcb51f72976f, 0x40c4dcb51f72976e, 0x40c579c982414188, 0x40c579c982414188, 0x40c579c982414188, 0x40c579c982414189, 0x40c579c982414188, 0x40c616dde50feba2, + 0x40c616dde50feba2, 0x40c616dde50feba2, 0x40c616dde50feba3, 0x40c616dde50feba2, 0x40c6b3f247de95bc, 0x40c6b3f247de95bc, 0x40c6b3f247de95bc, 0x40c6b3f247de95bd, + 0x40c6b3f247de95bc, 0x40c75106aaad3fd6, 0x40c75106aaad3fd6, 0x40c75106aaad3fd6, 0x40c75106aaad3fd7, 0x40c75106aaad3fd5, 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9f0, + 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9ef, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a9409, + 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e23, 0x40c9c55835e7e83d, 0x40c9c55835e7e83d, 0x40c9c55835e7e83d, + 0x40c9c55835e7e83e, 0x40c9c55835e7e83d, 0x40ca626c98b69257, 0x40ca626c98b69257, 0x40ca626c98b69257, 0x40ca626c98b69258, 0x40ca626c98b69257, 0x40caff80fb853c71, + 0x40caff80fb853c71, 0x40caff80fb853c71, 0x40caff80fb853c72, 0x40caff80fb853c71, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, + 0x40cb9c955e53e68a, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a4, 0x40ccd6be23f13abf, 0x40ccd6be23f13abf, + 0x40ccd6be23f13abf, 0x40ccd6be23f13abf, 0x40ccd6be23f13abe, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d9, 0x40cd73d286bfe4d8, + 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef3, 0x40ce10e6e98e8ef2, 0x40ceadfb4c5d390c, 0x40ceadfb4c5d390c, 0x40ceadfb4c5d390c, + 0x40ceadfb4c5d390d, 0x40ceadfb4c5d390c, 0x40cf4b0faf2be326, 0x40cf4b0faf2be326, 0x40cf4b0faf2be326, 0x40cf4b0faf2be327, 0x40cf4b0faf2be325, 0x40cfe82411fa8d40, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 512 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40cfe82411fa8d40, 0x40cfe82411fa8d40, 0x40cfe82411fa8d40, 0x40cfe82411fa8d3f, 0x40d0429c3a649bad, 0x40d0429c3a649bad, 0x40d0429c3a649bad, 0x40d0429c3a649bad, + 0x40d0429c3a649bad, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0b9, 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c7, + 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c6, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad3, + 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe0, 0x40d1cb4f316944ed, 0x40d1cb4f316944ed, 0x40d1cb4f316944ed, + 0x40d1cb4f316944ee, 0x40d1cb4f316944ed, 0x40d219d962d099fa, 0x40d219d962d099fa, 0x40d219d962d099fa, 0x40d219d962d099fb, 0x40d219d962d099fa, 0x40d268639437ef07, + 0x40d268639437ef07, 0x40d268639437ef07, 0x40d268639437ef08, 0x40d268639437ef07, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, + 0x40d2b6edc59f4414, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d35402286dee2e, 0x40d35402286dee2e, + 0x40d35402286dee2e, 0x40d35402286dee2e, 0x40d35402286dee2e, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, + 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, + 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4261, 0x40d4dcb51f72976f, + 0x40d4dcb51f72976f, 0x40d4dcb51f72976f, 0x40d4dcb51f72976f, 0x40d4dcb51f72976e, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, + 0x40d52b3f50d9ec7b, 0x40d579c982414188, 0x40d579c982414188, 0x40d579c982414188, 0x40d579c982414189, 0x40d579c982414188, 0x40d5c853b3a89695, 0x40d5c853b3a89695, + 0x40d5c853b3a89695, 0x40d5c853b3a89696, 0x40d5c853b3a89695, 0x40d616dde50feba2, 0x40d616dde50feba2, 0x40d616dde50feba2, 0x40d616dde50feba3, 0x40d616dde50feba2, + 0x40d66568167740af, 0x40d66568167740af, 0x40d66568167740af, 0x40d66568167740b0, 0x40d66568167740af, 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, + 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d75106aaad3fd6, + 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, + 0x40d79f90dc1494e3, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, + 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a9409, + 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e916, 0x40d92843d3193e24, 0x40d92843d3193e24, 0x40d92843d3193e24, + 0x40d92843d3193e24, 0x40d92843d3193e23, 0x40d976ce04809330, 0x40d976ce04809330, 0x40d976ce04809330, 0x40d976ce04809331, 0x40d976ce04809330, 0x40d9c55835e7e83d, + 0x40d9c55835e7e83d, 0x40d9c55835e7e83d, 0x40d9c55835e7e83e, 0x40d9c55835e7e83d, 0x40da13e2674f3d4a, 0x40da13e2674f3d4a, 0x40da13e2674f3d4a, 0x40da13e2674f3d4b, + 0x40da13e2674f3d4a, 0x40da626c98b69257, 0x40da626c98b69257, 0x40da626c98b69257, 0x40da626c98b69258, 0x40da626c98b69257, 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, + 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, + 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db9c955e53e68b, 0x40db9c955e53e68b, 0x40db9c955e53e68b, + 0x40db9c955e53e68b, 0x40db9c955e53e68b, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dc39a9c12290a5, + 0x40dc39a9c12290a5, 0x40dc39a9c12290a5, 0x40dc39a9c12290a5, 0x40dc39a9c12290a4, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, + 0x40dc8833f289e5b1, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abe, 0x40dd254855588fcc, 0x40dd254855588fcc, + 0x40dd254855588fcc, 0x40dd254855588fcc, 0x40dd254855588fcb, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d9, 0x40dd73d286bfe4d8, + 0x40ddc25cb82739e5, 0x40ddc25cb82739e5, 0x40ddc25cb82739e5, 0x40ddc25cb82739e6, 0x40ddc25cb82739e5, 0x40de10e6e98e8ef2, 0x40de10e6e98e8ef2, 0x40de10e6e98e8ef2, + 0x40de10e6e98e8ef3, 0x40de10e6e98e8ef2, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40deadfb4c5d390c, + 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40defc857dc48e19, 0x40defc857dc48e19, 0x40defc857dc48e19, 0x40defc857dc48e19, + 0x40defc857dc48e19, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df9999e0933833, 0x40df9999e0933833, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 1024 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40df9999e0933833, 0x40df9999e0933833, 0x40df9999e0933833, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, + 0x40e01b5721b0f126, 0x40e01b5721b0f126, 0x40e01b5721b0f126, 0x40e01b5721b0f127, 0x40e01b5721b0f126, 0x40e0429c3a649bad, 0x40e0429c3a649bad, 0x40e0429c3a649bad, + 0x40e0429c3a649bad, 0x40e0429c3a649bad, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e091266bcbf0ba, + 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, + 0x40e0b86b847f9b40, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, + 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad3, + 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e17cc50001efe1, 0x40e17cc50001efe1, 0x40e17cc50001efe1, + 0x40e17cc50001efe1, 0x40e17cc50001efe0, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1cb4f316944ed, + 0x40e1cb4f316944ed, 0x40e1cb4f316944ed, 0x40e1cb4f316944ee, 0x40e1cb4f316944ed, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, + 0x40e1f2944a1cef74, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e2411e7b844481, 0x40e2411e7b844481, + 0x40e2411e7b844481, 0x40e2411e7b844481, 0x40e2411e7b844481, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, + 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, + 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e30577f7069921, + 0x40e30577f7069921, 0x40e30577f7069921, 0x40e30577f7069921, 0x40e30577f7069921, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, + 0x40e32cbd0fba43a7, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e37b47412198b5, 0x40e37b47412198b5, + 0x40e37b47412198b5, 0x40e37b47412198b5, 0x40e37b47412198b4, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, + 0x40e3c9d17288edc1, 0x40e3c9d17288edc1, 0x40e3c9d17288edc1, 0x40e3c9d17288edc2, 0x40e3c9d17288edc1, 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, + 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e43fa0bca3ed55, + 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e466e5d55797db, 0x40e466e5d55797db, 0x40e466e5d55797db, 0x40e466e5d55797db, + 0x40e466e5d55797db, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e4b57006beece8, 0x40e4b57006beece8, + 0x40e4b57006beece8, 0x40e4b57006beece8, 0x40e4b57006beece8, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, + 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7c, + 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7b, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e579c982414188, + 0x40e579c982414188, 0x40e579c982414188, 0x40e579c982414189, 0x40e579c982414188, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, + 0x40e5a10e9af4ec0f, 0x40e5c853b3a89695, 0x40e5c853b3a89695, 0x40e5c853b3a89695, 0x40e5c853b3a89696, 0x40e5c853b3a89695, 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, + 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, + 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e66568167740af, 0x40e66568167740af, 0x40e66568167740af, + 0x40e66568167740af, 0x40e66568167740af, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e6b3f247de95bc, + 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6db3760924043, 0x40e6db3760924043, 0x40e6db3760924043, 0x40e6db3760924043, + 0x40e6db3760924043, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e729c191f99550, 0x40e729c191f99550, + 0x40e729c191f99550, 0x40e729c191f99550, 0x40e729c191f9954f, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, + 0x40e7784bc360ea5c, 0x40e7784bc360ea5c, 0x40e7784bc360ea5c, 0x40e7784bc360ea5d, 0x40e7784bc360ea5c, 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 1536 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f6a, 0x40e7c6d5f4c83f69, 0x40e7ee1b0d7be9f0, + 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e81560262f9476, 0x40e81560262f9476, 0x40e81560262f9476, 0x40e81560262f9476, + 0x40e81560262f9476, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e863ea5796e983, 0x40e863ea5796e983, + 0x40e863ea5796e983, 0x40e863ea5796e983, 0x40e863ea5796e983, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, + 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e917, + 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e916, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e92843d3193e24, + 0x40e92843d3193e24, 0x40e92843d3193e24, 0x40e92843d3193e24, 0x40e92843d3193e23, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, + 0x40e94f88ebcce8aa, 0x40e976ce04809330, 0x40e976ce04809330, 0x40e976ce04809330, 0x40e976ce04809331, 0x40e976ce04809330, 0x40e99e131d343db7, 0x40e99e131d343db7, + 0x40e99e131d343db7, 0x40e99e131d343db7, 0x40e99e131d343db7, 0x40e9c55835e7e83d, 0x40e9c55835e7e83d, 0x40e9c55835e7e83d, 0x40e9c55835e7e83e, 0x40e9c55835e7e83d, + 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, + 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea626c98b69257, + 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, + 0x40ea89b1b16a3cde, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40ead83be2d191eb, 0x40ead83be2d191eb, + 0x40ead83be2d191eb, 0x40ead83be2d191eb, 0x40ead83be2d191ea, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, + 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f7, 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, + 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, 0x40eb755045a03c04, 0x40eb755045a03c04, 0x40eb755045a03c04, 0x40eb755045a03c05, 0x40eb755045a03c04, 0x40eb9c955e53e68b, + 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40ebc3da77079111, 0x40ebc3da77079111, 0x40ebc3da77079111, 0x40ebc3da77079112, + 0x40ebc3da77079111, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, + 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, + 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, + 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecd6be23f13abf, + 0x40ecd6be23f13abf, 0x40ecd6be23f13abf, 0x40ecd6be23f13abf, 0x40ecd6be23f13abe, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, + 0x40ecfe033ca4e545, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcb, 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, + 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d9, 0x40ed73d286bfe4d8, + 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40edc25cb82739e5, 0x40edc25cb82739e5, 0x40edc25cb82739e5, + 0x40edc25cb82739e6, 0x40edc25cb82739e5, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ee10e6e98e8ef2, + 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee382c02423979, 0x40ee382c02423979, 0x40ee382c02423979, 0x40ee382c02423979, + 0x40ee382c02423979, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee86b633a98e86, 0x40ee86b633a98e86, + 0x40ee86b633a98e86, 0x40ee86b633a98e86, 0x40ee86b633a98e86, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, + 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e392, 0x40eefc857dc48e19, 0x40eefc857dc48e19, 0x40eefc857dc48e19, + 0x40eefc857dc48e19, 0x40eefc857dc48e19, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca9678389f, 0x40ef4b0faf2be326, + 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef7254c7df8dac, 0x40ef7254c7df8dac, 0x40ef7254c7df8dac, 0x40ef7254c7df8dad, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 2048 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40ef7254c7df8dac, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40efc0def946e2b9, 0x40efc0def946e2b9, + 0x40efc0def946e2b9, 0x40efc0def946e2b9, 0x40efc0def946e2b9, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, + 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f01b5721b0f126, 0x40f01b5721b0f126, 0x40f01b5721b0f126, + 0x40f01b5721b0f126, 0x40f01b5721b0f126, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f0429c3a649bad, + 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, + 0x40f0563ec6be70f0, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f07d83df721b77, 0x40f07d83df721b77, + 0x40f07d83df721b77, 0x40f07d83df721b77, 0x40f07d83df721b76, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, + 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, + 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, 0x40f0cc0e10d97083, 0x40f0cc0e10d97083, 0x40f0cc0e10d97083, 0x40f0cc0e10d97084, 0x40f0cc0e10d97083, 0x40f0dfb09d3345c7, + 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, + 0x40f0f353298d1b0a, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f11a984240c590, 0x40f11a984240c590, + 0x40f11a984240c590, 0x40f11a984240c590, 0x40f11a984240c590, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, + 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f1557fe74e455a, 0x40f1557fe74e455a, 0x40f1557fe74e455a, + 0x40f1557fe74e455a, 0x40f1557fe74e455a, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f17cc50001efe1, + 0x40f17cc50001efe1, 0x40f17cc50001efe1, 0x40f17cc50001efe1, 0x40f17cc50001efe0, 0x40f190678c5bc524, 0x40f190678c5bc524, 0x40f190678c5bc524, 0x40f190678c5bc524, + 0x40f190678c5bc524, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, + 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, 0x40f1cb4f316944ed, 0x40f1cb4f316944ed, 0x40f1cb4f316944ed, 0x40f1cb4f316944ee, 0x40f1cb4f316944ed, + 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, + 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f219d962d099fa, + 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, + 0x40f22d7bef2a6f3e, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f254c107de19c4, 0x40f254c107de19c4, + 0x40f254c107de19c4, 0x40f254c107de19c4, 0x40f254c107de19c4, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, + 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44a, 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, + 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2b6edc59f4414, + 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2ca9051f91957, 0x40f2ca9051f91957, 0x40f2ca9051f91957, 0x40f2ca9051f91958, + 0x40f2ca9051f91957, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, + 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, + 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, + 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f35402286dee2e, + 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, + 0x40f367a4b4c7c371, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b4, 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, + 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 2560 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, + 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3f1168b3c9848, + 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f404b917966d8b, 0x40f404b917966d8b, 0x40f404b917966d8b, 0x40f404b917966d8b, + 0x40f404b917966d8b, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f42bfe304a1812, 0x40f42bfe304a1812, + 0x40f42bfe304a1812, 0x40f42bfe304a1812, 0x40f42bfe304a1812, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, + 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f466e5d55797db, 0x40f466e5d55797db, 0x40f466e5d55797db, + 0x40f466e5d55797db, 0x40f466e5d55797db, 0x40f47a8861b16d1e, 0x40f47a8861b16d1e, 0x40f47a8861b16d1e, 0x40f47a8861b16d1f, 0x40f47a8861b16d1e, 0x40f48e2aee0b4262, + 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, + 0x40f4a1cd7a6517a5, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4c9129318c22b, 0x40f4c9129318c22b, + 0x40f4c9129318c22b, 0x40f4c9129318c22b, 0x40f4c9129318c22b, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, + 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f503fa382641f5, 0x40f503fa382641f5, 0x40f503fa382641f5, + 0x40f503fa382641f5, 0x40f503fa382641f5, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f52b3f50d9ec7c, + 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, + 0x40f53ee1dd33c1bf, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f56626f5e76c45, 0x40f56626f5e76c45, + 0x40f56626f5e76c45, 0x40f56626f5e76c45, 0x40f56626f5e76c45, 0x40f579c982414188, 0x40f579c982414188, 0x40f579c982414188, 0x40f579c982414189, 0x40f579c982414188, + 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, + 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5c853b3a89695, + 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, + 0x40f5dbf640026bd9, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f6033b58b6165f, 0x40f6033b58b6165f, + 0x40f6033b58b6165f, 0x40f6033b58b6165f, 0x40f6033b58b6165f, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, + 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e5, 0x40f63e22fdc39629, 0x40f63e22fdc39629, 0x40f63e22fdc39629, + 0x40f63e22fdc39629, 0x40f63e22fdc39629, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f66568167740af, + 0x40f66568167740af, 0x40f66568167740af, 0x40f66568167740af, 0x40f66568167740af, 0x40f6790aa2d115f2, 0x40f6790aa2d115f2, 0x40f6790aa2d115f2, 0x40f6790aa2d115f3, + 0x40f6790aa2d115f2, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, + 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, + 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6db3760924043, 0x40f6db3760924043, 0x40f6db3760924043, + 0x40f6db3760924043, 0x40f6db3760924043, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f7027c7945eac9, + 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7161f059fc00c, 0x40f7161f059fc00c, 0x40f7161f059fc00c, 0x40f7161f059fc00c, + 0x40f7161f059fc00c, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f9954f, 0x40f73d641e536a93, 0x40f73d641e536a93, + 0x40f73d641e536a93, 0x40f73d641e536a93, 0x40f73d641e536a93, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, + 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f7784bc360ea5c, 0x40f7784bc360ea5c, 0x40f7784bc360ea5c, + 0x40f7784bc360ea5d, 0x40f7784bc360ea5c, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f79f90dc1494e3, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 3072 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f7b333686e6a26, 0x40f7b333686e6a26, 0x40f7b333686e6a26, 0x40f7b333686e6a26, + 0x40f7b333686e6a26, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7da78812214ad, 0x40f7da78812214ad, + 0x40f7da78812214ad, 0x40f7da78812214ad, 0x40f7da78812214ad, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, + 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f81560262f9476, 0x40f81560262f9476, 0x40f81560262f9476, + 0x40f81560262f9476, 0x40f81560262f9476, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969b9, 0x40f83ca53ee33efd, + 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f85047cb3d1440, 0x40f85047cb3d1440, 0x40f85047cb3d1440, 0x40f85047cb3d1440, + 0x40f85047cb3d1440, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f8778ce3f0bec6, 0x40f8778ce3f0bec6, + 0x40f8778ce3f0bec6, 0x40f8778ce3f0bec7, 0x40f8778ce3f0bec6, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, + 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, + 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8d9b9a1b1e917, + 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, + 0x40f8ed5c2e0bbe5a, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f914a146bf68e0, 0x40f914a146bf68e0, + 0x40f914a146bf68e0, 0x40f914a146bf68e0, 0x40f914a146bf68e0, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e23, + 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, + 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f976ce04809330, + 0x40f976ce04809330, 0x40f976ce04809330, 0x40f976ce04809331, 0x40f976ce04809330, 0x40f98a7090da6874, 0x40f98a7090da6874, 0x40f98a7090da6874, 0x40f98a7090da6874, + 0x40f98a7090da6874, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, + 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, + 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, + 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa13e2674f3d4a, + 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, + 0x40fa2784f3a9128d, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, + 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, + 0x40fa760f2510679a, 0x40fa760f2510679a, 0x40fa760f2510679a, 0x40fa760f2510679b, 0x40fa760f2510679a, 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, + 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fab0f6ca1de764, + 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fac4995677bca7, 0x40fac4995677bca7, 0x40fac4995677bca7, 0x40fac4995677bca7, + 0x40fac4995677bca7, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40faebde6f2b672e, 0x40faebde6f2b672e, + 0x40faebde6f2b672e, 0x40faebde6f2b672e, 0x40faebde6f2b672e, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, + 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb26c61438e6f8, 0x40fb26c61438e6f8, 0x40fb26c61438e6f8, + 0x40fb26c61438e6f8, 0x40fb26c61438e6f7, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb4e0b2cec917e, + 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb61adb94666c1, 0x40fb61adb94666c1, 0x40fb61adb94666c1, 0x40fb61adb94666c1, + 0x40fb61adb94666c1, 0x40fb755045a03c04, 0x40fb755045a03c04, 0x40fb755045a03c04, 0x40fb755045a03c05, 0x40fb755045a03c04, 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 3584 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, + 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbc3da77079111, 0x40fbc3da77079111, 0x40fbc3da77079111, + 0x40fbc3da77079111, 0x40fbc3da77079111, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbeb1f8fbb3b98, + 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbfec21c1510db, 0x40fbfec21c1510db, 0x40fbfec21c1510db, 0x40fbfec21c1510db, + 0x40fbfec21c1510db, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc260734c8bb62, 0x40fc260734c8bb62, + 0x40fc260734c8bb62, 0x40fc260734c8bb62, 0x40fc260734c8bb61, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, + 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, + 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, 0x40fc74916630106e, 0x40fc74916630106e, 0x40fc74916630106e, 0x40fc74916630106f, 0x40fc74916630106e, 0x40fc8833f289e5b2, + 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, + 0x40fc9bd67ee3baf5, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcc31b9797657b, 0x40fcc31b9797657b, + 0x40fcc31b9797657b, 0x40fcc31b9797657b, 0x40fcc31b9797657b, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, + 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, + 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd254855588fcc, + 0x40fd254855588fcc, 0x40fd254855588fcc, 0x40fd254855588fcc, 0x40fd254855588fcb, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, + 0x40fd38eae1b2650f, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd602ffa660f95, 0x40fd602ffa660f95, + 0x40fd602ffa660f95, 0x40fd602ffa660f95, 0x40fd602ffa660f95, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d9, 0x40fd73d286bfe4d8, + 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, + 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdc25cb82739e5, + 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, + 0x40fdd5ff44810f29, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, + 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, + 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86435, 0x40fe382c02423979, 0x40fe382c02423979, 0x40fe382c02423979, + 0x40fe382c02423979, 0x40fe382c02423979, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe5f711af5e3ff, + 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe7313a74fb942, 0x40fe7313a74fb942, 0x40fe7313a74fb942, 0x40fe7313a74fb943, + 0x40fe7313a74fb942, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, + 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, + 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fed5406510e393, 0x40fed5406510e393, 0x40fed5406510e393, + 0x40fed5406510e393, 0x40fed5406510e393, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fefc857dc48e19, + 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40ff10280a1e635c, 0x40ff10280a1e635c, 0x40ff10280a1e635c, 0x40ff10280a1e635c, + 0x40ff10280a1e635c, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca9678389f, 0x40ff376d22d20de3, 0x40ff376d22d20de3, + 0x40ff376d22d20de3, 0x40ff376d22d20de3, 0x40ff376d22d20de3, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, + 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff7254c7df8dac, 0x40ff7254c7df8dac, 0x40ff7254c7df8dac, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 4096 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40ff7254c7df8dad, 0x40ff7254c7df8dac, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff9999e0933833, + 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, + 0x40ffad3c6ced0d76, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, + 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, + 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x410007b495571be3, 0x410007b495571be3, 0x410007b495571be3, + 0x410007b495571be3, 0x410007b495571be3, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001b5721b0f126, + 0x41001b5721b0f126, 0x41001b5721b0f126, 0x41001b5721b0f126, 0x41001b5721b0f126, 0x4100252867dddbc8, 0x4100252867dddbc8, 0x4100252867dddbc8, 0x4100252867dddbc8, + 0x4100252867dddbc8, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x410038caf437b10b, 0x410038caf437b10b, + 0x410038caf437b10b, 0x410038caf437b10b, 0x410038caf437b10b, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, + 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x4100563ec6be70f0, 0x4100563ec6be70f0, 0x4100563ec6be70f0, + 0x4100563ec6be70f0, 0x4100563ec6be70f0, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410069e153184633, + 0x410069e153184633, 0x410069e153184633, 0x410069e153184633, 0x410069e153184633, 0x410073b2994530d5, 0x410073b2994530d5, 0x410073b2994530d5, 0x410073b2994530d5, + 0x410073b2994530d5, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b76, 0x41008755259f0618, 0x41008755259f0618, + 0x41008755259f0618, 0x41008755259f0618, 0x41008755259f0618, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, + 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, + 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100b86b847f9b40, + 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, + 0x4100c23ccaac85e2, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100d5df57065b25, 0x4100d5df57065b25, + 0x4100d5df57065b25, 0x4100d5df57065b25, 0x4100d5df57065b25, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, + 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100f353298d1b0a, 0x4100f353298d1b0a, 0x4100f353298d1b0a, + 0x4100f353298d1b0a, 0x4100f353298d1b0a, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ab, 0x410106f5b5e6f04d, + 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410110c6fc13daef, 0x410110c6fc13daef, 0x410110c6fc13daef, 0x410110c6fc13daef, + 0x410110c6fc13daef, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41012469886db032, 0x41012469886db032, + 0x41012469886db032, 0x41012469886db032, 0x41012469886db032, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, + 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x410141dd5af47017, 0x410141dd5af47017, 0x410141dd5af47017, + 0x410141dd5af47017, 0x410141dd5af47017, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x4101557fe74e455a, + 0x4101557fe74e455a, 0x4101557fe74e455a, 0x4101557fe74e455a, 0x4101557fe74e455a, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, + 0x41015f512d7b2ffc, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x410172f3b9d5053f, 0x410172f3b9d5053f, + 0x410172f3b9d5053f, 0x410172f3b9d5053f, 0x410172f3b9d5053f, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe0, + 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x410190678c5bc524, 0x410190678c5bc524, 0x410190678c5bc524, + 0x410190678c5bc524, 0x410190678c5bc524, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x4101a40a18b59a67, + 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101addb5ee28509, 0x4101addb5ee28509, 0x4101addb5ee28509, 0x4101addb5ee28509, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 4608 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4101addb5ee28509, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, + 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, + 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101def1bdc31a31, 0x4101def1bdc31a31, 0x4101def1bdc31a31, + 0x4101def1bdc31a31, 0x4101def1bdc31a31, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101f2944a1cef74, + 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101fc659049da16, 0x4101fc659049da16, 0x4101fc659049da16, 0x4101fc659049da16, + 0x4101fc659049da15, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x410210081ca3af59, 0x410210081ca3af59, + 0x410210081ca3af59, 0x410210081ca3af59, 0x410210081ca3af59, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, + 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, + 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102411e7b844481, + 0x4102411e7b844481, 0x4102411e7b844481, 0x4102411e7b844481, 0x4102411e7b844481, 0x41024aefc1b12f22, 0x41024aefc1b12f22, 0x41024aefc1b12f22, 0x41024aefc1b12f22, + 0x41024aefc1b12f22, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x41025e924e0b0466, 0x41025e924e0b0466, + 0x41025e924e0b0466, 0x41025e924e0b0466, 0x41025e924e0b0466, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, + 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027c062091c44b, 0x41027c062091c44b, 0x41027c062091c44b, + 0x41027c062091c44b, 0x41027c062091c44a, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x41028fa8aceb998e, + 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41029979f318842f, 0x41029979f318842f, 0x41029979f318842f, 0x41029979f318842f, + 0x41029979f318842f, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102ad1c7f725973, 0x4102ad1c7f725973, + 0x4102ad1c7f725973, 0x4102ad1c7f725973, 0x4102ad1c7f725973, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, + 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102ca9051f91957, 0x4102ca9051f91957, 0x4102ca9051f91957, + 0x4102ca9051f91957, 0x4102ca9051f91957, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102de32de52ee9b, + 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102e804247fd93c, 0x4102e804247fd93c, 0x4102e804247fd93c, 0x4102e804247fd93c, + 0x4102e804247fd93c, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae80, + 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae7f, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, + 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x4103191a83606e64, 0x4103191a83606e64, 0x4103191a83606e64, + 0x4103191a83606e64, 0x4103191a83606e64, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x41032cbd0fba43a8, + 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x4103368e55e72e49, 0x4103368e55e72e49, 0x4103368e55e72e49, 0x4103368e55e72e49, + 0x4103368e55e72e49, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x41034a30e241038c, 0x41034a30e241038c, + 0x41034a30e241038c, 0x41034a30e241038c, 0x41034a30e241038c, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, + 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x410367a4b4c7c371, 0x410367a4b4c7c371, 0x410367a4b4c7c371, + 0x410367a4b4c7c371, 0x410367a4b4c7c371, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037b47412198b5, + 0x41037b47412198b5, 0x41037b47412198b5, 0x41037b47412198b5, 0x41037b47412198b4, 0x41038518874e8356, 0x41038518874e8356, 0x41038518874e8356, 0x41038518874e8356, + 0x41038518874e8356, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x410398bb13a85899, 0x410398bb13a85899, + 0x410398bb13a85899, 0x410398bb13a85899, 0x410398bb13a85899, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 5120 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103b62ee62f187e, 0x4103b62ee62f187e, 0x4103b62ee62f187e, + 0x4103b62ee62f187e, 0x4103b62ee62f187e, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c9d17288edc1, + 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, + 0x4103d3a2b8b5d863, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103e745450fada6, 0x4103e745450fada6, + 0x4103e745450fada6, 0x4103e745450fada6, 0x4103e745450fada6, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, + 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982e9, 0x410404b917966d8b, 0x410404b917966d8b, 0x410404b917966d8b, + 0x410404b917966d8b, 0x410404b917966d8b, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x4104185ba3f042ce, + 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104222cea1d2d70, 0x4104222cea1d2d70, 0x4104222cea1d2d70, 0x4104222cea1d2d70, + 0x4104222cea1d2d70, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x410435cf767702b3, 0x410435cf767702b3, + 0x410435cf767702b3, 0x410435cf767702b3, 0x410435cf767702b3, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, + 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104534348fdc298, 0x4104534348fdc298, 0x4104534348fdc298, + 0x4104534348fdc298, 0x4104534348fdc298, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x410466e5d55797db, + 0x410466e5d55797db, 0x410466e5d55797db, 0x410466e5d55797db, 0x410466e5d55797db, 0x410470b71b84827d, 0x410470b71b84827d, 0x410470b71b84827d, 0x410470b71b84827d, + 0x410470b71b84827d, 0x41047a8861b16d1e, 0x41047a8861b16d1e, 0x41047a8861b16d1e, 0x41047a8861b16d1f, 0x41047a8861b16d1e, 0x41048459a7de57c0, 0x41048459a7de57c0, + 0x41048459a7de57c0, 0x41048459a7de57c0, 0x41048459a7de57c0, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, + 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, + 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104b57006beece8, + 0x4104b57006beece8, 0x4104b57006beece8, 0x4104b57006beece8, 0x4104b57006beece8, 0x4104bf414cebd78a, 0x4104bf414cebd78a, 0x4104bf414cebd78a, 0x4104bf414cebd78a, + 0x4104bf414cebd78a, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104d2e3d945accd, 0x4104d2e3d945accd, + 0x4104d2e3d945accd, 0x4104d2e3d945accd, 0x4104d2e3d945accd, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, + 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, + 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, 0x4104fa28f1f95753, 0x4104fa28f1f95753, 0x4104fa28f1f95753, 0x4104fa28f1f95754, 0x4104fa28f1f95753, 0x410503fa382641f5, + 0x410503fa382641f5, 0x410503fa382641f5, 0x410503fa382641f5, 0x410503fa382641f5, 0x41050dcb7e532c97, 0x41050dcb7e532c97, 0x41050dcb7e532c97, 0x41050dcb7e532c97, + 0x41050dcb7e532c97, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105216e0aad01da, 0x4105216e0aad01da, + 0x4105216e0aad01da, 0x4105216e0aad01da, 0x4105216e0aad01da, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, + 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, + 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x41055284698d9702, + 0x41055284698d9702, 0x41055284698d9702, 0x41055284698d9702, 0x41055284698d9702, 0x41055c55afba81a4, 0x41055c55afba81a4, 0x41055c55afba81a4, 0x41055c55afba81a4, + 0x41055c55afba81a4, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056ff83c1456e7, 0x41056ff83c1456e7, + 0x41056ff83c1456e7, 0x41056ff83c1456e7, 0x41056ff83c1456e7, 0x410579c982414188, 0x410579c982414188, 0x410579c982414188, 0x410579c982414189, 0x410579c982414188, + 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, + 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105a10e9af4ec0f, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 5632 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, + 0x4105aadfe121d6b1, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105be826d7babf4, 0x4105be826d7babf4, + 0x4105be826d7babf4, 0x4105be826d7babf4, 0x4105be826d7babf4, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, + 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105dbf640026bd9, 0x4105dbf640026bd9, 0x4105dbf640026bd9, + 0x4105dbf640026bd9, 0x4105dbf640026bd9, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105ef98cc5c411c, + 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105f96a12892bbd, 0x4105f96a12892bbd, 0x4105f96a12892bbd, 0x4105f96a12892bbe, + 0x4105f96a12892bbd, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x41060d0c9ee30101, 0x41060d0c9ee30101, + 0x41060d0c9ee30101, 0x41060d0c9ee30101, 0x41060d0c9ee30101, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, + 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x41062a807169c0e6, 0x41062a807169c0e6, 0x41062a807169c0e6, + 0x41062a807169c0e6, 0x41062a807169c0e6, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063e22fdc39629, + 0x41063e22fdc39629, 0x41063e22fdc39629, 0x41063e22fdc39629, 0x41063e22fdc39629, 0x410647f443f080ca, 0x410647f443f080ca, 0x410647f443f080ca, 0x410647f443f080ca, + 0x410647f443f080ca, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x41065b96d04a560e, 0x41065b96d04a560e, + 0x41065b96d04a560e, 0x41065b96d04a560e, 0x41065b96d04a560e, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, + 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x4106790aa2d115f2, 0x4106790aa2d115f2, 0x4106790aa2d115f2, + 0x4106790aa2d115f3, 0x4106790aa2d115f2, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x41068cad2f2aeb36, + 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x4106967e7557d5d7, 0x4106967e7557d5d7, 0x4106967e7557d5d7, 0x4106967e7557d5d7, + 0x4106967e7557d5d7, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, + 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, + 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106c794d4386aff, 0x4106c794d4386aff, 0x4106c794d4386aff, + 0x4106c794d4386aff, 0x4106c794d4386aff, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106db3760924043, + 0x4106db3760924043, 0x4106db3760924043, 0x4106db3760924043, 0x4106db3760924043, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, + 0x4106e508a6bf2ae4, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106f8ab33190027, 0x4106f8ab33190027, + 0x4106f8ab33190027, 0x4106f8ab33190028, 0x4106f8ab33190027, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, + 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x4107161f059fc00c, 0x4107161f059fc00c, 0x4107161f059fc00c, + 0x4107161f059fc00c, 0x4107161f059fc00c, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x410729c191f99550, + 0x410729c191f99550, 0x410729c191f99550, 0x410729c191f99550, 0x410729c191f99550, 0x41073392d8267ff1, 0x41073392d8267ff1, 0x41073392d8267ff1, 0x41073392d8267ff1, + 0x41073392d8267ff1, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x4107473564805534, 0x4107473564805534, + 0x4107473564805534, 0x4107473564805534, 0x4107473564805534, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, + 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x410764a937071519, 0x410764a937071519, 0x410764a937071519, + 0x410764a937071519, 0x410764a937071519, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x4107784bc360ea5c, + 0x4107784bc360ea5c, 0x4107784bc360ea5c, 0x4107784bc360ea5d, 0x4107784bc360ea5c, 0x4107821d098dd4fe, 0x4107821d098dd4fe, 0x4107821d098dd4fe, 0x4107821d098dd4fe, + 0x4107821d098dd4fe, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x410795bf95e7aa41, 0x410795bf95e7aa41, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 6144 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x410795bf95e7aa41, 0x410795bf95e7aa41, 0x410795bf95e7aa41, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, + 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107b333686e6a26, 0x4107b333686e6a26, 0x4107b333686e6a26, + 0x4107b333686e6a26, 0x4107b333686e6a26, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107c6d5f4c83f69, + 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, + 0x4107d0a73af52a0b, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107e449c74eff4e, 0x4107e449c74eff4e, + 0x4107e449c74eff4e, 0x4107e449c74eff4e, 0x4107e449c74eff4e, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, + 0x4107f7ec53a8d491, 0x4107f7ec53a8d491, 0x4107f7ec53a8d491, 0x4107f7ec53a8d492, 0x4107f7ec53a8d491, 0x410801bd99d5bf33, 0x410801bd99d5bf33, 0x410801bd99d5bf33, + 0x410801bd99d5bf33, 0x410801bd99d5bf33, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41081560262f9476, + 0x41081560262f9476, 0x41081560262f9476, 0x41081560262f9476, 0x41081560262f9476, 0x41081f316c5c7f18, 0x41081f316c5c7f18, 0x41081f316c5c7f18, 0x41081f316c5c7f18, + 0x41081f316c5c7f18, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x410832d3f8b6545b, 0x410832d3f8b6545b, + 0x410832d3f8b6545b, 0x410832d3f8b6545b, 0x410832d3f8b6545b, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, + 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x41085047cb3d1440, 0x41085047cb3d1440, 0x41085047cb3d1440, + 0x41085047cb3d1440, 0x41085047cb3d1440, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x410863ea5796e983, + 0x410863ea5796e983, 0x410863ea5796e983, 0x410863ea5796e983, 0x410863ea5796e983, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, + 0x41086dbb9dc3d425, 0x4108778ce3f0bec6, 0x4108778ce3f0bec6, 0x4108778ce3f0bec6, 0x4108778ce3f0bec7, 0x4108778ce3f0bec6, 0x4108815e2a1da968, 0x4108815e2a1da968, + 0x4108815e2a1da968, 0x4108815e2a1da968, 0x4108815e2a1da968, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, + 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089ed1fca4694d, 0x41089ed1fca4694d, 0x41089ed1fca4694d, + 0x41089ed1fca4694d, 0x41089ed1fca4694d, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108b27488fe3e90, + 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, + 0x4108bc45cf2b2932, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, + 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, + 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, + 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, 0x4108f72d7438a8fb, 0x4108f72d7438a8fb, 0x4108f72d7438a8fb, 0x4108f72d7438a8fc, 0x4108f72d7438a8fb, 0x410900feba65939d, + 0x410900feba65939d, 0x410900feba65939d, 0x410900feba65939d, 0x410900feba65939d, 0x41090ad000927e3f, 0x41090ad000927e3f, 0x41090ad000927e3f, 0x41090ad000927e3f, + 0x41090ad000927e3f, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x41091e728cec5382, 0x41091e728cec5382, + 0x41091e728cec5382, 0x41091e728cec5382, 0x41091e728cec5382, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, + 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093be65f731367, 0x41093be65f731367, 0x41093be65f731367, + 0x41093be65f731367, 0x41093be65f731367, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x41094f88ebcce8aa, + 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x4109595a31f9d34c, 0x4109595a31f9d34c, 0x4109595a31f9d34c, 0x4109595a31f9d34c, + 0x4109595a31f9d34c, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, + 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, 0x410976ce04809330, 0x410976ce04809330, 0x410976ce04809330, 0x410976ce04809331, 0x410976ce04809330, + 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x41098a7090da6874, 0x41098a7090da6874, 0x41098a7090da6874, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 6656 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x41098a7090da6874, 0x41098a7090da6874, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099e131d343db7, + 0x41099e131d343db7, 0x41099e131d343db7, 0x41099e131d343db7, 0x41099e131d343db7, 0x4109a7e463612859, 0x4109a7e463612859, 0x4109a7e463612859, 0x4109a7e463612859, + 0x4109a7e463612859, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, + 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, + 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109d8fac241bd81, 0x4109d8fac241bd81, 0x4109d8fac241bd81, + 0x4109d8fac241bd81, 0x4109d8fac241bd81, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109ec9d4e9b92c4, + 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109f66e94c87d65, 0x4109f66e94c87d65, 0x4109f66e94c87d65, 0x4109f66e94c87d66, + 0x4109f66e94c87d65, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a0a11212252a9, 0x410a0a11212252a9, + 0x410a0a11212252a9, 0x410a0a11212252a9, 0x410a0a11212252a9, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, + 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a2784f3a9128e, 0x410a2784f3a9128e, 0x410a2784f3a9128e, + 0x410a2784f3a9128e, 0x410a2784f3a9128e, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a3b278002e7d1, + 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a44f8c62fd272, 0x410a44f8c62fd272, 0x410a44f8c62fd272, 0x410a44f8c62fd272, + 0x410a44f8c62fd272, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a589b5289a7b6, 0x410a589b5289a7b6, + 0x410a589b5289a7b6, 0x410a589b5289a7b6, 0x410a589b5289a7b6, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, + 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a760f2510679a, 0x410a760f2510679a, 0x410a760f2510679a, + 0x410a760f2510679a, 0x410a760f2510679a, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a89b1b16a3cde, + 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a9382f797277f, 0x410a9382f797277f, 0x410a9382f797277f, 0x410a9382f797277f, + 0x410a9382f797277f, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, + 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, + 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410ac4995677bca7, 0x410ac4995677bca7, 0x410ac4995677bca7, + 0x410ac4995677bca7, 0x410ac4995677bca7, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ad83be2d191eb, + 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, + 0x410ae20d28fe7c8c, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410af5afb55851cf, 0x410af5afb55851cf, + 0x410af5afb55851cf, 0x410af5afb55851cf, 0x410af5afb55851cf, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, + 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b132387df11b4, 0x410b132387df11b4, 0x410b132387df11b4, + 0x410b132387df11b4, 0x410b132387df11b4, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b26c61438e6f8, + 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b30975a65d199, 0x410b30975a65d199, 0x410b30975a65d199, 0x410b30975a65d199, + 0x410b30975a65d199, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, + 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, + 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b61adb94666c1, 0x410b61adb94666c1, 0x410b61adb94666c1, + 0x410b61adb94666c1, 0x410b61adb94666c1, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b755045a03c04, + 0x410b755045a03c04, 0x410b755045a03c04, 0x410b755045a03c04, 0x410b755045a03c04, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 7168 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x410b7f218bcd26a6, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b92c41826fbe9, 0x410b92c41826fbe9, + 0x410b92c41826fbe9, 0x410b92c41826fbe9, 0x410b92c41826fbe9, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, + 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410bb037eaadbbce, 0x410bb037eaadbbce, 0x410bb037eaadbbce, + 0x410bb037eaadbbce, 0x410bb037eaadbbce, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bc3da77079111, + 0x410bc3da77079111, 0x410bc3da77079111, 0x410bc3da77079111, 0x410bc3da77079111, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, + 0x410bcdabbd347bb3, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410be14e498e50f6, 0x410be14e498e50f6, + 0x410be14e498e50f6, 0x410be14e498e50f6, 0x410be14e498e50f6, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, + 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bfec21c1510db, 0x410bfec21c1510db, 0x410bfec21c1510db, + 0x410bfec21c1510db, 0x410bfec21c1510db, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c1264a86ee61e, + 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, + 0x410c1c35ee9bd0c0, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb61, 0x410c2fd87af5a603, 0x410c2fd87af5a603, + 0x410c2fd87af5a603, 0x410c2fd87af5a603, 0x410c2fd87af5a603, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, + 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, + 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c60eed9d63b2b, + 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c6ac0200325cd, 0x410c6ac0200325cd, 0x410c6ac0200325cd, 0x410c6ac0200325cd, + 0x410c6ac0200325cd, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, + 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, + 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, + 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a596, 0x410caf790b3d9038, + 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410cb94a516a7ada, 0x410cb94a516a7ada, 0x410cb94a516a7ada, 0x410cb94a516a7ada, + 0x410cb94a516a7ada, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cccecddc4501d, 0x410cccecddc4501d, + 0x410cccecddc4501d, 0x410cccecddc4501d, 0x410cccecddc4501d, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, + 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410cea60b04b1002, 0x410cea60b04b1002, 0x410cea60b04b1002, + 0x410cea60b04b1002, 0x410cea60b04b1002, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cfe033ca4e545, + 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, + 0x410d07d482d1cfe7, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, + 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcb, + 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d38eae1b2650f, 0x410d38eae1b2650f, 0x410d38eae1b2650f, + 0x410d38eae1b2650f, 0x410d38eae1b2650f, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d4c8d6e0c3a52, + 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d565eb43924f4, 0x410d565eb43924f4, 0x410d565eb43924f4, 0x410d565eb43924f4, + 0x410d565eb43924f4, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d6a014092fa37, 0x410d6a014092fa37, + 0x410d6a014092fa37, 0x410d6a014092fa37, 0x410d6a014092fa37, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 7680 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d87751319ba1c, 0x410d87751319ba1c, 0x410d87751319ba1c, + 0x410d87751319ba1c, 0x410d87751319ba1c, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d9b179f738f5f, + 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, + 0x410da4e8e5a07a00, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410db88b71fa4f44, 0x410db88b71fa4f44, + 0x410db88b71fa4f44, 0x410db88b71fa4f44, 0x410db88b71fa4f44, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, + 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dd5ff44810f29, 0x410dd5ff44810f29, 0x410dd5ff44810f29, + 0x410dd5ff44810f29, 0x410dd5ff44810f29, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410de9a1d0dae46c, + 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410df3731707cf0d, 0x410df3731707cf0d, 0x410df3731707cf0d, 0x410df3731707cf0d, + 0x410df3731707cf0d, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410e0715a361a451, 0x410e0715a361a451, + 0x410e0715a361a451, 0x410e0715a361a451, 0x410e0715a361a451, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, + 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e248975e86436, 0x410e248975e86436, 0x410e248975e86436, + 0x410e248975e86436, 0x410e248975e86435, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e382c02423979, + 0x410e382c02423979, 0x410e382c02423979, 0x410e382c02423979, 0x410e382c02423979, 0x410e41fd486f241a, 0x410e41fd486f241a, 0x410e41fd486f241a, 0x410e41fd486f241a, + 0x410e41fd486f241a, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, + 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, + 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e7313a74fb942, 0x410e7313a74fb942, 0x410e7313a74fb942, + 0x410e7313a74fb942, 0x410e7313a74fb942, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e86b633a98e86, + 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e908779d67927, 0x410e908779d67927, 0x410e908779d67927, 0x410e908779d67927, + 0x410e908779d67927, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410ea42a06304e6b, 0x410ea42a06304e6b, + 0x410ea42a06304e6b, 0x410ea42a06304e6b, 0x410ea42a06304e6a, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, + 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, + 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ed5406510e393, + 0x410ed5406510e393, 0x410ed5406510e393, 0x410ed5406510e393, 0x410ed5406510e393, 0x410edf11ab3dce34, 0x410edf11ab3dce34, 0x410edf11ab3dce34, 0x410edf11ab3dce34, + 0x410edf11ab3dce34, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ef2b43797a377, 0x410ef2b43797a377, + 0x410ef2b43797a377, 0x410ef2b43797a377, 0x410ef2b43797a377, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, + 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f10280a1e635c, 0x410f10280a1e635c, 0x410f10280a1e635c, + 0x410f10280a1e635c, 0x410f10280a1e635c, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f23ca967838a0, + 0x410f23ca967838a0, 0x410f23ca967838a0, 0x410f23ca967838a0, 0x410f23ca9678389f, 0x410f2d9bdca52341, 0x410f2d9bdca52341, 0x410f2d9bdca52341, 0x410f2d9bdca52341, + 0x410f2d9bdca52341, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f413e68fef884, 0x410f413e68fef884, + 0x410f413e68fef884, 0x410f413e68fef884, 0x410f413e68fef884, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, + 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f5eb23b85b869, 0x410f5eb23b85b869, 0x410f5eb23b85b869, + 0x410f5eb23b85b869, 0x410f5eb23b85b869, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f7254c7df8dac, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 8192 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7c260e0c784e, 0x410f7c260e0c784e, 0x410f7c260e0c784e, 0x410f7c260e0c784e, + 0x410f7c260e0c784e, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f8fc89a664d91, 0x410f8fc89a664d91, + 0x410f8fc89a664d91, 0x410f8fc89a664d91, 0x410f8fc89a664d91, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, + 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d4, 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, + 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fc0def946e2b9, + 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, + 0x410fcab03f73cd5b, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fde52cbcda29e, 0x410fde52cbcda29e, + 0x410fde52cbcda29e, 0x410fde52cbcda29e, 0x410fde52cbcda29e, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, + 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ffbc69e546283, 0x410ffbc69e546283, 0x410ffbc69e546283, + 0x410ffbc69e546283, 0x410ffbc69e546283, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411007b495571be3, + 0x411007b495571be3, 0x411007b495571be3, 0x411007b495571be3, 0x411007b495571be3, 0x41100c9d386d9134, 0x41100c9d386d9134, 0x41100c9d386d9134, 0x41100c9d386d9134, + 0x41100c9d386d9134, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, + 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, + 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110252867dddbc8, 0x4110252867dddbc8, 0x4110252867dddbc8, + 0x4110252867dddbc8, 0x4110252867dddbc8, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102ef9ae0ac66a, + 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x411033e251213bba, 0x411033e251213bba, 0x411033e251213bba, 0x411033e251213bba, + 0x411033e251213bba, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x41103db3974e265c, 0x41103db3974e265c, + 0x41103db3974e265c, 0x41103db3974e265c, 0x41103db3974e265c, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, + 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104c6d8091864e, 0x41104c6d8091864e, 0x41104c6d8091864e, + 0x41104c6d8091864e, 0x41104c6d8091864e, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110563ec6be70f0, + 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x41105b2769d4e641, 0x41105b2769d4e641, 0x41105b2769d4e641, 0x41105b2769d4e641, + 0x41105b2769d4e641, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411064f8b001d0e2, 0x411064f8b001d0e2, + 0x411064f8b001d0e2, 0x411064f8b001d0e3, 0x411064f8b001d0e2, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, + 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x411073b2994530d5, 0x411073b2994530d5, 0x411073b2994530d5, + 0x411073b2994530d5, 0x411073b2994530d5, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x41107d83df721b77, + 0x41107d83df721b77, 0x41107d83df721b77, 0x41107d83df721b77, 0x41107d83df721b77, 0x4110826c828890c7, 0x4110826c828890c7, 0x4110826c828890c7, 0x4110826c828890c7, + 0x4110826c828890c7, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, + 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, + 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, + 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x4110a4c8f825c5fd, + 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, + 0x4110a9b19b3c3b4e, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110b382e16925ef, 0x4110b382e16925ef, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 8704 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4110b382e16925ef, 0x4110b382e16925ef, 0x4110b382e16925ef, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, + 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, + 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110cc0e10d97083, + 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, + 0x4110d0f6b3efe5d4, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, + 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, + 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e981e3603068, 0x4110e981e3603068, 0x4110e981e3603068, + 0x4110e981e3603068, 0x4110e981e3603068, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110f353298d1b0a, + 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f83bcca3905b, 0x4110f83bcca3905b, 0x4110f83bcca3905b, 0x4110f83bcca3905b, + 0x4110f83bcca3905b, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4111020d12d07afc, 0x4111020d12d07afc, + 0x4111020d12d07afc, 0x4111020d12d07afc, 0x4111020d12d07afc, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, + 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x411110c6fc13daef, 0x411110c6fc13daef, 0x411110c6fc13daef, + 0x411110c6fc13daef, 0x411110c6fc13daef, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x41111a984240c590, + 0x41111a984240c590, 0x41111a984240c590, 0x41111a984240c590, 0x41111a984240c590, 0x41111f80e5573ae1, 0x41111f80e5573ae1, 0x41111f80e5573ae1, 0x41111f80e5573ae1, + 0x41111f80e5573ae1, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x411129522b842583, 0x411129522b842583, + 0x411129522b842583, 0x411129522b842583, 0x411129522b842583, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, + 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111380c14c78575, 0x4111380c14c78575, 0x4111380c14c78575, + 0x4111380c14c78575, 0x4111380c14c78575, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x411141dd5af47017, + 0x411141dd5af47017, 0x411141dd5af47017, 0x411141dd5af47017, 0x411141dd5af47017, 0x411146c5fe0ae568, 0x411146c5fe0ae568, 0x411146c5fe0ae568, 0x411146c5fe0ae568, + 0x411146c5fe0ae568, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x411150974437d009, 0x411150974437d009, + 0x411150974437d009, 0x411150974437d009, 0x411150974437d009, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, + 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, + 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x4111692273a81a9d, + 0x4111692273a81a9d, 0x4111692273a81a9d, 0x4111692273a81a9d, 0x4111692273a81a9d, 0x41116e0b16be8fee, 0x41116e0b16be8fee, 0x41116e0b16be8fee, 0x41116e0b16be8fee, + 0x41116e0b16be8fee, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, + 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe0, + 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x41118696462eda82, 0x41118696462eda82, 0x41118696462eda82, + 0x41118696462eda82, 0x41118696462eda82, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x411190678c5bc524, + 0x411190678c5bc524, 0x411190678c5bc524, 0x411190678c5bc524, 0x411190678c5bc524, 0x411195502f723a75, 0x411195502f723a75, 0x411195502f723a75, 0x411195502f723a75, + 0x411195502f723a75, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119f21759f2516, 0x41119f21759f2516, + 0x41119f21759f2516, 0x41119f21759f2516, 0x41119f21759f2516, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, + 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111addb5ee28509, 0x4111addb5ee28509, 0x4111addb5ee28509, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 9216 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4111addb5ee28509, 0x4111addb5ee28509, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b7aca50f6faa, + 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111bc954825e4fb, 0x4111bc954825e4fb, 0x4111bc954825e4fb, 0x4111bc954825e4fb, + 0x4111bc954825e4fb, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, + 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, + 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d52077962f8f, 0x4111d52077962f8f, 0x4111d52077962f8f, + 0x4111d52077962f8f, 0x4111d52077962f8f, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111def1bdc31a31, + 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111e3da60d98f81, 0x4111e3da60d98f81, 0x4111e3da60d98f81, 0x4111e3da60d98f81, + 0x4111e3da60d98f81, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111edaba7067a23, 0x4111edaba7067a23, + 0x4111edaba7067a23, 0x4111edaba7067a23, 0x4111edaba7067a23, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, + 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111fc659049da16, 0x4111fc659049da16, 0x4111fc659049da16, + 0x4111fc659049da16, 0x4111fc659049da15, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x41120636d676c4b7, + 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120b1f798d3a08, 0x41120b1f798d3a08, 0x41120b1f798d3a08, 0x41120b1f798d3a08, + 0x41120b1f798d3a08, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411214f0bfba24aa, 0x411214f0bfba24aa, + 0x411214f0bfba24aa, 0x411214f0bfba24aa, 0x411214f0bfba24aa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, + 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x411223aaa8fd849c, 0x411223aaa8fd849c, 0x411223aaa8fd849c, + 0x411223aaa8fd849c, 0x411223aaa8fd849c, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x41122d7bef2a6f3e, + 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x411232649240e48e, 0x411232649240e48e, 0x411232649240e48e, 0x411232649240e48e, + 0x411232649240e48e, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x41123c35d86dcf30, 0x41123c35d86dcf30, + 0x41123c35d86dcf30, 0x41123c35d86dcf30, 0x41123c35d86dcf30, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, + 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x41124aefc1b12f22, 0x41124aefc1b12f22, 0x41124aefc1b12f22, + 0x41124aefc1b12f22, 0x41124aefc1b12f22, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x411254c107de19c4, + 0x411254c107de19c4, 0x411254c107de19c4, 0x411254c107de19c4, 0x411254c107de19c4, 0x411259a9aaf48f15, 0x411259a9aaf48f15, 0x411259a9aaf48f15, 0x411259a9aaf48f15, + 0x411259a9aaf48f15, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x4112637af12179b6, 0x4112637af12179b6, + 0x4112637af12179b6, 0x4112637af12179b6, 0x4112637af12179b6, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, + 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41127234da64d9a9, 0x41127234da64d9a9, 0x41127234da64d9a9, + 0x41127234da64d9a9, 0x41127234da64d9a9, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x41127c062091c44b, + 0x41127c062091c44b, 0x41127c062091c44b, 0x41127c062091c44b, 0x41127c062091c44a, 0x411280eec3a8399b, 0x411280eec3a8399b, 0x411280eec3a8399b, 0x411280eec3a8399b, + 0x411280eec3a8399b, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x41128ac009d5243d, 0x41128ac009d5243d, + 0x41128ac009d5243d, 0x41128ac009d5243d, 0x41128ac009d5243d, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, + 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x41129979f318842f, 0x41129979f318842f, 0x41129979f318842f, + 0x41129979f318842f, 0x41129979f318842f, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x4112a34b39456ed1, + 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a833dc5be422, 0x4112a833dc5be422, 0x4112a833dc5be422, 0x4112a833dc5be422, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 9728 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4112a833dc5be422, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112b2052288cec3, 0x4112b2052288cec3, + 0x4112b2052288cec3, 0x4112b2052288cec3, 0x4112b2052288cec3, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, + 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, + 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112ca9051f91957, + 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, + 0x4112cf78f50f8ea8, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, + 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, + 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e804247fd93c, 0x4112e804247fd93c, 0x4112e804247fd93c, + 0x4112e804247fd93c, 0x4112e804247fd93c, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112f1d56aacc3de, + 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, + 0x4112f6be0dc3392f, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae7f, 0x4113008f53f023d0, 0x4113008f53f023d0, + 0x4113008f53f023d0, 0x4113008f53f023d0, 0x4113008f53f023d0, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, + 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130f493d3383c3, 0x41130f493d3383c3, 0x41130f493d3383c3, + 0x41130f493d3383c3, 0x41130f493d3383c3, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x4113191a83606e64, + 0x4113191a83606e64, 0x4113191a83606e64, 0x4113191a83606e64, 0x4113191a83606e64, 0x41131e032676e3b5, 0x41131e032676e3b5, 0x41131e032676e3b5, 0x41131e032676e3b5, + 0x41131e032676e3b5, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411327d46ca3ce57, 0x411327d46ca3ce57, + 0x411327d46ca3ce57, 0x411327d46ca3ce57, 0x411327d46ca3ce57, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, + 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x40774475ad031dbf, 0x40774475ad031dbf, 0x40774475ad031dbf, + 0x40774475ad031dc0, 0x40774475ad031dbf, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x4089156a569a0b02, + 0x4089156a569a0b02, 0x4089156a569a0b02, 0x4089156a569a0b02, 0x4089156a569a0b02, 0x408fcf0216a64913, 0x408fcf0216a64913, 0x408fcf0216a64913, 0x408fcf0216a64913, + 0x408fcf0216a64913, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4096a118cb5f629a, 0x4096a118cb5f629a, + 0x4096a118cb5f629a, 0x4096a118cb5f629a, 0x4096a118cb5f629a, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, + 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, + 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a3b88a15befee2, + 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a566f005c20e67, 0x40a566f005c20e67, 0x40a566f005c20e67, 0x40a566f005c20e67, + 0x40a566f005c20e67, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, + 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, + 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, + 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40b095dccaebbd82, + 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, + 0x40b16d0fc2ed4544, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, + 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d1e56d15d49d932, 0x3d1e56d15d49d932, 0x3d1e56d15d49d932, + 0xbd20d497515b1367, 0x3d1e56d15d49d932, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d2162ace0052e27, + 0x3d2162ace0052e27, 0x3d2162ace0052e27, 0x3d2162ace0052e27, 0x3d2162ace0052e27, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd21f0c26eaf48e7, 0xbd21f0c26eaf48e7, 0xbd21f0c26eaf48e7, 0xbd21f0c26eaf48e7, 0xbd21f0c26eaf48e7, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d227ed7fd5963a8, 0x3d227ed7fd5963a8, 0x3d227ed7fd5963a8, 0x3d227ed7fd5963a8, 0x3d227ed7fd5963a8, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd230ced8c037e68, 0xbd230ced8c037e68, 0xbd230ced8c037e68, + 0xbd230ced8c037e68, 0xbd230ced8c037e68, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4b193f395499b6, + 0xbd4b193f395499b6, 0xbd4b193f395499b6, 0xbd4b193f395499b6, 0xbd4b193f395499b6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd242918a957b3e9, 0xbd242918a957b3e9, 0xbd242918a957b3e9, 0xbd242918a957b3e9, 0xbd242918a957b3e9, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4ad23471ff8c56, 0xbd4ad23471ff8c56, 0xbd4ad23471ff8c56, 0xbd4ad23471ff8c56, 0xbd4ad23471ff8c56, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd254543c6abe969, 0xbd254543c6abe969, 0xbd254543c6abe969, + 0xbd254543c6abe969, 0xbd254543c6abe969, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4a8b29aaaa7ef6, + 0xbd4a8b29aaaa7ef6, 0xbd4a8b29aaaa7ef6, 0xbd4a8b29aaaa7ef6, 0xbd4a8b29aaaa7ef6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d5d33d2237ffc23, 0x3d5d33d2237ffc23, 0x3d5d33d2237ffc23, 0x3d5d33d2237ffc23, 0x3d5d33d2237ffc23, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d52ddf08e554735, 0x3d52ddf08e554735, 0x3d52ddf08e554735, 0x3d52ddf08e554735, 0x3d52ddf08e554735, +] )) ), + +################ chunk 10240 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, + 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b74f748af7fb93, + 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b826a782f98355, 0x40b826a782f98355, 0x40b826a782f98355, 0x40b826a782f98355, + 0x40b826a782f98355, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, + 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, + 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, + 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40be090c4b0439a4, + 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40bee03f4305c166, 0x40bee03f4305c166, 0x40bee03f4305c166, 0x40bee03f4305c166, + 0x40bee03f4305c166, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40c0475299846875, 0x40c0475299846875, + 0x40c0475299846875, 0x40c0475299846875, 0x40c0475299846875, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, + 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, + 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c2615205883bdb, + 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, + 0x40c2cceb8188ffbc, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c3a41e798a877e, 0x40c3a41e798a877e, + 0x40c3a41e798a877e, 0x40c3a41e798a877e, 0x40c3a41e798a877e, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, + 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, + 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c5be1de58e5ae3, + 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, + 0x40c629b7618f1ec4, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c700ea5990a686, 0x40c700ea5990a686, + 0x40c700ea5990a686, 0x40c700ea5990a686, 0x40c700ea5990a686, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, + 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c843b6cd92f229, 0x40c843b6cd92f229, 0x40c843b6cd92f229, + 0x40c843b6cd92f229, 0x40c843b6cd92f229, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c91ae9c59479ec, + 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c9868341953dcd, 0x40c9868341953dcd, 0x40c9868341953dcd, 0x40c9868341953dcd, + 0x40c9868341953dcd, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40ca5db63996c58f, 0x40ca5db63996c58f, + 0x40ca5db63996c58f, 0x40ca5db63996c58f, 0x40ca5db63996c58f, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, + 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cba082ad991132, 0x40cba082ad991132, 0x40cba082ad991132, + 0x40cba082ad991132, 0x40cba082ad991132, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc77b5a59a98f4, + 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, + 0x40cce34f219b5cd5, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cdba82199ce497, 0x40cdba82199ce497, + 0x40cdba82199ce497, 0x40cdba82199ce497, 0x40cdba82199ce497, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, + 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, + 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cfd48185a0b7fd, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd277d9a0154546b, 0xbd277d9a0154546b, 0xbd277d9a0154546b, + 0xbd277d9a0154546b, 0xbd277d9a0154546b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd49fd141c006435, + 0xbd49fd141c006435, 0xbd49fd141c006435, 0xbd49fd141c006435, 0xbd49fd141c006435, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d5cecc75c2aeec3, 0x3d5cecc75c2aeec3, 0x3d5cecc75c2aeec3, 0x3d5cecc75c2aeec3, 0x3d5cecc75c2aeec3, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d5324fb55aa5495, 0x3d5324fb55aa5495, 0x3d5324fb55aa5495, 0x3d5324fb55aa5495, 0x3d5324fb55aa5495, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd29b5f03bfcbf6c, 0xbd29b5f03bfcbf6c, 0xbd29b5f03bfcbf6c, + 0xbd29b5f03bfcbf6c, 0xbd29b5f03bfcbf6c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd496efe8d564975, + 0xbd496efe8d564975, 0xbd496efe8d564975, 0xbd496efe8d564975, 0xbd496efe8d564975, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d5ca5bc94d5e162, 0x3d5ca5bc94d5e162, 0x3d5ca5bc94d5e162, 0x3d5ca5bc94d5e162, 0x3d5ca5bc94d5e162, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6649fcf1804f05, 0xbd6649fcf1804f05, 0xbd6649fcf1804f05, 0xbd6649fcf1804f05, 0xbd6649fcf1804f05, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6e411b9895ad59, 0x3d6e411b9895ad59, 0x3d6e411b9895ad59, + 0x3d6e411b9895ad59, 0x3d6e411b9895ad59, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d69c7c5c054f453, + 0x3d69c7c5c054f453, 0x3d69c7c5c054f453, 0x3d69c7c5c054f453, 0x3d69c7c5c054f453, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd61d0a7193f95ff, 0xbd61d0a7193f95ff, 0xbd61d0a7193f95ff, 0xbd61d0a7193f95ff, 0xbd61d0a7193f95ff, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d53b310e4546f56, 0x3d53b310e4546f56, 0x3d53b310e4546f56, 0x3d53b310e4546f56, 0x3d53b310e4546f56, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd2e269cb14d956e, 0xbd2e269cb14d956e, 0xbd2e269cb14d956e, + 0xbd2e269cb14d956e, 0xbd2e269cb14d956e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4852d3700213f4, + 0xbd4852d3700213f4, 0xbd4852d3700213f4, 0xbd4852d3700213f4, 0xbd4852d3700213f4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d5c17a7062bc6a2, 0x3d5c17a7062bc6a2, 0x3d5c17a7062bc6a2, 0x3d5c17a7062bc6a2, 0x3d5c17a7062bc6a2, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6602f22a2b41a5, 0xbd6602f22a2b41a5, 0xbd6602f22a2b41a5, 0xbd6602f22a2b41a5, 0xbd6602f22a2b41a5, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6dfa10d1409ff9, 0x3d6dfa10d1409ff9, 0x3d6dfa10d1409ff9, + 0x3d6dfa10d1409ff9, 0x3d6dfa10d1409ff9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6a0ed087aa01b3, + 0x3d6a0ed087aa01b3, 0x3d6a0ed087aa01b3, 0x3d6a0ed087aa01b3, 0x3d6a0ed087aa01b3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd6217b1e094a35f, 0xbd6217b1e094a35f, 0xbd6217b1e094a35f, 0xbd6217b1e094a35f, 0xbd6217b1e094a35f, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d54412672fe8a16, 0x3d54412672fe8a16, 0x3d54412672fe8a16, 0x3d54412672fe8a16, 0x3d54412672fe8a16, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd314ba4934f35b9, 0xbd314ba4934f35b9, 0xbd314ba4934f35b9, + 0xbd314ba4934f35b9, 0xbd314ba4934f35b9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4736a852adde74, + 0xbd4736a852adde74, 0xbd4736a852adde74, 0xbd4736a852adde74, 0xbd4736a852adde74, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d5b89917781abe2, 0x3d5b89917781abe2, 0x3d5b89917781abe2, 0x3d5b89917781abe2, 0x3d5b89917781abe2, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd65bbe762d63445, 0xbd65bbe762d63445, 0xbd65bbe762d63445, 0xbd65bbe762d63445, 0xbd65bbe762d63445, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6db30609eb9299, 0x3d6db30609eb9299, 0x3d6db30609eb9299, + 0x3d6db30609eb9299, 0x3d6db30609eb9299, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6a55db4eff0f13, +] )) ), + +################ chunk 10752 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, + 0x40d0200d80d0bdef, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, + 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, + 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, + 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d198a6b2d36b83, + 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, + 0x40d1ce7370d3cd73, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d23a0cecd49154, 0x40d23a0cecd49154, + 0x40d23a0cecd49154, 0x40d23a0cecd49154, 0x40d23a0cecd49154, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, + 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2db7326d5b726, 0x40d2db7326d5b726, 0x40d2db7326d5b726, + 0x40d2db7326d5b726, 0x40d2db7326d5b726, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3470ca2d67b07, + 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, + 0x40d37cd960d6dcf7, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, + 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, + 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, + 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4f57292d98a8b, + 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, + 0x40d52b3f50d9ec7c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, + 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, + 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, + 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d6a3d882dc9a0f, + 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, + 0x40d6d9a540dcfc00, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, + 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, + 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, + 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d8523e72dfa994, + 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8880b30e00b84, 0x40d8880b30e00b84, 0x40d8880b30e00b84, 0x40d8880b30e00b84, + 0x40d8880b30e00b84, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, + 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, + 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, + 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40da00a462e2b918, + 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da367120e31b08, 0x40da367120e31b08, 0x40da367120e31b08, 0x40da367120e31b08, + 0x40da367120e31b08, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d6a55db4eff0f13, 0x3d6a55db4eff0f13, 0x3d6a55db4eff0f13, 0x3d6a55db4eff0f13, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d76d0a1ac0b27a0, 0x3d76d0a1ac0b27a0, 0x3d76d0a1ac0b27a0, 0x3d76d0a1ac0b27a0, 0x3d76d0a1ac0b27a0, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7acc30ff95d6ca, 0xbd7acc30ff95d6ca, 0xbd7acc30ff95d6ca, 0xbd7acc30ff95d6ca, 0xbd7acc30ff95d6ca, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7ec7c0532085f4, 0x3d7ec7c0532085f4, 0x3d7ec7c0532085f4, + 0x3d7ec7c0532085f4, 0x3d7ec7c0532085f4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7d3cb05954cae2, + 0x3d7d3cb05954cae2, 0x3d7d3cb05954cae2, 0x3d7d3cb05954cae2, 0x3d7d3cb05954cae2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd79412105ca1bb8, 0xbd79412105ca1bb8, 0xbd79412105ca1bb8, 0xbd79412105ca1bb8, 0xbd79412105ca1bb8, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d754591b23f6c8e, 0x3d754591b23f6c8e, 0x3d754591b23f6c8e, 0x3d754591b23f6c8e, 0x3d754591b23f6c8e, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd714a025eb4bd64, 0xbd714a025eb4bd64, 0xbd714a025eb4bd64, + 0xbd714a025eb4bd64, 0xbd714a025eb4bd64, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6a9ce616541c73, + 0x3d6a9ce616541c73, 0x3d6a9ce616541c73, 0x3d6a9ce616541c73, 0x3d6a9ce616541c73, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd62a5c76f3ebe1f, 0xbd62a5c76f3ebe1f, 0xbd62a5c76f3ebe1f, 0xbd62a5c76f3ebe1f, 0xbd62a5c76f3ebe1f, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d555d519052bf97, 0x3d555d519052bf97, 0x3d555d519052bf97, 0x3d555d519052bf97, 0x3d555d519052bf97, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd35bc5108a00bbb, 0xbd35bc5108a00bbb, 0xbd35bc5108a00bbb, + 0xbd35bc5108a00bbb, 0xbd35bc5108a00bbb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd44fe5218057372, + 0xbd44fe5218057372, 0xbd44fe5218057372, 0xbd44fe5218057372, 0xbd44fe5218057372, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d5a6d665a2d7661, 0x3d5a6d665a2d7661, 0x3d5a6d665a2d7661, 0x3d5a6d665a2d7661, 0x3d5a6d665a2d7661, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd652dd1d42c1985, 0xbd652dd1d42c1985, 0xbd652dd1d42c1985, 0xbd652dd1d42c1985, 0xbd652dd1d42c1985, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6d24f07b4177d9, 0x3d6d24f07b4177d9, 0x3d6d24f07b4177d9, + 0x3d6d24f07b4177d9, 0x3d6d24f07b4177d9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd728e07912b6b16, + 0xbd728e07912b6b16, 0xbd728e07912b6b16, 0xbd728e07912b6b16, 0xbd728e07912b6b16, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d768996e4b61a40, 0x3d768996e4b61a40, 0x3d768996e4b61a40, 0x3d768996e4b61a40, 0x3d768996e4b61a40, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7a85263840c96a, 0xbd7a85263840c96a, 0xbd7a85263840c96a, 0xbd7a85263840c96a, 0xbd7a85263840c96a, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7e80b58bcb7894, 0x3d7e80b58bcb7894, 0x3d7e80b58bcb7894, + 0x3d7e80b58bcb7894, 0x3d7e80b58bcb7894, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7d83bb20a9d842, + 0x3d7d83bb20a9d842, 0x3d7d83bb20a9d842, 0x3d7d83bb20a9d842, 0x3d7d83bb20a9d842, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd79882bcd1f2918, 0xbd79882bcd1f2918, 0xbd79882bcd1f2918, 0xbd79882bcd1f2918, 0xbd79882bcd1f2918, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d758c9c799479ee, 0x3d758c9c799479ee, 0x3d758c9c799479ee, 0x3d758c9c799479ee, 0x3d758c9c799479ee, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd71910d2609cac4, 0xbd71910d2609cac4, 0xbd71910d2609cac4, + 0xbd71910d2609cac4, 0xbd71910d2609cac4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6b2afba4fe3734, + 0x3d6b2afba4fe3734, 0x3d6b2afba4fe3734, 0x3d6b2afba4fe3734, 0x3d6b2afba4fe3734, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd6333dcfde8d8e0, 0xbd6333dcfde8d8e0, 0xbd6333dcfde8d8e0, 0xbd6333dcfde8d8e0, 0xbd6333dcfde8d8e0, 0xbff0000000000000, 0xbff0000000000000, +] )) ), + +################ chunk 11264 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, + 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db4370d6e504bb, 0x40db4370d6e504bb, 0x40db4370d6e504bb, + 0x40db4370d6e504bb, 0x40db4370d6e504bb, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40dbaf0a52e5c89c, + 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, + 0x40dbe4d710e62a8d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, + 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, + 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, + 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd5d7042e8d820, + 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd933d00e93a11, 0x40dd933d00e93a11, 0x40dd933d00e93a11, 0x40dd933d00e93a11, + 0x40dd933d00e93a11, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, + 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, + 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, + 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40df0bd632ebe7a5, + 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, + 0x40df41a2f0ec4995, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, + 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, + 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e02751537719a4, 0x40e02751537719a4, 0x40e02751537719a4, + 0x40e02751537719a4, 0x40e02751537719a4, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e05d1e11777b94, + 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e078047077ac8d, 0x40e078047077ac8d, 0x40e078047077ac8d, 0x40e078047077ac8d, + 0x40e078047077ac8d, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e0add12e780e7d, 0x40e0add12e780e7d, + 0x40e0add12e780e7d, 0x40e0add12e780e7d, 0x40e0add12e780e7d, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, + 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0fe844b78a166, 0x40e0fe844b78a166, 0x40e0fe844b78a166, + 0x40e0fe844b78a166, 0x40e0fe844b78a166, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1345109790357, + 0x40e1345109790357, 0x40e1345109790357, 0x40e1345109790357, 0x40e1345109790357, 0x40e14f376879344f, 0x40e14f376879344f, 0x40e14f376879344f, 0x40e14f376879344f, + 0x40e14f376879344f, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e185042679963f, 0x40e185042679963f, + 0x40e185042679963f, 0x40e185042679963f, 0x40e185042679963f, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, + 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, + 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e20b84017a8b19, + 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e2266a607abc11, 0x40e2266a607abc11, 0x40e2266a607abc11, 0x40e2266a607abc11, + 0x40e2266a607abc11, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, + 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, + 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d56797cada6f517, 0x3d56797cada6f517, 0x3d56797cada6f517, 0x3d56797cada6f517, 0x3d56797cada6f517, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd3a2cfd7df0e1be, 0xbd3a2cfd7df0e1be, 0xbd3a2cfd7df0e1be, + 0xbd3a2cfd7df0e1be, 0xbd3a2cfd7df0e1be, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd42c5fbdd5d0871, + 0xbd42c5fbdd5d0871, 0xbd42c5fbdd5d0871, 0xbd42c5fbdd5d0871, 0xbd42c5fbdd5d0871, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d59513b3cd940e1, 0x3d59513b3cd940e1, 0x3d59513b3cd940e1, 0x3d59513b3cd940e1, 0x3d59513b3cd940e1, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd649fbc4581fec4, 0xbd649fbc4581fec4, 0xbd649fbc4581fec4, 0xbd649fbc4581fec4, 0xbd649fbc4581fec4, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6c96daec975d18, 0x3d6c96daec975d18, 0x3d6c96daec975d18, + 0x3d6c96daec975d18, 0x3d6c96daec975d18, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7246fcc9d65db6, + 0xbd7246fcc9d65db6, 0xbd7246fcc9d65db6, 0xbd7246fcc9d65db6, 0xbd7246fcc9d65db6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d76428c1d610ce0, 0x3d76428c1d610ce0, 0x3d76428c1d610ce0, 0x3d76428c1d610ce0, 0x3d76428c1d610ce0, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7a3e1b70ebbc0a, 0xbd7a3e1b70ebbc0a, 0xbd7a3e1b70ebbc0a, 0xbd7a3e1b70ebbc0a, 0xbd7a3e1b70ebbc0a, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7e39aac4766b34, 0x3d7e39aac4766b34, 0x3d7e39aac4766b34, + 0x3d7e39aac4766b34, 0x3d7e39aac4766b34, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7dcac5e7fee5a2, + 0x3d7dcac5e7fee5a2, 0x3d7dcac5e7fee5a2, 0x3d7dcac5e7fee5a2, 0x3d7dcac5e7fee5a2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd79cf3694743678, 0xbd79cf3694743678, 0xbd79cf3694743678, 0xbd79cf3694743678, 0xbd79cf3694743678, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d75d3a740e9874e, 0x3d75d3a740e9874e, 0x3d75d3a740e9874e, 0x3d75d3a740e9874e, 0x3d75d3a740e9874e, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd71d817ed5ed824, 0xbd71d817ed5ed824, 0xbd71d817ed5ed824, + 0xbd71d817ed5ed824, 0xbd71d817ed5ed824, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8911bbb315eb83, + 0xbd8911bbb315eb83, 0xbd8911bbb315eb83, 0xbd8911bbb315eb83, 0xbd8911bbb315eb83, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd63c1f28c92f3a0, 0xbd63c1f28c92f3a0, 0xbd63c1f28c92f3a0, 0xbd63c1f28c92f3a0, 0xbd63c1f28c92f3a0, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8d0d4b06a09aad, 0xbd8d0d4b06a09aad, 0xbd8d0d4b06a09aad, 0xbd8d0d4b06a09aad, 0xbd8d0d4b06a09aad, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd3e9da9f341b7c0, 0xbd3e9da9f341b7c0, 0xbd3e9da9f341b7c0, + 0xbd3e9da9f341b7c0, 0xbd3e9da9f341b7c0, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8ef725a5d4b629, + 0x3d8ef725a5d4b629, 0x3d8ef725a5d4b629, 0x3d8ef725a5d4b629, 0x3d8ef725a5d4b629, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d5835101f850b60, 0x3d5835101f850b60, 0x3d5835101f850b60, 0x3d5835101f850b60, 0x3d5835101f850b60, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8afb96524a06ff, 0x3d8afb96524a06ff, 0x3d8afb96524a06ff, 0x3d8afb96524a06ff, 0x3d8afb96524a06ff, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6c08c55ded4258, 0x3d6c08c55ded4258, 0x3d6c08c55ded4258, + 0x3d6c08c55ded4258, 0x3d6c08c55ded4258, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d870006febf57d5, + 0x3d870006febf57d5, 0x3d870006febf57d5, 0x3d870006febf57d5, 0x3d870006febf57d5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d75fb81560bff80, 0x3d75fb81560bff80, 0x3d75fb81560bff80, 0x3d75fb81560bff80, 0x3d75fb81560bff80, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d830477ab34a8ab, 0x3d830477ab34a8ab, 0x3d830477ab34a8ab, 0x3d830477ab34a8ab, 0x3d830477ab34a8ab, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7df29ffd215dd4, 0x3d7df29ffd215dd4, 0x3d7df29ffd215dd4, +] )) ), + +################ chunk 11776 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e3, 0x40e2c7d09a7be1e2, 0x40e2e2b6f97c12db, + 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, + 0x40e2fd9d587c43d3, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, + 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, + 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e3841d337d38ac, 0x40e3841d337d38ac, 0x40e3841d337d38ac, + 0x40e3841d337d38ac, 0x40e3841d337d38ac, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e3b9e9f17d9a9d, + 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, + 0x40e3d4d0507dcb95, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, + 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, + 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, + 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e4911ce97f225f, + 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4ac03487f5357, 0x40e4ac03487f5357, 0x40e4ac03487f5357, 0x40e4ac03487f5357, + 0x40e4ac03487f5357, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, + 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, + 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5328323804831, 0x40e5328323804831, 0x40e5328323804831, + 0x40e5328323804831, 0x40e5328323804831, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e5684fe180aa21, + 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e583364080db19, 0x40e583364080db19, 0x40e583364080db19, 0x40e583364080db19, + 0x40e583364080db19, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, + 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, + 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e609b61b81cff3, 0x40e609b61b81cff3, 0x40e609b61b81cff3, + 0x40e609b61b81cff3, 0x40e609b61b81cff3, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e63f82d98231e3, + 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e65a69388262dc, 0x40e65a69388262dc, 0x40e65a69388262dc, 0x40e65a69388262dc, + 0x40e65a69388262dc, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e69035f682c4cc, 0x40e69035f682c4cc, + 0x40e69035f682c4cc, 0x40e69035f682c4cc, 0x40e69035f682c4cc, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, + 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, + 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e716b5d183b9a5, + 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, + 0x40e7319c3083ea9e, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e76768ee844c8e, 0x40e76768ee844c8e, + 0x40e76768ee844c8e, 0x40e76768ee844c8e, 0x40e76768ee844c8e, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, + 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, + 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7ede8c9854168, + 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e808cf28857260, 0x40e808cf28857260, 0x40e808cf28857260, 0x40e808cf28857260, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d7df29ffd215dd4, 0x3d7df29ffd215dd4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7e11d0af53f302, + 0x3d7e11d0af53f302, 0x3d7e11d0af53f302, 0x3d7e11d0af53f302, 0x3d7e11d0af53f302, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d82f4df521b5e14, 0x3d82f4df521b5e14, 0x3d82f4df521b5e14, 0x3d82f4df521b5e14, 0x3d82f4df521b5e14, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d761ab2083e94ae, 0x3d761ab2083e94ae, 0x3d761ab2083e94ae, 0x3d761ab2083e94ae, 0x3d761ab2083e94ae, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d86f06ea5a60d3e, 0x3d86f06ea5a60d3e, 0x3d86f06ea5a60d3e, + 0x3d86f06ea5a60d3e, 0x3d86f06ea5a60d3e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6c4726c2526cb4, + 0x3d6c4726c2526cb4, 0x3d6c4726c2526cb4, 0x3d6c4726c2526cb4, 0x3d6c4726c2526cb4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d8aebfdf930bc68, 0x3d8aebfdf930bc68, 0x3d8aebfdf930bc68, 0x3d8aebfdf930bc68, 0x3d8aebfdf930bc68, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d58b1d2e84f6019, 0x3d58b1d2e84f6019, 0x3d58b1d2e84f6019, 0x3d58b1d2e84f6019, 0x3d58b1d2e84f6019, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8ee78d4cbb6b92, 0x3d8ee78d4cbb6b92, 0x3d8ee78d4cbb6b92, + 0x3d8ee78d4cbb6b92, 0x3d8ee78d4cbb6b92, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd3caa9ed01864dd, + 0xbd3caa9ed01864dd, 0xbd3caa9ed01864dd, 0xbd3caa9ed01864dd, 0xbd3caa9ed01864dd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd8d1ce35fb9e544, 0xbd8d1ce35fb9e544, 0xbd8d1ce35fb9e544, 0xbd8d1ce35fb9e544, 0xbd8d1ce35fb9e544, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd638391282dc944, 0xbd638391282dc944, 0xbd638391282dc944, 0xbd638391282dc944, 0xbd638391282dc944, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8921540c2f361a, 0xbd8921540c2f361a, 0xbd8921540c2f361a, + 0xbd8921540c2f361a, 0xbd8921540c2f361a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd71b8e73b2c42f6, + 0xbd71b8e73b2c42f6, 0xbd71b8e73b2c42f6, 0xbd71b8e73b2c42f6, 0xbd71b8e73b2c42f6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd8525c4b8a486f0, 0xbd8525c4b8a486f0, 0xbd8525c4b8a486f0, 0xbd8525c4b8a486f0, 0xbd8525c4b8a486f0, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd79b005e241a14a, 0xbd79b005e241a14a, 0xbd79b005e241a14a, 0xbd79b005e241a14a, 0xbd79b005e241a14a, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd812a356519d7c6, 0xbd812a356519d7c6, 0xbd812a356519d7c6, + 0xbd812a356519d7c6, 0xbd812a356519d7c6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd80d39244ab7fcf, + 0xbd80d39244ab7fcf, 0xbd80d39244ab7fcf, 0xbd80d39244ab7fcf, 0xbd80d39244ab7fcf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd7a5d4c231e5138, 0xbd7a5d4c231e5138, 0xbd7a5d4c231e5138, 0xbd7a5d4c231e5138, 0xbd7a5d4c231e5138, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd84cf2198362ef9, 0xbd84cf2198362ef9, 0xbd84cf2198362ef9, 0xbd84cf2198362ef9, 0xbd84cf2198362ef9, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd72662d7c08f2e4, 0xbd72662d7c08f2e4, 0xbd72662d7c08f2e4, + 0xbd72662d7c08f2e4, 0xbd72662d7c08f2e4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd88cab0ebc0de23, + 0xbd88cab0ebc0de23, 0xbd88cab0ebc0de23, 0xbd88cab0ebc0de23, 0xbd88cab0ebc0de23, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd64de1da9e72921, 0xbd64de1da9e72921, 0xbd64de1da9e72921, 0xbd64de1da9e72921, 0xbd64de1da9e72921, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8cc6403f4b8d4d, 0xbd8cc6403f4b8d4d, 0xbd8cc6403f4b8d4d, 0xbd8cc6403f4b8d4d, 0xbd8cc6403f4b8d4d, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd43bf816ef1b1e3, 0xbd43bf816ef1b1e3, 0xbd43bf816ef1b1e3, + 0xbd43bf816ef1b1e3, 0xbd43bf816ef1b1e3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8f3e306d29c389, + 0x3d8f3e306d29c389, 0x3d8f3e306d29c389, 0x3d8f3e306d29c389, 0x3d8f3e306d29c389, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 12288 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40e808cf28857260, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e83e9be685d450, 0x40e83e9be685d450, + 0x40e83e9be685d450, 0x40e83e9be685d450, 0x40e83e9be685d450, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, + 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e88f4f03866739, 0x40e88f4f03866739, 0x40e88f4f03866739, + 0x40e88f4f03866739, 0x40e88f4f03866739, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8c51bc186c92a, + 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8e0022086fa22, 0x40e8e0022086fa22, 0x40e8e0022086fa22, 0x40e8e0022086fa22, + 0x40e8e0022086fa22, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e915cede875c12, 0x40e915cede875c12, + 0x40e915cede875c12, 0x40e915cede875c12, 0x40e915cede875c12, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, + 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e96681fb87eefb, 0x40e96681fb87eefb, 0x40e96681fb87eefb, + 0x40e96681fb87eefb, 0x40e96681fb87eefb, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e99c4eb98850ec, + 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e9b735188881e4, 0x40e9b735188881e4, 0x40e9b735188881e4, 0x40e9b735188881e4, + 0x40e9b735188881e4, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, + 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, + 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, + 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea7381b189d8ae, + 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, + 0x40ea8e68108a09a6, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, + 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, + 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, + 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb4ab4a98b6070, + 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb659b088b9168, 0x40eb659b088b9168, 0x40eb659b088b9168, 0x40eb659b088b9168, + 0x40eb659b088b9168, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, + 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, + 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, + 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec21e7a18ce832, + 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec3cce008d192a, 0x40ec3cce008d192a, 0x40ec3cce008d192a, 0x40ec3cce008d192a, + 0x40ec3cce008d192a, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, + 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, + 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, + 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecf91a998e6ff4, + 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, + 0x40ed1400f88ea0ed, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, + 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3d55fcb9e4dca05f, 0x3d55fcb9e4dca05f, 0x3d55fcb9e4dca05f, 0x3d55fcb9e4dca05f, 0x3d55fcb9e4dca05f, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8b42a1199f145f, 0x3d8b42a1199f145f, 0x3d8b42a1199f145f, 0x3d8b42a1199f145f, 0x3d8b42a1199f145f, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6aec9a40990cd7, 0x3d6aec9a40990cd7, 0x3d6aec9a40990cd7, + 0x3d6aec9a40990cd7, 0x3d6aec9a40990cd7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d874711c6146535, + 0x3d874711c6146535, 0x3d874711c6146535, 0x3d874711c6146535, 0x3d874711c6146535, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d756d6bc761e4c0, 0x3d756d6bc761e4c0, 0x3d756d6bc761e4c0, 0x3d756d6bc761e4c0, 0x3d756d6bc761e4c0, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d834b827289b60b, 0x3d834b827289b60b, 0x3d834b827289b60b, 0x3d834b827289b60b, 0x3d834b827289b60b, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7d648a6e774314, 0x3d7d648a6e774314, 0x3d7d648a6e774314, + 0x3d7d648a6e774314, 0x3d7d648a6e774314, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7e9fe63dfe0dc2, + 0x3d7e9fe63dfe0dc2, 0x3d7e9fe63dfe0dc2, 0x3d7e9fe63dfe0dc2, 0x3d7e9fe63dfe0dc2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d82add48ac650b4, 0x3d82add48ac650b4, 0x3d82add48ac650b4, 0x3d82add48ac650b4, 0x3d82add48ac650b4, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d76a8c796e8af6e, 0x3d76a8c796e8af6e, 0x3d76a8c796e8af6e, 0x3d76a8c796e8af6e, 0x3d76a8c796e8af6e, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d86a963de50ffde, 0x3d86a963de50ffde, 0x3d86a963de50ffde, + 0x3d86a963de50ffde, 0x3d86a963de50ffde, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6d6351dfa6a235, + 0x3d6d6351dfa6a235, 0x3d6d6351dfa6a235, 0x3d6d6351dfa6a235, 0x3d6d6351dfa6a235, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d8aa4f331dbaf08, 0x3d8aa4f331dbaf08, 0x3d8aa4f331dbaf08, 0x3d8aa4f331dbaf08, 0x3d8aa4f331dbaf08, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d5aea2922f7cb1a, 0x3d5aea2922f7cb1a, 0x3d5aea2922f7cb1a, 0x3d5aea2922f7cb1a, 0x3d5aea2922f7cb1a, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8ea08285665e32, 0x3d8ea08285665e32, 0x3d8ea08285665e32, + 0x3d8ea08285665e32, 0x3d8ea08285665e32, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd33c945e576b8d8, + 0xbd33c945e576b8d8, 0xbd33c945e576b8d8, 0xbd33c945e576b8d8, 0xbd33c945e576b8d8, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd8d63ee270ef2a4, 0xbd8d63ee270ef2a4, 0xbd8d63ee270ef2a4, 0xbd8d63ee270ef2a4, 0xbd8d63ee270ef2a4, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6267660ad993c3, 0xbd6267660ad993c3, 0xbd6267660ad993c3, 0xbd6267660ad993c3, 0xbd6267660ad993c3, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd89685ed384437a, 0xbd89685ed384437a, 0xbd89685ed384437a, + 0xbd89685ed384437a, 0xbd89685ed384437a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd712ad1ac822835, + 0xbd712ad1ac822835, 0xbd712ad1ac822835, 0xbd712ad1ac822835, 0xbd712ad1ac822835, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd856ccf7ff99450, 0xbd856ccf7ff99450, 0xbd856ccf7ff99450, 0xbd856ccf7ff99450, 0xbd856ccf7ff99450, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7921f053978689, 0xbd7921f053978689, 0xbd7921f053978689, 0xbd7921f053978689, 0xbd7921f053978689, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8171402c6ee526, 0xbd8171402c6ee526, 0xbd8171402c6ee526, + 0xbd8171402c6ee526, 0xbd8171402c6ee526, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd808c877d56726f, + 0xbd808c877d56726f, 0xbd808c877d56726f, 0xbd808c877d56726f, 0xbd808c877d56726f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd7aeb61b1c86bf9, 0xbd7aeb61b1c86bf9, 0xbd7aeb61b1c86bf9, 0xbd7aeb61b1c86bf9, 0xbd7aeb61b1c86bf9, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd848816d0e12199, 0xbd848816d0e12199, 0xbd848816d0e12199, 0xbd848816d0e12199, 0xbd848816d0e12199, +] )) ), + +################ chunk 12800 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, + 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edd04d918ff7b6, + 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edeb33f09028af, 0x40edeb33f09028af, 0x40edeb33f09028af, 0x40edeb33f09028af, + 0x40edeb33f09028af, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, + 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, + 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, + 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40eea78089917f79, + 0x40eea78089917f79, 0x40eea78089917f79, 0x40eea78089917f79, 0x40eea78089917f79, 0x40eec266e891b071, 0x40eec266e891b071, 0x40eec266e891b071, 0x40eec266e891b071, + 0x40eec266e891b071, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eef833a6921261, 0x40eef833a6921261, + 0x40eef833a6921261, 0x40eef833a6921261, 0x40eef833a6921261, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, + 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, + 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef7eb38193073b, + 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, + 0x40ef9999e0933833, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efcf669e939a23, 0x40efcf669e939a23, + 0x40efcf669e939a23, 0x40efcf669e939a23, 0x40efcf669e939a23, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, + 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f0100cddca1686, 0x40f0100cddca1686, 0x40f0100cddca1686, + 0x40f0100cddca1686, 0x40f0100cddca1686, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f02af33cca477e, + 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, + 0x40f038666c4a5ffb, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, + 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, + 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f07ba659cada67, 0x40f07ba659cada67, 0x40f07ba659cada67, + 0x40f07ba659cada67, 0x40f07ba659cada67, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f0968cb8cb0b5f, + 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, + 0x40f0a3ffe84b23dc, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, + 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, + 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, + 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f1022634cbcf41, + 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f10f99644be7bd, 0x40f10f99644be7bd, 0x40f10f99644be7bd, 0x40f10f99644be7bd, + 0x40f10f99644be7bd, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, + 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, + 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f152d951cc6229, 0x40f152d951cc6229, 0x40f152d951cc6229, + 0x40f152d951cc6229, 0x40f152d951cc6229, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f16dbfb0cc9322, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd72f4430ab30da5, 0xbd72f4430ab30da5, 0xbd72f4430ab30da5, + 0xbd72f4430ab30da5, 0xbd72f4430ab30da5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8883a6246bd0c3, + 0xbd8883a6246bd0c3, 0xbd8883a6246bd0c3, 0xbd8883a6246bd0c3, 0xbd8883a6246bd0c3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd65fa48c73b5ea1, 0xbd65fa48c73b5ea1, 0xbd65fa48c73b5ea1, 0xbd65fa48c73b5ea1, 0xbd65fa48c73b5ea1, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8c7f3577f67fed, 0xbd8c7f3577f67fed, 0xbd8c7f3577f67fed, 0xbd8c7f3577f67fed, 0xbd8c7f3577f67fed, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd48302de44287e5, 0xbd48302de44287e5, 0xbd48302de44287e5, + 0xbd48302de44287e5, 0xbd48302de44287e5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8f853b347ed0e9, + 0x3d8f853b347ed0e9, 0x3d8f853b347ed0e9, 0x3d8f853b347ed0e9, 0x3d8f853b347ed0e9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d53c463aa34355d, 0x3d53c463aa34355d, 0x3d53c463aa34355d, 0x3d53c463aa34355d, 0x3d53c463aa34355d, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8b89abe0f421bf, 0x3d8b89abe0f421bf, 0x3d8b89abe0f421bf, 0x3d8b89abe0f421bf, 0x3d8b89abe0f421bf, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d69d06f2344d757, 0x3d69d06f2344d757, 0x3d69d06f2344d757, + 0x3d69d06f2344d757, 0x3d69d06f2344d757, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d878e1c8d697295, + 0x3d878e1c8d697295, 0x3d878e1c8d697295, 0x3d878e1c8d697295, 0x3d878e1c8d697295, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d74df5638b7c9ff, 0x3d74df5638b7c9ff, 0x3d74df5638b7c9ff, 0x3d74df5638b7c9ff, 0x3d74df5638b7c9ff, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d83928d39dec36b, 0x3d83928d39dec36b, 0x3d83928d39dec36b, 0x3d83928d39dec36b, 0x3d83928d39dec36b, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7cd674dfcd2853, 0x3d7cd674dfcd2853, 0x3d7cd674dfcd2853, + 0x3d7cd674dfcd2853, 0x3d7cd674dfcd2853, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9834810cd5f5df, + 0xbd9834810cd5f5df, 0xbd9834810cd5f5df, 0xbd9834810cd5f5df, 0xbd9834810cd5f5df, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd96cc9b1e475e56, 0xbd96cc9b1e475e56, 0xbd96cc9b1e475e56, 0xbd96cc9b1e475e56, 0xbd96cc9b1e475e56, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7736dd2592ca2f, 0x3d7736dd2592ca2f, 0x3d7736dd2592ca2f, 0x3d7736dd2592ca2f, 0x3d7736dd2592ca2f, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d86625916fbf27e, 0x3d86625916fbf27e, 0x3d86625916fbf27e, + 0x3d86625916fbf27e, 0x3d86625916fbf27e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9c30106060a509, + 0xbd9c30106060a509, 0xbd9c30106060a509, 0xbd9c30106060a509, 0xbd9c30106060a509, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd92d10bcabcaf2c, 0xbd92d10bcabcaf2c, 0xbd92d10bcabcaf2c, 0xbd92d10bcabcaf2c, 0xbd92d10bcabcaf2c, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d5d227f5da0361b, 0x3d5d227f5da0361b, 0x3d5d227f5da0361b, 0x3d5d227f5da0361b, 0x3d5d227f5da0361b, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8e5977be1150d2, 0x3d8e5977be1150d2, 0x3d8e5977be1150d2, + 0x3d8e5977be1150d2, 0x3d8e5977be1150d2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9fd4604c14abcd, + 0x3d9fd4604c14abcd, 0x3d9fd4604c14abcd, 0x3d9fd4604c14abcd, 0x3d9fd4604c14abcd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd8daaf8ee640004, 0xbd8daaf8ee640004, 0xbd8daaf8ee640004, 0xbd8daaf8ee640004, 0xbd8daaf8ee640004, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd614b3aed855e42, 0xbd614b3aed855e42, 0xbd614b3aed855e42, 0xbd614b3aed855e42, 0xbd614b3aed855e42, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d93284b32935793, 0x3d93284b32935793, 0x3d93284b32935793, + 0x3d93284b32935793, 0x3d93284b32935793, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9bd8d0f889fca3, +] )) ), + +################ chunk 13312 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, + 0x40f17b32e04cab9e, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f196193f4cdc96, 0x40f196193f4cdc96, + 0x40f196193f4cdc96, 0x40f196193f4cdc96, 0x40f196193f4cdc96, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, + 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, + 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1d9592ccd5703, + 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, + 0x40f1e6cc5c4d6f7f, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f201b2bb4da077, 0x40f201b2bb4da077, + 0x40f201b2bb4da077, 0x40f201b2bb4da077, 0x40f201b2bb4da077, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, + 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, + 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f244f2a8ce1ae4, + 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f25265d84e3360, 0x40f25265d84e3360, 0x40f25265d84e3360, 0x40f25265d84e3360, + 0x40f25265d84e3360, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f26d4c374e6458, 0x40f26d4c374e6458, + 0x40f26d4c374e6458, 0x40f26d4c374e6458, 0x40f26d4c374e6458, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, + 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, + 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2b08c24cedec5, + 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2bdff544ef741, 0x40f2bdff544ef741, 0x40f2bdff544ef741, 0x40f2bdff544ef741, + 0x40f2bdff544ef741, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, + 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, + 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, + 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f31c25a0cfa2a6, + 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f32998d04fbb22, 0x40f32998d04fbb22, 0x40f32998d04fbb22, 0x40f32998d04fbb22, + 0x40f32998d04fbb22, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, + 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, + 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, + 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f387bf1cd06687, + 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f395324c507f03, 0x40f395324c507f03, 0x40f395324c507f03, 0x40f395324c507f03, + 0x40f395324c507f03, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3b018ab50affb, 0x40f3b018ab50affb, + 0x40f3b018ab50affb, 0x40f3b018ab50affb, 0x40f3b018ab50affb, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, + 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3d87239d0f970, 0x40f3d87239d0f970, 0x40f3d87239d0f970, + 0x40f3d87239d0f970, 0x40f3d87239d0f970, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3f35898d12a68, + 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f400cbc85142e4, 0x40f400cbc85142e4, 0x40f400cbc85142e4, 0x40f400cbc85142e4, + 0x40f400cbc85142e4, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f41bb2275173dc, 0x40f41bb2275173dc, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d9bd8d0f889fca3, 0x3d9bd8d0f889fca3, 0x3d9bd8d0f889fca3, 0x3d9bd8d0f889fca3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd85b3da474ea1b0, 0xbd85b3da474ea1b0, 0xbd85b3da474ea1b0, 0xbd85b3da474ea1b0, 0xbd85b3da474ea1b0, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7893dac4ed6bc9, 0xbd7893dac4ed6bc9, 0xbd7893dac4ed6bc9, 0xbd7893dac4ed6bc9, 0xbd7893dac4ed6bc9, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9723da861e06bd, 0x3d9723da861e06bd, 0x3d9723da861e06bd, + 0x3d9723da861e06bd, 0x3d9723da861e06bd, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d97dd41a4ff4d79, + 0x3d97dd41a4ff4d79, 0x3d97dd41a4ff4d79, 0x3d97dd41a4ff4d79, 0x3d97dd41a4ff4d79, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd7b7977407286b9, 0xbd7b7977407286b9, 0xbd7b7977407286b9, 0xbd7b7977407286b9, 0xbd7b7977407286b9, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd84410c098c1439, 0xbd84410c098c1439, 0xbd84410c098c1439, 0xbd84410c098c1439, 0xbd84410c098c1439, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9b1f69d9a8b5e7, 0x3d9b1f69d9a8b5e7, 0x3d9b1f69d9a8b5e7, + 0x3d9b1f69d9a8b5e7, 0x3d9b1f69d9a8b5e7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d93e1b251749e4f, + 0x3d93e1b251749e4f, 0x3d93e1b251749e4f, 0x3d93e1b251749e4f, 0x3d93e1b251749e4f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd671673e48f9422, 0xbd671673e48f9422, 0xbd671673e48f9422, 0xbd671673e48f9422, 0xbd671673e48f9422, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8c382ab0a1728d, 0xbd8c382ab0a1728d, 0xbd8c382ab0a1728d, 0xbd8c382ab0a1728d, 0xbd8c382ab0a1728d, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9f1af92d336511, 0x3d9f1af92d336511, 0x3d9f1af92d336511, + 0x3d9f1af92d336511, 0x3d9f1af92d336511, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8fcc45fbd3de49, + 0x3d8fcc45fbd3de49, 0x3d8fcc45fbd3de49, 0x3d8fcc45fbd3de49, 0x3d8fcc45fbd3de49, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d518c0d6f8bca5c, 0x3d518c0d6f8bca5c, 0x3d518c0d6f8bca5c, 0x3d518c0d6f8bca5c, 0x3d518c0d6f8bca5c, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9217a4abdb6870, 0xbd9217a4abdb6870, 0xbd9217a4abdb6870, 0xbd9217a4abdb6870, 0xbd9217a4abdb6870, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9ce9777f41ebc5, 0xbd9ce9777f41ebc5, 0xbd9ce9777f41ebc5, + 0xbd9ce9777f41ebc5, 0xbd9ce9777f41ebc5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d87d52754be7ff6, + 0x3d87d52754be7ff6, 0x3d87d52754be7ff6, 0x3d87d52754be7ff6, 0x3d87d52754be7ff6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d745140aa0daf3f, 0x3d745140aa0daf3f, 0x3d745140aa0daf3f, 0x3d745140aa0daf3f, 0x3d745140aa0daf3f, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd961333ff66179a, 0xbd961333ff66179a, 0xbd961333ff66179a, 0xbd961333ff66179a, 0xbd961333ff66179a, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd98ede82bb73c9b, 0xbd98ede82bb73c9b, 0xbd98ede82bb73c9b, + 0xbd98ede82bb73c9b, 0xbd98ede82bb73c9b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7fbc115b524343, + 0x3d7fbc115b524343, 0x3d7fbc115b524343, 0x3d7fbc115b524343, 0x3d7fbc115b524343, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d821fbefc1c35f3, 0x3d821fbefc1c35f3, 0x3d821fbefc1c35f3, 0x3d821fbefc1c35f3, 0x3d821fbefc1c35f3, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9a0ec352f0c6c4, 0xbd9a0ec352f0c6c4, 0xbd9a0ec352f0c6c4, 0xbd9a0ec352f0c6c4, 0xbd9a0ec352f0c6c4, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd94f258d82c8d71, 0xbd94f258d82c8d71, 0xbd94f258d82c8d71, + 0xbd94f258d82c8d71, 0xbd94f258d82c8d71, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6f9ba81a4f0d36, + 0x3d6f9ba81a4f0d36, 0x3d6f9ba81a4f0d36, 0x3d6f9ba81a4f0d36, 0x3d6f9ba81a4f0d36, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d8a16dda3319447, 0x3d8a16dda3319447, 0x3d8a16dda3319447, 0x3d8a16dda3319447, 0x3d8a16dda3319447, 0xbff0000000000000, 0xbff0000000000000, +] )) ), + +################ chunk 13824 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f41bb2275173dc, 0x40f41bb2275173dc, 0x40f41bb2275173dc, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, + 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, + 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f45ef214d1ee49, + 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f46c65445206c5, 0x40f46c65445206c5, 0x40f46c65445206c5, 0x40f46c65445206c5, + 0x40f46c65445206c5, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f4874ba35237bd, 0x40f4874ba35237bd, + 0x40f4874ba35237bd, 0x40f4874ba35237bd, 0x40f4874ba35237bd, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, + 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4afa531d28132, 0x40f4afa531d28132, 0x40f4afa531d28132, + 0x40f4afa531d28132, 0x40f4afa531d28132, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4ca8b90d2b22a, + 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, + 0x40f4d7fec052caa6, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, + 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, + 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f51b3eadd34513, 0x40f51b3eadd34513, 0x40f51b3eadd34513, + 0x40f51b3eadd34513, 0x40f51b3eadd34513, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f536250cd3760b, + 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f543983c538e87, 0x40f543983c538e87, 0x40f543983c538e87, 0x40f543983c538e87, + 0x40f543983c538e87, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, + 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, + 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f586d829d408f4, 0x40f586d829d408f4, 0x40f586d829d408f4, + 0x40f586d829d408f4, 0x40f586d829d408f4, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5a1be88d439ec, + 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5af31b8545268, 0x40f5af31b8545268, 0x40f5af31b8545268, 0x40f5af31b8545268, + 0x40f5af31b8545268, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5ca1817548361, 0x40f5ca1817548361, + 0x40f5ca1817548361, 0x40f5ca1817548361, 0x40f5ca1817548361, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, + 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, + 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f60d5804d4fdcd, + 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f61acb34551649, 0x40f61acb34551649, 0x40f61acb34551649, 0x40f61acb34551649, + 0x40f61acb34551649, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f635b193554742, 0x40f635b193554742, + 0x40f635b193554742, 0x40f635b193554742, 0x40f635b193554742, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, + 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, + 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f678f180d5c1ae, + 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f68664b055da2a, 0x40f68664b055da2a, 0x40f68664b055da2a, 0x40f68664b055da2a, + 0x40f68664b055da2a, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, + 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, + 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9e0a52a67b75ee, 0xbd9e0a52a67b75ee, 0xbd9e0a52a67b75ee, 0xbd9e0a52a67b75ee, 0xbd9e0a52a67b75ee, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd90f6c984a1de47, 0xbd90f6c984a1de47, 0xbd90f6c984a1de47, + 0xbd90f6c984a1de47, 0xbd90f6c984a1de47, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd0034a0819b066f, + 0xbd0034a0819b066f, 0xbd0034a0819b066f, 0xbd0034a0819b066f, 0xbd0034a0819b066f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d9106fe2523794e, 0x3d9106fe2523794e, 0x3d9106fe2523794e, 0x3d9106fe2523794e, 0x3d9106fe2523794e, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9dfa1e05f9dae8, 0x3d9dfa1e05f9dae8, 0x3d9dfa1e05f9dae8, 0x3d9dfa1e05f9dae8, 0x3d9dfa1e05f9dae8, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd89f674622e5e3b, 0xbd89f674622e5e3b, 0xbd89f674622e5e3b, + 0xbd89f674622e5e3b, 0xbd89f674622e5e3b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd700ea68f2df2b5, + 0xbd700ea68f2df2b5, 0xbd700ea68f2df2b5, 0xbd700ea68f2df2b5, 0xbd700ea68f2df2b5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d95028d78ae2878, 0x3d95028d78ae2878, 0x3d95028d78ae2878, 0x3d95028d78ae2878, 0x3d95028d78ae2878, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d99fe8eb26f2bbe, 0x3d99fe8eb26f2bbe, 0x3d99fe8eb26f2bbe, 0x3d99fe8eb26f2bbe, 0x3d99fe8eb26f2bbe, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd81ff55bb18ffe7, 0xbd81ff55bb18ffe7, 0xbd81ff55bb18ffe7, + 0xbd81ff55bb18ffe7, 0xbd81ff55bb18ffe7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7ffce3dd58af5d, + 0xbd7ffce3dd58af5d, 0xbd7ffce3dd58af5d, 0xbd7ffce3dd58af5d, 0xbd7ffce3dd58af5d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d98fe1ccc38d7a2, 0x3d98fe1ccc38d7a2, 0x3d98fe1ccc38d7a2, 0x3d98fe1ccc38d7a2, 0x3d98fe1ccc38d7a2, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9602ff5ee47c94, 0x3d9602ff5ee47c94, 0x3d9602ff5ee47c94, 0x3d9602ff5ee47c94, 0x3d9602ff5ee47c94, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd74106e28074325, 0xbd74106e28074325, 0xbd74106e28074325, + 0xbd74106e28074325, 0xbd74106e28074325, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd87f59095c1b602, + 0xbd87f59095c1b602, 0xbd87f59095c1b602, 0xbd87f59095c1b602, 0xbd87f59095c1b602, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d9cf9ac1fc386cc, 0x3d9cf9ac1fc386cc, 0x3d9cf9ac1fc386cc, 0x3d9cf9ac1fc386cc, 0x3d9cf9ac1fc386cc, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9207700b59cd6a, 0x3d9207700b59cd6a, 0x3d9207700b59cd6a, 0x3d9207700b59cd6a, 0x3d9207700b59cd6a, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5088c3677219f5, 0xbd5088c3677219f5, 0xbd5088c3677219f5, + 0xbd5088c3677219f5, 0xbd5088c3677219f5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8fecaf3cd71456, + 0xbd8fecaf3cd71456, 0xbd8fecaf3cd71456, 0xbd8fecaf3cd71456, 0xbd8fecaf3cd71456, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd9f0ac48cb1ca0a, 0xbd9f0ac48cb1ca0a, 0xbd9f0ac48cb1ca0a, 0xbd9f0ac48cb1ca0a, 0xbd9f0ac48cb1ca0a, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8c17c16f9e3c80, 0x3d8c17c16f9e3c80, 0x3d8c17c16f9e3c80, 0x3d8c17c16f9e3c80, 0x3d8c17c16f9e3c80, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d679818e89c6c55, 0x3d679818e89c6c55, 0x3d679818e89c6c55, + 0x3d679818e89c6c55, 0x3d679818e89c6c55, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd93f1e6f1f63955, + 0xbd93f1e6f1f63955, 0xbd93f1e6f1f63955, 0xbd93f1e6f1f63955, 0xbd93f1e6f1f63955, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd9b0f3539271ae0, 0xbd9b0f3539271ae0, 0xbd9b0f3539271ae0, 0xbd9b0f3539271ae0, 0xbd9b0f3539271ae0, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8420a2c888de2c, 0x3d8420a2c888de2c, 0x3d8420a2c888de2c, 0x3d8420a2c888de2c, 0x3d8420a2c888de2c, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7bba49c278f2d3, 0x3d7bba49c278f2d3, 0x3d7bba49c278f2d3, +] )) ), + +################ chunk 14336 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6e48afcd6858f, + 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, + 0x40f6f1fe2c569e0c, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, + 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, + 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f7353e19d71878, 0x40f7353e19d71878, 0x40f7353e19d71878, + 0x40f7353e19d71878, 0x40f7353e19d71878, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f7502478d74970, + 0x40f7502478d74970, 0x40f7502478d74970, 0x40f7502478d74970, 0x40f7502478d74970, 0x40f75d97a85761ed, 0x40f75d97a85761ed, 0x40f75d97a85761ed, 0x40f75d97a85761ed, + 0x40f75d97a85761ed, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f7787e075792e5, 0x40f7787e075792e5, + 0x40f7787e075792e5, 0x40f7787e075792e5, 0x40f7787e075792e5, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, + 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, + 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7bbbdf4d80d51, + 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7c931245825ce, 0x40f7c931245825ce, 0x40f7c931245825ce, 0x40f7c931245825ce, + 0x40f7c931245825ce, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7e417835856c6, 0x40f7e417835856c6, + 0x40f7e417835856c6, 0x40f7e417835856c6, 0x40f7e417835856c6, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, + 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, + 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f8275770d8d133, + 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f834caa058e9af, 0x40f834caa058e9af, 0x40f834caa058e9af, 0x40f834caa058e9af, + 0x40f834caa058e9af, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, + 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, + 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, + 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f892f0ecd99514, + 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, + 0x40f8a0641c59ad90, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, + 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, + 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, + 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8fe8a68da58f5, + 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f90bfd985a7171, 0x40f90bfd985a7171, 0x40f90bfd985a7171, 0x40f90bfd985a7171, + 0x40f90bfd985a7171, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f926e3f75aa269, 0x40f926e3f75aa269, + 0x40f926e3f75aa269, 0x40f926e3f75aa269, 0x40f926e3f75aa269, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, + 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, + 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f96a23e4db1cd6, + 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f97797145b3552, 0x40f97797145b3552, 0x40f97797145b3552, 0x40f97797145b3552, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d7bba49c278f2d3, 0x3d7bba49c278f2d3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd97ed764580e87f, + 0xbd97ed764580e87f, 0xbd97ed764580e87f, 0xbd97ed764580e87f, 0xbd97ed764580e87f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd9713a5e59c6bb6, 0xbd9713a5e59c6bb6, 0xbd9713a5e59c6bb6, 0xbd9713a5e59c6bb6, 0xbd9713a5e59c6bb6, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d78530842e6ffaf, 0x3d78530842e6ffaf, 0x3d78530842e6ffaf, 0x3d78530842e6ffaf, 0x3d78530842e6ffaf, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d85d4438851d7bd, 0x3d85d4438851d7bd, 0x3d85d4438851d7bd, + 0x3d85d4438851d7bd, 0x3d85d4438851d7bd, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9be905990b97a9, + 0xbd9be905990b97a9, 0xbd9be905990b97a9, 0xbd9be905990b97a9, 0xbd9be905990b97a9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd9318169211bc8c, 0xbd9318169211bc8c, 0xbd9318169211bc8c, 0xbd9318169211bc8c, 0xbd9318169211bc8c, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d60c995e978860f, 0x3d60c995e978860f, 0x3d60c995e978860f, 0x3d60c995e978860f, 0x3d60c995e978860f, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8dcb622f673611, 0x3d8dcb622f673611, 0x3d8dcb622f673611, + 0x3d8dcb622f673611, 0x3d8dcb622f673611, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9fe494ec9646d3, + 0xbd9fe494ec9646d3, 0xbd9fe494ec9646d3, 0xbd9fe494ec9646d3, 0xbd9fe494ec9646d3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd8e390e7d0e1ac5, 0xbd8e390e7d0e1ac5, 0xbd8e390e7d0e1ac5, 0xbd8e390e7d0e1ac5, 0xbd8e390e7d0e1ac5, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd5e25c965b9e682, 0xbd5e25c965b9e682, 0xbd5e25c965b9e682, 0xbd5e25c965b9e682, 0xbd5e25c965b9e682, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d92e1406b3e4a33, 0x3d92e1406b3e4a33, 0x3d92e1406b3e4a33, + 0x3d92e1406b3e4a33, 0x3d92e1406b3e4a33, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9c1fdbbfdf0a03, + 0x3d9c1fdbbfdf0a03, 0x3d9c1fdbbfdf0a03, 0x3d9c1fdbbfdf0a03, 0x3d9c1fdbbfdf0a03, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd8641efd5f8bc71, 0xbd8641efd5f8bc71, 0xbd8641efd5f8bc71, 0xbd8641efd5f8bc71, 0xbd8641efd5f8bc71, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7777afa7993648, 0xbd7777afa7993648, 0xbd7777afa7993648, 0xbd7777afa7993648, 0xbd7777afa7993648, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d96dccfbec8f95d, 0x3d96dccfbec8f95d, 0x3d96dccfbec8f95d, + 0x3d96dccfbec8f95d, 0x3d96dccfbec8f95d, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d98244c6c545ad9, + 0x3d98244c6c545ad9, 0x3d98244c6c545ad9, 0x3d98244c6c545ad9, 0x3d98244c6c545ad9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd7c95a25dc6bc3a, 0xbd7c95a25dc6bc3a, 0xbd7c95a25dc6bc3a, 0xbd7c95a25dc6bc3a, 0xbd7c95a25dc6bc3a, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd83b2f67ae1f978, 0xbd83b2f67ae1f978, 0xbd83b2f67ae1f978, 0xbd83b2f67ae1f978, 0xbd83b2f67ae1f978, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9ad85f1253a887, 0x3d9ad85f1253a887, 0x3d9ad85f1253a887, + 0x3d9ad85f1253a887, 0x3d9ad85f1253a887, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9428bd18c9abaf, + 0x3d9428bd18c9abaf, 0x3d9428bd18c9abaf, 0x3d9428bd18c9abaf, 0x3d9428bd18c9abaf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd694eca1f37ff23, 0xbd694eca1f37ff23, 0xbd694eca1f37ff23, 0xbd694eca1f37ff23, 0xbd694eca1f37ff23, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8baa1521f757cc, 0xbd8baa1521f757cc, 0xbd8baa1521f757cc, 0xbd8baa1521f757cc, 0xbd8baa1521f757cc, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9ed3ee65de57b1, 0x3d9ed3ee65de57b1, 0x3d9ed3ee65de57b1, + 0x3d9ed3ee65de57b1, 0x3d9ed3ee65de57b1, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d902d2dc53efc85, + 0x3d902d2dc53efc85, 0x3d902d2dc53efc85, 0x3d902d2dc53efc85, 0x3d902d2dc53efc85, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 14848 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40f97797145b3552, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9927d735b664a, 0x40f9927d735b664a, + 0x40f9927d735b664a, 0x40f9927d735b664a, 0x40f9927d735b664a, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, + 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, + 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9d5bd60dbe0b7, + 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9e330905bf933, 0x40f9e330905bf933, 0x40f9e330905bf933, 0x40f9e330905bf933, + 0x40f9e330905bf933, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, + 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, + 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, + 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa4156dcdca498, + 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, + 0x40fa4eca0c5cbd14, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, + 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, + 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, + 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40faacf058dd6879, + 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faba63885d80f5, 0x40faba63885d80f5, 0x40faba63885d80f5, 0x40faba63885d80f5, + 0x40faba63885d80f5, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fad549e75db1ed, 0x40fad549e75db1ed, + 0x40fad549e75db1ed, 0x40fad549e75db1ed, 0x40fad549e75db1ed, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, + 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40fafda375ddfb62, 0x40fafda375ddfb62, 0x40fafda375ddfb62, + 0x40fafda375ddfb62, 0x40fafda375ddfb62, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb1889d4de2c5a, + 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, + 0x40fb25fd045e44d6, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, + 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, + 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb693cf1debf43, 0x40fb693cf1debf43, 0x40fb693cf1debf43, + 0x40fb693cf1debf43, 0x40fb693cf1debf43, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb842350def03b, + 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb9196805f08b7, 0x40fb9196805f08b7, 0x40fb9196805f08b7, 0x40fb9196805f08b7, + 0x40fb9196805f08b7, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, + 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, + 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, + 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbefbcccdfb41c, + 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, + 0x40fbfd2ffc5fcc98, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, + 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3d4a36c1f475e8b3, 0x3d4a36c1f475e8b3, 0x3d4a36c1f475e8b3, 0x3d4a36c1f475e8b3, 0x3d4a36c1f475e8b3, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd91d099e4865b10, 0xbd91d099e4865b10, 0xbd91d099e4865b10, 0xbd91d099e4865b10, 0xbd91d099e4865b10, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9d30824696f925, 0xbd9d30824696f925, 0xbd9d30824696f925, + 0xbd9d30824696f925, 0xbd9d30824696f925, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d88633ce3689ab6, + 0x3d88633ce3689ab6, 0x3d88633ce3689ab6, 0x3d88633ce3689ab6, 0x3d88633ce3689ab6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d7335158cb979be, 0x3d7335158cb979be, 0x3d7335158cb979be, 0x3d7335158cb979be, 0x3d7335158cb979be, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd95cc2938110a3a, 0xbd95cc2938110a3a, 0xbd95cc2938110a3a, 0xbd95cc2938110a3a, 0xbd95cc2938110a3a, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9934f2f30c49fb, 0xbd9934f2f30c49fb, 0xbd9934f2f30c49fb, + 0xbd9934f2f30c49fb, 0xbd9934f2f30c49fb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d806c1e3c533c62, + 0x3d806c1e3c533c62, 0x3d806c1e3c533c62, 0x3d806c1e3c533c62, 0x3d806c1e3c533c62, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d8191a96d721b33, 0x3d8191a96d721b33, 0x3d8191a96d721b33, 0x3d8191a96d721b33, 0x3d8191a96d721b33, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd99c7b88b9bb964, 0xbd99c7b88b9bb964, 0xbd99c7b88b9bb964, 0xbd99c7b88b9bb964, 0xbd99c7b88b9bb964, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9539639f819ad1, 0xbd9539639f819ad1, 0xbd9539639f819ad1, + 0xbd9539639f819ad1, 0xbd9539639f819ad1, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d70e9ff2a7bbc1c, + 0x3d70e9ff2a7bbc1c, 0x3d70e9ff2a7bbc1c, 0x3d70e9ff2a7bbc1c, 0x3d70e9ff2a7bbc1c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d8988c814877987, 0x3d8988c814877987, 0x3d8988c814877987, 0x3d8988c814877987, 0x3d8988c814877987, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9dc347df26688e, 0xbd9dc347df26688e, 0xbd9dc347df26688e, 0xbd9dc347df26688e, 0xbd9dc347df26688e, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd913dd44bf6eba7, 0xbd913dd44bf6eba7, 0xbd913dd44bf6eba7, + 0xbd913dd44bf6eba7, 0xbd913dd44bf6eba7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d2f783b8a1fee79, + 0x3d2f783b8a1fee79, 0x3d2f783b8a1fee79, 0x3d2f783b8a1fee79, 0x3d2f783b8a1fee79, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d90bff35dce6bee, 0x3d90bff35dce6bee, 0x3d90bff35dce6bee, 0x3d90bff35dce6bee, 0x3d90bff35dce6bee, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9e4128cd4ee848, 0x3d9e4128cd4ee848, 0x3d9e4128cd4ee848, 0x3d9e4128cd4ee848, 0x3d9e4128cd4ee848, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8a8489f0d878fb, 0xbd8a8489f0d878fb, 0xbd8a8489f0d878fb, + 0xbd8a8489f0d878fb, 0xbd8a8489f0d878fb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6de4f6e3b37a68, + 0xbd6de4f6e3b37a68, 0xbd6de4f6e3b37a68, 0xbd6de4f6e3b37a68, 0xbd6de4f6e3b37a68, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d94bb82b1591b18, 0x3d94bb82b1591b18, 0x3d94bb82b1591b18, 0x3d94bb82b1591b18, 0x3d94bb82b1591b18, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9a459979c4391e, 0x3d9a459979c4391e, 0x3d9a459979c4391e, 0x3d9a459979c4391e, 0x3d9a459979c4391e, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd828d6b49c31aa7, 0xbd828d6b49c31aa7, 0xbd828d6b49c31aa7, + 0xbd828d6b49c31aa7, 0xbd828d6b49c31aa7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7ee0b8c00479dc, + 0xbd7ee0b8c00479dc, 0xbd7ee0b8c00479dc, 0xbd7ee0b8c00479dc, 0xbd7ee0b8c00479dc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d98b71204e3ca42, 0x3d98b71204e3ca42, 0x3d98b71204e3ca42, 0x3d98b71204e3ca42, 0x3d98b71204e3ca42, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d964a0a263989f4, 0x3d964a0a263989f4, 0x3d964a0a263989f4, 0x3d964a0a263989f4, 0x3d964a0a263989f4, +] )) ), + +################ chunk 15360 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc406fe9e04705, 0x40fc406fe9e04705, 0x40fc406fe9e04705, + 0x40fc406fe9e04705, 0x40fc406fe9e04705, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc5b5648e077fd, + 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc68c978609079, 0x40fc68c978609079, 0x40fc68c978609079, 0x40fc68c978609079, + 0x40fc68c978609079, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc83afd760c172, 0x40fc83afd760c172, + 0x40fc83afd760c172, 0x40fc83afd760c172, 0x40fc83afd760c172, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, + 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, + 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcc6efc4e13bde, + 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcd462f461545a, 0x40fcd462f461545a, 0x40fcd462f461545a, 0x40fcd462f461545a, + 0x40fcd462f461545a, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fcef4953618553, 0x40fcef4953618553, + 0x40fcef4953618553, 0x40fcef4953618553, 0x40fcef4953618553, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, + 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, + 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd328940e1ffbf, + 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, + 0x40fd3ffc7062183b, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, + 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, + 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd833c5de292a8, 0x40fd833c5de292a8, 0x40fd833c5de292a8, + 0x40fd833c5de292a8, 0x40fd833c5de292a8, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd9e22bce2c3a0, + 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, + 0x40fdab95ec62dc1d, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, + 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, + 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, + 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fe09bc38e38781, + 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe172f68639ffe, 0x40fe172f68639ffe, 0x40fe172f68639ffe, 0x40fe172f68639ffe, + 0x40fe172f68639ffe, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, + 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, + 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, + 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe7555b4e44b62, + 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe82c8e46463df, 0x40fe82c8e46463df, 0x40fe82c8e46463df, 0x40fe82c8e46463df, + 0x40fe82c8e46463df, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe9daf436494d7, 0x40fe9daf436494d7, + 0x40fe9daf436494d7, 0x40fe9daf436494d7, 0x40fe9daf436494d7, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, + 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, + 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fee0ef30e50f44, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd752c99455b78a6, 0xbd752c99455b78a6, 0xbd752c99455b78a6, + 0xbd752c99455b78a6, 0xbd752c99455b78a6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd87677b07179b42, + 0xbd87677b07179b42, 0xbd87677b07179b42, 0xbd87677b07179b42, 0xbd87677b07179b42, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d9cb2a1586e796c, 0x3d9cb2a1586e796c, 0x3d9cb2a1586e796c, 0x3d9cb2a1586e796c, 0x3d9cb2a1586e796c, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d924e7ad2aedaca, 0x3d924e7ad2aedaca, 0x3d924e7ad2aedaca, 0x3d924e7ad2aedaca, 0x3d924e7ad2aedaca, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd54f96fdcc2eff8, 0xbd54f96fdcc2eff8, 0xbd54f96fdcc2eff8, + 0xbd54f96fdcc2eff8, 0xbd54f96fdcc2eff8, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8f5e99ae2cf996, + 0xbd8f5e99ae2cf996, 0xbd8f5e99ae2cf996, 0xbd8f5e99ae2cf996, 0xbd8f5e99ae2cf996, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd9f51cf5406d76a, 0xbd9f51cf5406d76a, 0xbd9f51cf5406d76a, 0xbd9f51cf5406d76a, 0xbd9f51cf5406d76a, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8ca5d6fe485740, 0x3d8ca5d6fe485740, 0x3d8ca5d6fe485740, 0x3d8ca5d6fe485740, 0x3d8ca5d6fe485740, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d655fc2adf40154, 0x3d655fc2adf40154, 0x3d655fc2adf40154, + 0x3d655fc2adf40154, 0x3d655fc2adf40154, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd93aadc2aa12bf5, + 0xbd93aadc2aa12bf5, 0xbd93aadc2aa12bf5, 0xbd93aadc2aa12bf5, 0xbd93aadc2aa12bf5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd9b5640007c2840, 0xbd9b5640007c2840, 0xbd9b5640007c2840, 0xbd9b5640007c2840, 0xbd9b5640007c2840, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d84aeb85732f8ec, 0x3d84aeb85732f8ec, 0x3d84aeb85732f8ec, 0x3d84aeb85732f8ec, 0x3d84aeb85732f8ec, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7a9e1ea524bd52, 0x3d7a9e1ea524bd52, 0x3d7a9e1ea524bd52, + 0x3d7a9e1ea524bd52, 0x3d7a9e1ea524bd52, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd97a66b7e2bdb1f, + 0xbd97a66b7e2bdb1f, 0xbd97a66b7e2bdb1f, 0xbd97a66b7e2bdb1f, 0xbd97a66b7e2bdb1f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd975ab0acf17917, 0xbd975ab0acf17917, 0xbd975ab0acf17917, 0xbd975ab0acf17917, 0xbd975ab0acf17917, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d796f33603b3530, 0x3d796f33603b3530, 0x3d796f33603b3530, 0x3d796f33603b3530, 0x3d796f33603b3530, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d85462df9a7bcfd, 0x3d85462df9a7bcfd, 0x3d85462df9a7bcfd, + 0x3d85462df9a7bcfd, 0x3d85462df9a7bcfd, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9ba1fad1b68a49, + 0xbd9ba1fad1b68a49, 0xbd9ba1fad1b68a49, 0xbd9ba1fad1b68a49, 0xbd9ba1fad1b68a49, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd935f215966c9ed, 0xbd935f215966c9ed, 0xbd935f215966c9ed, 0xbd935f215966c9ed, 0xbd935f215966c9ed, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6301ec2420f110, 0x3d6301ec2420f110, 0x3d6301ec2420f110, 0x3d6301ec2420f110, 0x3d6301ec2420f110, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8d3d4ca0bd1b51, 0x3d8d3d4ca0bd1b51, 0x3d8d3d4ca0bd1b51, + 0x3d8d3d4ca0bd1b51, 0x3d8d3d4ca0bd1b51, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9f9d8a25413973, + 0xbd9f9d8a25413973, 0xbd9f9d8a25413973, 0xbd9f9d8a25413973, 0xbd9f9d8a25413973, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd8ec7240bb83585, 0xbd8ec7240bb83585, 0xbd8ec7240bb83585, 0xbd8ec7240bb83585, 0xbd8ec7240bb83585, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd59b51cf0691080, 0xbd59b51cf0691080, 0xbd59b51cf0691080, 0xbd59b51cf0691080, 0xbd59b51cf0691080, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d929a35a3e93cd2, 0x3d929a35a3e93cd2, 0x3d929a35a3e93cd2, + 0x3d929a35a3e93cd2, 0x3d929a35a3e93cd2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9c66e687341763, +] )) ), + +################ chunk 15872 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40feee62606527c0, 0x40feee62606527c0, 0x40feee62606527c0, 0x40feee62606527c0, + 0x40feee62606527c0, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, + 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, + 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, + 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff4c88ace5d325, + 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, + 0x40ff59fbdc65eba1, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff74e23b661c99, 0x40ff74e23b661c99, + 0x40ff74e23b661c99, 0x40ff74e23b661c99, 0x40ff74e23b661c99, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, + 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, + 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffb82228e69706, + 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffc5955866af82, 0x40ffc5955866af82, 0x40ffc5955866af82, 0x40ffc5955866af82, + 0x40ffc5955866af82, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, + 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, + 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x4100046aa2f394f7, 0x4100046aa2f394f7, 0x4100046aa2f394f7, + 0x4100046aa2f394f7, 0x4100046aa2f394f7, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x410011ddd273ad73, + 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410018976a33b9b1, 0x410018976a33b9b1, 0x410018976a33b9b1, 0x410018976a33b9b1, + 0x410018976a33b9b1, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x4100260a99b3d22e, 0x4100260a99b3d22e, + 0x4100260a99b3d22e, 0x4100260a99b3d22e, 0x4100260a99b3d22e, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, + 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, + 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410047aa90740f64, + 0x410047aa90740f64, 0x410047aa90740f64, 0x410047aa90740f64, 0x410047aa90740f64, 0x41004e6428341ba2, 0x41004e6428341ba2, 0x41004e6428341ba2, 0x41004e6428341ba2, + 0x41004e6428341ba2, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x41005bd757b4341e, 0x41005bd757b4341e, + 0x41005bd757b4341e, 0x41005bd757b4341e, 0x41005bd757b4341e, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, + 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x410070041ef458d8, 0x410070041ef458d8, 0x410070041ef458d8, + 0x410070041ef458d8, 0x410070041ef458d8, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x41007d774e747154, + 0x41007d774e747154, 0x41007d774e747154, 0x41007d774e747154, 0x41007d774e747154, 0x41008430e6347d93, 0x41008430e6347d93, 0x41008430e6347d93, 0x41008430e6347d93, + 0x41008430e6347d92, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x410091a415b4960f, 0x410091a415b4960f, + 0x410091a415b4960f, 0x410091a415b4960f, 0x410091a415b4960f, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, + 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, + 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100b3440c74d345, + 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b9fda434df83, 0x4100b9fda434df83, 0x4100b9fda434df83, 0x4100b9fda434df83, + 0x4100b9fda434df83, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3d9c66e687341763, 0x3d9c66e687341763, 0x3d9c66e687341763, 0x3d9c66e687341763, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd86d00564a2d731, 0xbd86d00564a2d731, 0xbd86d00564a2d731, 0xbd86d00564a2d731, 0xbd86d00564a2d731, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd765b848a4500c8, 0xbd765b848a4500c8, 0xbd765b848a4500c8, 0xbd765b848a4500c8, 0xbd765b848a4500c8, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9695c4f773ebfc, 0x3d9695c4f773ebfc, 0x3d9695c4f773ebfc, + 0x3d9695c4f773ebfc, 0x3d9695c4f773ebfc, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d986b5733a96839, + 0x3d986b5733a96839, 0x3d986b5733a96839, 0x3d986b5733a96839, 0x3d986b5733a96839, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd7db1cd7b1af1ba, 0xbd7db1cd7b1af1ba, 0xbd7db1cd7b1af1ba, 0xbd7db1cd7b1af1ba, 0xbd7db1cd7b1af1ba, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8324e0ec37deb8, 0xbd8324e0ec37deb8, 0xbd8324e0ec37deb8, 0xbd8324e0ec37deb8, 0xbd8324e0ec37deb8, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9a91544afe9b26, 0x3d9a91544afe9b26, 0x3d9a91544afe9b26, + 0x3d9a91544afe9b26, 0x3d9a91544afe9b26, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d946fc7e01eb90f, + 0x3d946fc7e01eb90f, 0x3d946fc7e01eb90f, 0x3d946fc7e01eb90f, 0x3d946fc7e01eb90f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd6b872059e06a24, 0xbd6b872059e06a24, 0xbd6b872059e06a24, 0xbd6b872059e06a24, 0xbd6b872059e06a24, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8b1bff934d3d0c, 0xbd8b1bff934d3d0c, 0xbd8b1bff934d3d0c, 0xbd8b1bff934d3d0c, 0xbd8b1bff934d3d0c, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9e8ce39e894a50, 0x3d9e8ce39e894a50, 0x3d9e8ce39e894a50, + 0x3d9e8ce39e894a50, 0x3d9e8ce39e894a50, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda7c5e3b9b5fb0d, + 0xbda7c5e3b9b5fb0d, 0xbda7c5e3b9b5fb0d, 0xbda7c5e3b9b5fb0d, 0xbda7c5e3b9b5fb0d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbdafbaaa5bd8af0d, 0xbdafbaaa5bd8af0d, 0xbdafbaaa5bd8af0d, 0xbdafbaaa5bd8af0d, 0xbdafbaaa5bd8af0d, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da73b3871675928, 0x3da73b3871675928, 0x3da73b3871675928, 0x3da73b3871675928, 0x3da73b3871675928, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9d778d0dec0686, 0xbd9d778d0dec0686, 0xbd9d778d0dec0686, + 0xbd9d778d0dec0686, 0xbd9d778d0dec0686, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d88f1527212b576, + 0x3d88f1527212b576, 0x3d88f1527212b576, 0x3d88f1527212b576, 0x3d88f1527212b576, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d7218ea6f65443e, 0x3d7218ea6f65443e, 0x3d7218ea6f65443e, 0x3d7218ea6f65443e, 0x3d7218ea6f65443e, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd95851e70bbfcda, 0xbd95851e70bbfcda, 0xbd95851e70bbfcda, 0xbd95851e70bbfcda, 0xbd95851e70bbfcda, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3da3420122cf5452, 0x3da3420122cf5452, 0x3da3420122cf5452, + 0x3da3420122cf5452, 0x3da3420122cf5452, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdabc1730d40aa37, + 0xbdabc1730d40aa37, 0xbdabc1730d40aa37, 0xbdabc1730d40aa37, 0xbdabc1730d40aa37, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbdabbf1b084dffe3, 0xbdabbf1b084dffe3, 0xbdabbf1b084dffe3, 0xbdabbf1b084dffe3, 0xbdabbf1b084dffe3, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da33fa91ddca9fe, 0x3da33fa91ddca9fe, 0x3da33fa91ddca9fe, 0x3da33fa91ddca9fe, 0x3da33fa91ddca9fe, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd95806e66d6a832, 0xbd95806e66d6a832, 0xbd95806e66d6a832, + 0xbd95806e66d6a832, 0xbd95806e66d6a832, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d72062a47cff19c, + 0x3d72062a47cff19c, 0x3d72062a47cff19c, 0x3d72062a47cff19c, 0x3d72062a47cff19c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d88fab285dd5ec7, 0x3d88fab285dd5ec7, 0x3d88fab285dd5ec7, 0x3d88fab285dd5ec7, 0x3d88fab285dd5ec7, 0xbff0000000000000, 0xbff0000000000000, +] )) ), + +################ chunk 16384 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, + 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, + 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e910ca753535, + 0x4100e910ca753535, 0x4100e910ca753535, 0x4100e910ca753535, 0x4100e910ca753535, 0x4100efca62354174, 0x4100efca62354174, 0x4100efca62354174, 0x4100efca62354174, + 0x4100efca62354174, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, + 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, + 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x4101116a58f57eaa, 0x4101116a58f57eaa, 0x4101116a58f57eaa, + 0x4101116a58f57eaa, 0x4101116a58f57eaa, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011edd88759726, + 0x41011edd88759726, 0x41011edd88759726, 0x41011edd88759726, 0x41011edd88759726, 0x410125972035a364, 0x410125972035a364, 0x410125972035a364, 0x410125972035a364, + 0x410125972035a364, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, + 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, + 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101473716f5e09a, 0x4101473716f5e09a, 0x4101473716f5e09a, + 0x4101473716f5e09a, 0x4101473716f5e09a, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x410154aa4675f917, + 0x410154aa4675f917, 0x410154aa4675f917, 0x410154aa4675f917, 0x410154aa4675f917, 0x41015b63de360555, 0x41015b63de360555, 0x41015b63de360555, 0x41015b63de360555, + 0x41015b63de360555, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x410168d70db61dd1, 0x410168d70db61dd1, + 0x410168d70db61dd1, 0x410168d70db61dd1, 0x410168d70db61dd1, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, + 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x41017d03d4f6428b, 0x41017d03d4f6428b, 0x41017d03d4f6428b, + 0x41017d03d4f6428b, 0x41017d03d4f6428b, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x41018a7704765b07, + 0x41018a7704765b07, 0x41018a7704765b07, 0x41018a7704765b07, 0x41018a7704765b07, 0x410191309c366745, 0x410191309c366745, 0x410191309c366745, 0x410191309c366745, + 0x410191309c366745, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, + 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, + 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, + 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101c043c276bcf8, + 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, + 0x4101c6fd5a36c936, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, + 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, + 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e89d50f7066c, 0x4101e89d50f7066c, 0x4101e89d50f7066c, + 0x4101e89d50f7066c, 0x4101e89d50f7066c, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101f61080771ee8, + 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101fcca18372b26, 0x4101fcca18372b26, 0x4101fcca18372b26, 0x4101fcca18372b26, + 0x4101fcca18372b26, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020a3d47b743a2, 0x41020a3d47b743a2, + 0x41020a3d47b743a2, 0x41020a3d47b743a2, 0x41020a3d47b743a2, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, + 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9d7c3d17d15b2e, 0xbd9d7c3d17d15b2e, 0xbd9d7c3d17d15b2e, 0xbd9d7c3d17d15b2e, 0xbd9d7c3d17d15b2e, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3da73d90765a037c, 0x3da73d90765a037c, 0x3da73d90765a037c, + 0x3da73d90765a037c, 0x3da73d90765a037c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdafbd0260cb5961, + 0xbdafbd0260cb5961, 0xbdafbd0260cb5961, 0xbdafbd0260cb5961, 0xbdafbd0260cb5961, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbda7c38bb4c350b9, 0xbda7c38bb4c350b9, 0xbda7c38bb4c350b9, 0xbda7c38bb4c350b9, 0xbda7c38bb4c350b9, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9e883394a3f5a8, 0x3d9e883394a3f5a8, 0x3d9e883394a3f5a8, 0x3d9e883394a3f5a8, 0x3d9e883394a3f5a8, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8b129f7f8293bb, 0xbd8b129f7f8293bb, 0xbd8b129f7f8293bb, + 0xbd8b129f7f8293bb, 0xbd8b129f7f8293bb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6baca0a90b0f67, + 0xbd6baca0a90b0f67, 0xbd6baca0a90b0f67, 0xbd6baca0a90b0f67, 0xbd6baca0a90b0f67, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d947477ea040db7, 0x3d947477ea040db7, 0x3d947477ea040db7, 0x3d947477ea040db7, 0x3d947477ea040db7, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda2b9addf735cc1, 0xbda2b9addf735cc1, 0xbda2b9addf735cc1, 0xbda2b9addf735cc1, 0xbda2b9addf735cc1, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3dab391fc9e4b2a6, 0x3dab391fc9e4b2a6, 0x3dab391fc9e4b2a6, + 0x3dab391fc9e4b2a6, 0x3dab391fc9e4b2a6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3dac476e4ba9f775, + 0x3dac476e4ba9f775, 0x3dac476e4ba9f775, 0x3dac476e4ba9f775, 0x3dac476e4ba9f775, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbda3c7fc6138a18f, 0xbda3c7fc6138a18f, 0xbda3c7fc6138a18f, 0xbda3c7fc6138a18f, 0xbda3c7fc6138a18f, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d969114ed8e9754, 0x3d969114ed8e9754, 0x3d969114ed8e9754, 0x3d969114ed8e9754, 0x3d969114ed8e9754, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7648c462afae27, 0xbd7648c462afae27, 0xbd7648c462afae27, + 0xbd7648c462afae27, 0xbd7648c462afae27, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd86d965786d8082, + 0xbd86d965786d8082, 0xbd86d965786d8082, 0xbd86d965786d8082, 0xbd86d965786d8082, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3d9c6b9691196c0b, 0x3d9c6b9691196c0b, 0x3d9c6b9691196c0b, 0x3d9c6b9691196c0b, 0x3d9c6b9691196c0b, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda6b53d32fe0beb, 0xbda6b53d32fe0beb, 0xbda6b53d32fe0beb, 0xbda6b53d32fe0beb, 0xbda6b53d32fe0beb, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3daf34af1d6f61d0, 0x3daf34af1d6f61d0, 0x3daf34af1d6f61d0, + 0x3daf34af1d6f61d0, 0x3daf34af1d6f61d0, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da84bdef81f484b, + 0x3da84bdef81f484b, 0x3da84bdef81f484b, 0x3da84bdef81f484b, 0x3da84bdef81f484b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd9f98da1b5be4cb, 0xbd9f98da1b5be4cb, 0xbd9f98da1b5be4cb, 0xbd9f98da1b5be4cb, 0xbd9f98da1b5be4cb, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8d33ec8cf27200, 0x3d8d33ec8cf27200, 0x3d8d33ec8cf27200, 0x3d8d33ec8cf27200, 0x3d8d33ec8cf27200, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d63276c734b9653, 0x3d63276c734b9653, 0x3d63276c734b9653, + 0x3d63276c734b9653, 0x3d63276c734b9653, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9363d1634c1e95, + 0xbd9363d1634c1e95, 0xbd9363d1634c1e95, 0xbd9363d1634c1e95, 0xbd9363d1634c1e95, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3da2315a9c176530, 0x3da2315a9c176530, 0x3da2315a9c176530, 0x3da2315a9c176530, 0x3da2315a9c176530, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdaab0cc8688bb15, 0xbdaab0cc8688bb15, 0xbdaab0cc8688bb15, 0xbdaab0cc8688bb15, 0xbdaab0cc8688bb15, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbdaccfc18f05ef06, 0xbdaccfc18f05ef06, 0xbdaccfc18f05ef06, +] )) ), + +################ chunk 16896 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022bdd3e7780d9, + 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41023296d6378d17, 0x41023296d6378d17, 0x41023296d6378d17, 0x41023296d6378d17, + 0x41023296d6378d17, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x4102400a05b7a593, 0x4102400a05b7a593, + 0x4102400a05b7a593, 0x4102400a05b7a593, 0x4102400a05b7a593, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, + 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, + 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x410261a9fc77e2c9, + 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, + 0x410268639437ef07, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x410275d6c3b80783, 0x410275d6c3b80783, + 0x410275d6c3b80783, 0x410275d6c3b80783, 0x410275d6c3b80783, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, + 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028a038af82c3e, 0x41028a038af82c3e, 0x41028a038af82c3e, + 0x41028a038af82c3e, 0x41028a038af82c3e, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x41029776ba7844ba, + 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029e30523850f8, 0x41029e30523850f8, 0x41029e30523850f8, 0x41029e30523850f8, + 0x41029e30523850f8, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102aba381b86974, 0x4102aba381b86974, + 0x4102aba381b86974, 0x4102aba381b86974, 0x4102aba381b86974, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, + 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, + 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102cd437878a6aa, + 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, + 0x4102d3fd1038b2e8, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, + 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, + 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, + 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x410303103679089b, + 0x410303103679089b, 0x410303103679089b, 0x410303103679089b, 0x410303103679089b, 0x410309c9ce3914d9, 0x410309c9ce3914d9, 0x410309c9ce3914d9, 0x410309c9ce3914d9, + 0x410309c9ce3914d9, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103173cfdb92d55, 0x4103173cfdb92d55, + 0x4103173cfdb92d55, 0x4103173cfdb92d55, 0x4103173cfdb92d55, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, + 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x41032b69c4f9520f, 0x41032b69c4f9520f, 0x41032b69c4f9520f, + 0x41032b69c4f9520f, 0x41032b69c4f9520f, 0x4090000000000000, 0x4090040000000000, 0x408ff80000000000, 0x4090020000000000, 0x408ffc0000000000, 0x40a0000000000000, + 0x40a0020000000000, 0x409ffc0000000000, 0x40a0010000000000, 0x409ffe0000000000, 0x40b0000000000000, 0x40b0010000000000, 0x40affe0000000000, 0x40b0008000000000, + 0x40afff0000000000, 0x40c0000000000000, 0x40c0008000000000, 0x40bfff0000000000, 0x40c0004000000000, 0x40bfff8000000000, 0x40d0000000000000, 0x40d0004000000000, + 0x40cfff8000000000, 0x40d0002000000000, 0x40cfffc000000000, 0x40e0000000000000, 0x40e0002000000000, 0x40dfffc000000000, 0x40e0001000000000, 0x40dfffe000000000, + 0x40f0000000000000, 0x40f0001000000000, 0x40efffe000000000, 0x40f0000800000000, 0x40effff000000000, 0x4100000000000000, 0x4100000800000000, 0x40fffff000000000, + 0x4100000400000000, 0x40fffff800000000, 0x4110000000000000, 0x4110000400000000, 0x410ffff800000000, 0x4110000200000000, 0x410ffffc00000000, 0x4120000000000000, + 0x4120000200000000, 0x411ffffc00000000, 0x4120000100000000, 0x411ffffe00000000, 0x4130000000000000, 0x4130000100000000, 0x412ffffe00000000, 0x4130000080000000, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0xbdaccfc18f05ef06, 0xbdaccfc18f05ef06, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da4504fa4949921, + 0x3da4504fa4949921, 0x3da4504fa4949921, 0x3da4504fa4949921, 0x3da4504fa4949921, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd97a1bb74468677, 0xbd97a1bb74468677, 0xbd97a1bb74468677, 0xbd97a1bb74468677, 0xbd97a1bb74468677, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7a8b5e7d8f6ab1, 0x3d7a8b5e7d8f6ab1, 0x3d7a8b5e7d8f6ab1, 0x3d7a8b5e7d8f6ab1, 0x3d7a8b5e7d8f6ab1, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d84b8186afda23d, 0x3d84b8186afda23d, 0x3d84b8186afda23d, + 0x3d84b8186afda23d, 0x3d84b8186afda23d, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9b5af00a617ce9, + 0xbd9b5af00a617ce9, 0xbd9b5af00a617ce9, 0xbd9b5af00a617ce9, 0xbd9b5af00a617ce9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3da62ce9efa2145a, 0x3da62ce9efa2145a, 0x3da62ce9efa2145a, 0x3da62ce9efa2145a, 0x3da62ce9efa2145a, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdaeac5bda136a3f, 0xbdaeac5bda136a3f, 0xbdaeac5bda136a3f, 0xbdaeac5bda136a3f, 0xbdaeac5bda136a3f, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbda8d4323b7b3fdc, 0xbda8d4323b7b3fdc, 0xbda8d4323b7b3fdc, + 0xbda8d4323b7b3fdc, 0xbda8d4323b7b3fdc, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da054c05109e9f7, + 0x3da054c05109e9f7, 0x3da054c05109e9f7, 0x3da054c05109e9f7, 0x3da054c05109e9f7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd8f55399a625045, 0xbd8f55399a625045, 0xbd8f55399a625045, 0xbd8f55399a625045, 0xbd8f55399a625045, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd5544707b183a7d, 0xbd5544707b183a7d, 0xbd5544707b183a7d, 0xbd5544707b183a7d, 0xbd5544707b183a7d, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d92532adc942f72, 0x3d92532adc942f72, 0x3d92532adc942f72, + 0x3d92532adc942f72, 0x3d92532adc942f72, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda1a90758bb6d9e, + 0xbda1a90758bb6d9e, 0xbda1a90758bb6d9e, 0xbda1a90758bb6d9e, 0xbda1a90758bb6d9e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3daa2879432cc384, 0x3daa2879432cc384, 0x3daa2879432cc384, 0x3daa2879432cc384, 0x3daa2879432cc384, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3dad5814d261e697, 0x3dad5814d261e697, 0x3dad5814d261e697, 0x3dad5814d261e697, 0x3dad5814d261e697, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbda4d8a2e7f090b2, 0xbda4d8a2e7f090b2, 0xbda4d8a2e7f090b2, + 0xbda4d8a2e7f090b2, 0xbda4d8a2e7f090b2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d98b261fafe7599, + 0x3d98b261fafe7599, 0x3d98b261fafe7599, 0x3d98b261fafe7599, 0x3d98b261fafe7599, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0xbd7ecdf8986f273b, 0xbd7ecdf8986f273b, 0xbd7ecdf8986f273b, 0xbd7ecdf8986f273b, 0xbd7ecdf8986f273b, 0xbff0000000000000, 0xbff0000000000000, + 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8296cb5d8dc3f8, 0xbd8296cb5d8dc3f8, 0xbd8296cb5d8dc3f8, 0xbd8296cb5d8dc3f8, 0xbd8296cb5d8dc3f8, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9a4a4983a98dc6, 0x3d9a4a4983a98dc6, 0x3d9a4a4983a98dc6, + 0x3d9a4a4983a98dc6, 0x3d9a4a4983a98dc6, 0x3fef98669d7aedb8, 0x3fe557012c0b1fae, 0x3fd99ab7a3c97099, 0x3fee28df4155ee38, 0x3fe94b9b627e3d8b, 0x3fee6439427e96b9, + 0x3fe8d9ad9d741941, 0x3fcff6ab69ab99f9, 0x3fef794e3e8fb787, 0x3fe5de4587979a24, 0x3fe9ba4a85e6ce6c, 0x3fede9a6e35dc7d2, 0xbfb0e3cd8b89b3a3, 0x3fefb3717aed2271, + 0x3fdae92b9a539aed, 0x3fd2bd43d0eb2c92, 0x3feecf343a9a3b5d, 0xbfe4af3b1102ac8b, 0x3fe6e452f825d183, 0xbfc9c94ff2246ad9, 0xbfea835a25a9edd8, 0x3f9813cd16ce910a, + 0xbfed67101411ae9a, 0xbfdd5aa89a751131, 0xbfefdb982dea8158, 0x3fd7de36a119d74b, 0xbfe28956c81752d0, 0x3fef6eb38d7d11b4, 0xbfbe1809a8e94e2e, 0x3fe8b538b06fb01e, + 0xbfe719453109288b, 0xbfef1d96dea65228, 0x3fc89eba92bf27c6, 0xbfeee37028eb1f04, 0xbfd34ea7c01f9a41, 0x3fa58ced65ec8b50, 0x3feba1859b0d0123, 0xbfea2cebbb513e7c, + 0x3fe08292273454cf, 0xbfdc4ac0840e0011, 0xbfefe2f9378c3909, 0xbfdded644ac6704b, 0xbfe37e403cff462d, 0xbfeab15b51c2ae6d, 0xbfed46027aa61a66, 0x3fef8c1986ca67fa, + 0x3fd9102d8065bbb9, 0x3fe58efb524baf70, 0x3fe91d21d6b953d7, 0x3fee41c1a1728a39, 0x3fee33ada92fe2ae, 0x3fcdacfb27d45b34, 0x3fe937a45bd49642, 0x3fe56f3082d8f8a6, +] )) ), + +################ chunk 17408 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x412fffff00000000, 0x4140000000000000, 0x4140000080000000, 0x413fffff00000000, 0x4140000040000000, 0x413fffff80000000, 0x4150000000000000, 0x4150000040000000, + 0x414fffff80000000, 0x4150000020000000, 0x414fffffc0000000, 0x4160000000000000, 0x4160000020000000, 0x415fffffc0000000, 0x4160000010000000, 0x415fffffe0000000, + 0x4170000000000000, 0x4170000010000000, 0x416fffffe0000000, 0x4170000008000000, 0x416ffffff0000000, 0x4180000000000000, 0x4180000008000000, 0x417ffffff0000000, + 0x4180000004000000, 0x417ffffff8000000, 0x4190000000000000, 0x4190000004000000, 0x418ffffff8000000, 0x4190000002000000, 0x418ffffffc000000, 0x41a0000000000000, + 0x41a0000002000000, 0x419ffffffc000000, 0x41a0000001000000, 0x419ffffffe000000, 0x41b0000000000000, 0x41b0000001000000, 0x41affffffe000000, 0x41b0000000800000, + 0x41afffffff000000, 0x41c0000000000000, 0x41c0000000800000, 0x41bfffffff000000, 0x41c0000000400000, 0x41bfffffff800000, 0x41d0000000000000, 0x41d0000000400000, + 0x41cfffffff800000, 0x41d0000000200000, 0x41cfffffffc00000, 0x41e0000000000000, 0x41e0000000200000, 0x41dfffffffc00000, 0x41e0000000100000, 0x41dfffffffe00000, + 0x41f0000000000000, 0x41f0000000100000, 0x41efffffffe00000, 0x41f0000000080000, 0x41effffffff00000, 0x4200000000000000, 0x4200000000080000, 0x41fffffffff00000, + 0x4200000000040000, 0x41fffffffff80000, 0x4210000000000000, 0x4210000000040000, 0x420ffffffff80000, 0x4210000000020000, 0x420ffffffffc0000, 0x4220000000000000, + 0x4220000000020000, 0x421ffffffffc0000, 0x4220000000010000, 0x421ffffffffe0000, 0x4230000000000000, 0x4230000000010000, 0x422ffffffffe0000, 0x4230000000008000, + 0x422fffffffff0000, 0x4240000000000000, 0x4240000000008000, 0x423fffffffff0000, 0x4240000000004000, 0x423fffffffff8000, 0x4250000000000000, 0x4250000000004000, + 0x424fffffffff8000, 0x4250000000002000, 0x424fffffffffc000, 0x4260000000000000, 0x4260000000002000, 0x425fffffffffc000, 0x4260000000001000, 0x425fffffffffe000, + 0x4270000000000000, 0x4270000000001000, 0x426fffffffffe000, 0x4270000000000800, 0x426ffffffffff000, 0x4280000000000000, 0x4280000000000800, 0x427ffffffffff000, + 0x4280000000000400, 0x427ffffffffff800, 0x4290000000000000, 0x4290000000000400, 0x428ffffffffff800, 0x4290000000000200, 0x428ffffffffffc00, 0x42a0000000000000, + 0x42a0000000000200, 0x429ffffffffffc00, 0x42a0000000000100, 0x429ffffffffffe00, 0x42b0000000000000, 0x42b0000000000100, 0x42affffffffffe00, 0x42b0000000000080, + 0x42afffffffffff00, 0x42c0000000000000, 0x42c0000000000080, 0x42bfffffffffff00, 0x42c0000000000040, 0x42bfffffffffff80, 0x42d0000000000000, 0x42d0000000000040, + 0x42cfffffffffff80, 0x42d0000000000020, 0x42cfffffffffffc0, 0x42e0000000000000, 0x42e0000000000020, 0x42dfffffffffffc0, 0x42e0000000000010, 0x42dfffffffffffe0, + 0x42f0000000000000, 0x42f0000000000010, 0x42efffffffffffe0, 0x42f0000000000008, 0x42effffffffffff0, 0x4300000000000000, 0x4300000000000008, 0x42fffffffffffff0, + 0x4300000000000004, 0x42fffffffffffff8, 0x4310000000000000, 0x4310000000000004, 0x430ffffffffffff8, 0x4310000000000002, 0x430ffffffffffffc, 0x408f400000000000, + 0x4091300000000000, 0x408c200000000000, 0x408f480000000000, 0x408f380000000000, 0x40c3880000000000, 0x40c57c0000000000, 0x40c1940000000000, 0x40c3888000000000, + 0x40c3878000000000, 0x40f86a0000000000, 0x40fadb0000000000, 0x40f5f90000000000, 0x40f86a1000000000, 0x40f869f000000000, 0x412e848000000000, 0x4130c8e000000000, + 0x412b774000000000, 0x412e848200000000, 0x412e847e00000000, 0x416312d000000000, 0x4164fb1800000000, 0x41612a8800000000, 0x416312d020000000, 0x416312cfe0000000, + 0x4197d78400000000, 0x419a39de00000000, 0x4195752a00000000, 0x4197d78404000000, 0x4197d783fc000000, 0x41cdcd6500000000, 0x41d0642ac0000000, 0x41cad27480000000, + 0x41cdcd6500800000, 0x41cdcd64ff800000, 0x4202a05f20000000, 0x42047d3570000000, 0x4200c388d0000000, 0x4202a05f20080000, 0x4202a05f1ff80000, 0x42374876e8000000, + 0x42399c82cc000000, 0x4234f46b04000000, 0x42374876e8010000, 0x42374876e7ff0000, 0x426d1a94a2000000, 0x427001d1bf800000, 0x426a3185c5000000, 0x426d1a94a2002000, + 0x426d1a94a1ffe000, 0x42a2309ce5400000, 0x42a402462f600000, 0x42a05ef39b200000, 0x42a2309ce5400200, 0x42a2309ce53ffe00, 0x42d6bcc41e900000, 0x42d902d7bb380000, + 0x42d476b081e80000, 0x42d6bcc41e900040, 0x42d6bcc41e8fffc0, 0x430c6bf526340000, 0x430f438daa060000, 0x4309945ca2620000, 0x430c6bf526340008, 0x430c6bf52633fff8, + 0x4341c37937e08000, 0x43438a388a43c000, 0x433ff973cafa8000, 0x4341c37937e08000, 0x4341c37937e08000, 0x4376345785d8a000, 0x43786cc6acd4b000, 0x4373fbe85edc9000, + 0x4376345785d8a000, 0x4376345785d8a000, 0x43abc16d674ec800, 0x43ae87f85809dc00, 0x43a8fae27693b400, 0x43abc16d674ec800, 0x43abc16d674ec800, 0x409f400000000000, + 0x40d3880000000000, 0x40a7700000000000, 0x40dd4c0000000000, 0x40b3880000000000, 0x40e86a0000000000, 0x40bf400000000000, 0x40f3880000000000, 0x40c9640000000000, + 0x40ffbd0000000000, 0x40d4820000000000, 0x4109a28000000000, 0x40e09a0000000000, 0x4114c08000000000, 0x40eadb0000000000, 0x4120c8e000000000, 0x40f5ba8000000000, + 0x412b292000000000, 0x4101940000000000, 0x4135f90000000000, 0x410c714000000000, 0x4141c6c800000000, 0x411702a000000000, 0x414cc34800000000, 0x41229da000000000, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3fef932ec65b1d71, 0x3fe9027224e704fa, 0xbfba48dfb6dedc7a, 0x3fee4f9f2ca69a7a, 0x3fd8c11bfcff0bf3, 0x3fef84cb87f27aca, 0x3fcc5e944c25ddfc, 0xbfe66ce45566976a, + 0x3fee16e2d72bcae5, 0xbfd178cb94e982c8, 0x3fe52f27725c6a75, 0xbfecdb2c9e19e37f, 0xbfeb3aefdaedf0d7, 0xbfbf9d6bdd62473d, 0xbfeff47d828035ae, 0xbfe2b1386c2356f5, + 0x3fe40ad67f3f0c9a, 0x3fefd1fe5195a1a2, 0xbfd4532c3721ed43, 0x3fed8c6f300a4e27, 0x3fc684222ce7cf42, 0xbfcb9381aa1f0792, 0x3fe691e3aaf2bac6, 0xbfee0505ed05495e, + 0x3fd1dccdb8fb604b, 0xbfe5080d3c655fda, 0xbfed078da7f267e0, 0xbfeb03b8eccd6d81, 0xbfc16b64d0ba2fee, 0xbfefee5117e7de7f, 0xbfe305495657bcbf, 0x3fe4ab6511a7d39b, + 0x3fefb957eac4b278, 0xbfd2c6e027930661, 0x3fedd9ddebc91055, 0x3fc9b59e71dbc3e9, 0xbfc5315d441272de, 0x3fe7b15b165a9836, 0xbfed6b063454023c, 0x3fd4f5e4c8c289df, + 0xbfe3c78ca5b8e438, 0xbfee3edd2dfeef90, 0xbfe922a043b37f85, 0xbfce3164dbe8bfd8, 0xbfef8d94f6ae2333, 0xbfe5886c4549d6fe, 0x3fe92cb46a920144, 0x3fee398612c96801, + 0xbfb82ac4b53cde6b, 0x3fef904817b569bf, 0x3fd93e7a92b37336, 0x3fce70c2d5131e55, 0x3fee442c6ece90b5, 0xbfe60af33efcd1b2, 0x3fe594794e581a33, 0xbfd072280f63ee92, + 0xbfec6160ab00cc87, 0xbfb726fe54bd570a, 0xbfebc620597e2174, 0xbfe1d189a370cb58, 0xbfeffe665569837f, 0x3fe25722fce440b7, 0xbfd85006c884cf67, 0x3feff9997e9f3665, + 0x3fbc2fd68e174e47, 0x3fecaac2a7d977a0, 0xbfd5f42d7467737c, 0xbfef3960081bba1d, 0x3fe35cc7bd281d1a, 0xbfe80b3da22632da, 0x3fc31c48a387ae25, 0xbfe8781e90e43ee1, + 0x3fc08703307bdf8c, 0xbfee92ca17c17a14, 0xbfd72c9f6d71c48f, 0xbfef5c40a4fa17d8, 0x3fc5af85f5920329, 0xbfe79bce4c9299c3, 0x3fed778e67b786ed, 0xbfd4b965f7505f86, + 0x3fe3e0a8bee7d320, 0xbfee29bbad4a34c6, 0xbfe94a07334d8753, 0xbfcd3872fb117645, 0xbfef97fdeabd40fe, 0xbfe558ecbf295df3, 0x3fe8dceca447cc2f, 0x3fee629bc609ad19, + 0xbfbc2522826c9145, 0x3fef7a3c230679ad, 0x3fd852844a7ed11e, 0x3fca8ac198a43f66, 0x3feded4eddb14139, 0xbfe6c1b264108a90, 0x3fe4d4d47738ff61, 0xbfd25eb3471e35df, + 0xbfed3f8577b3aa88, 0xbfc38377325300fc, 0xbfeaba2f0767e6d5, 0xbfe37187c84b9c83, 0xbfefe44e52c8a562, 0x3fe5774001534a97, 0xbfd0be6fe3bde4fc, 0x3fef91693a804015, + 0x3fcdd73d3206811f, 0x3fee3742ec79593e, 0xbfb99bf99b8cd518, 0xbfec85872ad1def1, 0x3fe90ff9d3f8bd7e, 0xbfe212ede44cf1f3, 0x3fd8e927629dffec, 0xbfef5c0a8dda3078, + 0xbfd72aa4b28054b6, 0xbfe64dd1132b34d7, 0xbfe8776f64e86be6, 0xbfee931a53bfcefa, 0x3fed76ba5f13bf3a, 0x3fc5a726eaf73e30, 0x3fea6ceb2dfd7e8a, 0x3fe3defeb13ad651, + 0x3fefd7bcfe4b6fda, 0x3fe641d49e1cdd35, 0xbfcd48fcbe1f7e38, 0x3fef5f59494ee482, 0x3fd104f34f3f27c7, 0x3fee8e28818df4da, 0xbfa09e872a291106, 0xbfeb795e5bdf8cd0, + 0x3fea5a06f53679cb, 0xbfe03ebd9cc36159, 0x3fdcd80e73c34fc0, 0xbfefeebccef9b75b, 0xbfdf031d80668b28, 0xbfe30019f9247067, 0xbfeb072cdfc5a2bc, 0xbfed04d6c3c72a0b, + 0x3fefbb05dbc935f1, 0x3fdb507555f95a45, 0x3fe4a18bfc569a6a, 0x3fe9dc0898a5864b, 0x3fedd5367fd5480f, 0x3feeed40cc9f557c, 0x3fd396d992df53dd, 0x3fe79ffecb2a56b3, + 0x3fe7336dbdd8de2c, 0x3fef14a86ab65801, 0x3febc7711009e00b, 0x3faa480d05a78bd4, 0x3fec6027497a209e, 0x3fe0c34d7d94f93d, 0x3feffe73a085a62d, 0x3fe1ff026793f1bb, + 0x3feceabab3af8d64, 0x3fb0f58b3b6e2fb2, 0xbfd9158d4fc66255, 0x3feffd21b0401f9a, 0xbfee780e88ec4409, 0xbfd218d6717dbfd7, 0xbfe938c234a2c7e5, 0xbfd077601e8bdb04, + 0xbfe8b116ef7bfe0d, 0xbfeffac3841b3da7, 0x3feecc924c9c9ddc, 0x3fee1992128c0e47, 0xbfe23dc16ebb5fb1, 0xbfe050e628324337, 0x3fedf9df9906d32c, 0xbfed8e78a6cf2845, + 0xbfee5b77243ab262, 0x3fe99ed513372fa0, 0x3fcb165cde80ddd4, 0xbfed085be7a8f4a1, 0xbfe67c8180332c01, 0xbfefe80ce42182ac, 0xbfeb02b20ff99943, 0xbfc172fbc27daf4a, + 0xbfd741b388a8c029, 0xbfafcce8b3c0581b, 0x3fe7166c772abd32, 0xbfef5e7eac0cb917, 0x3fe2cdb23ebc4568, 0x3feacff8c7364234, 0xbfea042293820edd, 0x3fca1e6b94962239, + 0xbf7b079aad325820, 0x3fed2f4c89ddace2, 0x3febf098901c931a, 0x3fefecf9ce0c9b34, 0x3fddca527e0c50bb, 0x3fec391aa90d21f5, 0x3faf8062696d2f86, 0x3fd7bbf860c90a11, + 0x3fe8d966b8bedd25, 0xbfc08168e201f762, 0xbfe2985c9e8e130b, 0x3fef6b38f6f58ac3, 0x3fe9538731dff223, 0x3feb8e9e9f6df628, 0xbfd18ba183302d62, 0x3fee248913bcac5b, + 0xbfb6333d9e49c508, 0x3feea2b93bceea60, 0x3fe2989191d619ee, 0x3fede59ed8fd8127, 0x3fe854d2c978a2c8, 0x3fd18c1ea754277c, 0xbfef4a5e8cbdb66a, 0xbfefe4696e7709a4, + 0xbfec05431799cd0e, 0xbfd689003319820d, 0xbfe68b8aa9ebdcce, 0xbfe06c154609d33f, 0x3fe5cf370e1af74d, 0x3fd49d0e2edada03, 0xbfeffbd56a1a9b4d, 0x3fdc79c39defd9ee, + 0xbfe40991e398dbfc, 0xbfd643003557e87a, 0x3fefb26d3b4abef0, 0xbfe40991e398dbfc, 0xbfe40991e398dbfc, 0xbfec567c5278afcb, 0x3fed5593a9e16356, 0x3fc89deb18111af4, + 0xbfec567c5278afcb, 0xbfec567c5278afcb, 0x3fbe4da072c0759a, 0xbfe21d675cc21247, 0x3fd6cfe55a4245cc, 0x3fbe4da072c0759a, 0x3fbe4da072c0759a, 0xbfd784750e7f6c2a, + 0x3fea05bb5b890b51, 0xbfef38c9e0798e67, 0xbfe315f3639820d8, 0x3fc3cc2ca122a80a, 0xbf924e6a56dfd385, 0x3fb0ce1e7bcc7037, 0xbfe957097e2c1a8a, 0x3fefdf2399378a74, + 0x3fe3fde43ecb9017, 0xbf987a8016eef42c, 0xbfef1701b4f36985, 0xbfbcfeccfad03c13, 0xbfdb033fab1e8187, 0xbfefb2c766c4626d, 0x3fc902b4d65ae22c, 0x3fcfc82497b395fb, + 0x3fe9cfcd0ebaa2a6, 0xbfd83bbf8a8250e2, 0x3fe797e35c9cd4a7, 0x3fe9ae6aba6a0c5b, 0x3fefcf117865afce, 0xbfeb64cc7eb9ecb1, 0x3fe517d2451e1402, 0xbfefda3eab97a114, +] )) ), + +################ chunk 17920 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4157450800000000, 0x412e1ef000000000, 0x4162d35600000000, 0x41385e4800000000, 0x416e75da00000000, 0x4143b6e000000000, 0x4178a49800000000, 0x414fe60400000000, + 0x4183efc280000000, 0x4159ce7200000000, 0x4190210740000000, 0x4164e0ba00000000, 0x419a18e880000000, 0x40f8a88000000000, 0x412ed2a000000000, 0x416343a400000000, + 0x4073d4d0507dcb95, 0x4063d4d0507dcb95, 0x40f9258000000000, 0x412f6ee000000000, 0x4163a54c00000000, 0x407439583dcedc4a, 0x406439583dcedc4a, 0x40fa1f8000000000, + 0x413053b000000000, 0x4164689c00000000, 0x407502681870fdb2, 0x406502681870fdb2, 0x40fa9c8000000000, 0x4130a1d000000000, 0x4164ca4400000000, 0x407566f005c20e67, + 0x406566f005c20e67, 0x40fb968000000000, 0x41313e1000000000, 0x41658d9400000000, 0x40762fffe0642fcf, 0x40662fffe0642fcf, 0x40ff018000000000, 0x413360f000000000, + 0x4168392c00000000, 0x4078efb75d9ba4be, 0x4068efb75d9ba4be, 0x40fffb8000000000, 0x4133fd3000000000, 0x4168fc7c00000000, 0x4079b8c7383dc627, 0x4069b8c7383dc627, + 0x4100b94000000000, 0x4134e79000000000, 0x416a217400000000, 0x407ae65f0030f844, 0x406ae65f0030f844, 0x4100f7c000000000, 0x413535b000000000, 0x416a831c00000000, + 0x407b4ae6ed8208f8, 0x406b4ae6ed8208f8, 0x4102304000000000, 0x4136bc5000000000, 0x416c6b6400000000, 0x407d418e90175c7e, 0x406d418e90175c7e, 0x41026ec000000000, + 0x41370a7000000000, 0x416ccd0c00000000, 0x407da6167d686d33, 0x406da6167d686d33, 0x41032a4000000000, 0x4137f4d000000000, 0x416df20400000000, 0x407ed3ae455b9f50, + 0x406ed3ae455b9f50, 0x4103e5c000000000, 0x4138df3000000000, 0x416f16fc00000000, 0x408000a306a768b6, 0x407000a306a768b6, 0x410462c000000000, 0x41397b7000000000, + 0x416fda4c00000000, 0x4080652af3f8796b, 0x4070652af3f8796b, 0x41051e4000000000, 0x413a65d000000000, 0x41707fa200000000, 0x4080fbf6d7f21279, 0x4070fbf6d7f21279, + 0x4105d9c000000000, 0x413b503000000000, 0x4171121e00000000, 0x408192c2bbebab88, 0x407192c2bbebab88, 0x4106184000000000, 0x413b9e5000000000, 0x417142f200000000, + 0x4081c506b29433e2, 0x4071c506b29433e2, 0x410750c000000000, 0x413d24f000000000, 0x4172371600000000, 0x4082c05a83dedda5, 0x4072c05a83dedda5, 0x41078f4000000000, + 0x413d731000000000, 0x417267ea00000000, 0x4082f29e7a8765ff, 0x4072f29e7a8765ff, 0x41080c4000000000, 0x413e0f5000000000, 0x4172c99200000000, 0x4083572667d876b4, + 0x4073572667d876b4, 0x41084ac000000000, 0x413e5d7000000000, 0x4172fa6600000000, 0x4083896a5e80ff0e, 0x4073896a5e80ff0e, 0x4109c1c000000000, 0x4140191800000000, + 0x41741f5e00000000, 0x4084b7022674312b, 0x4074b7022674312b, 0x410b38c000000000, 0x4141037800000000, 0x4175445600000000, 0x4085e499ee676348, 0x4075e499ee676348, + 0x410bb5c000000000, 0x4141519800000000, 0x4175a5fe00000000, 0x40864921dbb873fd, 0x40764921dbb873fd, 0x410bf44000000000, 0x414178a800000000, 0x4175d6d200000000, + 0x40867b65d260fc57, 0x40767b65d260fc57, 0x410c714000000000, 0x4141c6c800000000, 0x4176387a00000000, 0x4086dfedbfb20d0b, 0x4076dfedbfb20d0b, 0x410d2cc000000000, + 0x41423bf800000000, 0x4176caf600000000, 0x408776b9a3aba61a, 0x407776b9a3aba61a, 0x410d6b4000000000, 0x4142630800000000, 0x4176fbca00000000, 0x4087a8fd9a542e74, + 0x4077a8fd9a542e74, 0x410ea3c000000000, 0x4143265800000000, 0x4177efee00000000, 0x4088a4516b9ed837, 0x4078a4516b9ed837, 0x410f5f4000000000, 0x41439b8800000000, + 0x4178826a00000000, 0x40893b1d4f987145, 0x40793b1d4f987145, 0x41100d6000000000, 0x414410b800000000, 0x417914e600000000, 0x4089d1e933920a54, 0x4079d1e933920a54, + 0x41106b2000000000, 0x414485e800000000, 0x4179a76200000000, 0x408a68b5178ba363, 0x407a68b5178ba363, 0x41108a6000000000, 0x4144acf800000000, 0x4179d83600000000, + 0x408a9af90e342bbd, 0x407a9af90e342bbd, 0x4110e82000000000, 0x4145222800000000, 0x417a6ab200000000, 0x408b31c4f22dc4cb, 0x407b31c4f22dc4cb, 0x411126a000000000, + 0x4145704800000000, 0x417acc5a00000000, 0x408b964cdf7ed580, 0x407b964cdf7ed580, 0x411145e000000000, 0x4145975800000000, 0x417afd2e00000000, 0x408bc890d6275dda, + 0x407bc890d6275dda, 0x4111e22000000000, 0x41465aa800000000, 0x417bf15200000000, 0x408cc3e4a772079d, 0x407cc3e4a772079d, 0x4112bce000000000, 0x41476c1800000000, + 0x417d471e00000000, 0x408e23c0660dc214, 0x407e23c0660dc214, 0x4112fb6000000000, 0x4147ba3800000000, 0x417da8c600000000, 0x408e8848535ed2c8, 0x407e8848535ed2c8, + 0x41131aa000000000, 0x4147e14800000000, 0x417dd99a00000000, 0x408eba8c4a075b23, 0x407eba8c4a075b23, 0x4113592000000000, 0x41482f6800000000, 0x417e3b4200000000, + 0x408f1f1437586bd7, 0x407f1f1437586bd7, 0x411433e000000000, 0x414940d800000000, 0x417f910e00000000, 0x40903f77fafa1327, 0x40803f77fafa1327, 0x411491a000000000, + 0x4149b60800000000, 0x418011c500000000, 0x40908addecf6dfae, 0x40808addecf6dfae, 0x41152de000000000, 0x414a795800000000, 0x41808bd700000000, 0x40910887d59c3490, + 0x40810887d59c3490, 0x41154d2000000000, 0x414aa06800000000, 0x4180a44100000000, 0x409121a9d0f078bd, 0x408121a9d0f078bd, 0x41158ba000000000, 0x414aee8800000000, + 0x4180d51500000000, 0x409153edc7990117, 0x408153edc7990117, 0x4115e96000000000, 0x414b63b800000000, 0x41811e5300000000, 0x40919f53b995cd9f, 0x40819f53b995cd9f, + 0x4116666000000000, 0x414bfff800000000, 0x41817ffb00000000, 0x409203dba6e6de53, 0x408203dba6e6de53, 0x7fdfffffffffffff, 0x7fe1ccf385ebc8a0, 0x7fac7b1f3cac7433, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3fe2573f41b3c7da, 0x3fecda8a29be2324, 0xbfce84fffb89359d, 0xbfee0c31d0e7ad55, 0xbfedd6d53a17647b, 0xbfe65582204e1f1d, 0xbfc0722375c39fb1, 0x3fda2d9efbcc29af, + 0x3fde985903385d94, 0x3fd78dc1c376279c, 0x3fe9e881f09b2014, 0x3feff7e30694ffef, 0x3fece1db297e0adc, 0xbfe2ee384081d8aa, 0xbfeff6f609e4245b, 0x3fec8872fa00c805, + 0xbff0000000000000, 0x3cf3da34489c213b, 0x3feef37d2c3baa6b, 0xbfeade48cd01342c, 0x3feb6cca87aced27, 0xbff0000000000000, 0x3d0dcc4d42e59df2, 0xbfec258b382b33c9, + 0x3fcf23207919ef10, 0x3fe8cb70945763fa, 0xbff0000000000000, 0xbd02c0e3eeb304ee, 0x3fe880653893353f, 0x3fe864ef708e9d05, 0x3fe749304164d8b4, 0xbff0000000000000, + 0xbd04f8837880a9a2, 0xbfeff420d658420b, 0x3feb78f3c1ed6a0b, 0x3fe3eb65a925f2b8, 0xbff0000000000000, 0x3d0b94adb917f93e, 0xbfdc0ebed26639cc, 0x3fc62fbf84eb5a52, + 0x3fc5d2860e6ec49c, 0xbff0000000000000, 0xbce60b679ab8cd3b, 0xbfd2d5fce9cc76de, 0x3fef9ebca91283a0, 0x3f9cf9437551142b, 0xbff0000000000000, 0x3cf3dfe9cf7253a2, + 0x3fc245763c42706b, 0xbfc1aa6eaad4a4e8, 0xbfc7b37f72e0f767, 0xbff0000000000000, 0xbcc1c2b1d543580a, 0xbfef228ea1517b6f, 0xbfe609679c4744c5, 0xbfd0506b32a5d343, + 0xbff0000000000000, 0xbd072a6d7b781bef, 0x3feb63088671d585, 0x3fe5317393efbfa3, 0xbfe27890d57450ce, 0xbff0000000000000, 0x3d008b687775b320, 0xbfe975146b460391, + 0x3fef301dfe29b980, 0xbfe44a75361753ae, 0xbff0000000000000, 0x3d072dfeefbdfb70, 0xbfdd6fbcdaecf3cd, 0xbfb11fe2f7799739, 0xbfe917f9f91c0f72, 0xbff0000000000000, + 0xbcfcb46a4ab20e3f, 0xbfa268f6fb37fae9, 0xbfedf3e1abeb85c3, 0xbfecbef3d8abd0e3, 0xbff0000000000000, 0xbd1d3cca5285f698, 0x3fe6b2a7d74fe691, 0x3f9fedfebd6cd16b, + 0xbfee74d876434eb1, 0xbff0000000000000, 0x3d04f93a295b6fef, 0x3fd5bce1ec9cad13, 0x3fee560c7f952539, 0xbfefd93b84b18d0d, 0xbff0000000000000, 0x3d19ed47d084c231, + 0xbfb863f44319801f, 0xbfe2812004ecce65, 0xbfefc7ca262f5e83, 0xbff0000000000000, 0x3cda8d34a48c3a73, 0x3feebf0672a8e9fb, 0xbfee3de51cb88228, 0xbfef6e8b041b0240, + 0xbff0000000000000, 0x3d04f4f2043aca22, 0xbfea907f4bcc6270, 0x3fedd935a26e3ea0, 0xbfeb57b79de5cafa, 0xbff0000000000000, 0xbcfcabda0070c2a5, 0x3fea5ade1f0480e7, + 0x3feefc7c91b8d270, 0xbfea15bba7bed456, 0xbff0000000000000, 0x3d134e42cc825961, 0xbfefa4a8a1a86b2a, 0x3fb3755bc1870ea2, 0xbfe72d2d5cc2a872, 0xbff0000000000000, + 0xbd146b249ab1552f, 0x3fe00f3bc3161e20, 0xbfe09778d53da4ff, 0xbfe58a696478699d, 0xbff0000000000000, 0x3d008fb09c9658ed, 0xbfd66fe353da9644, 0x3fecf2acb06e9ab9, + 0xbfd37c5ebeab7f24, 0xbff0000000000000, 0xbcc17e2f8338fb35, 0xbfee498080c4da1a, 0xbfefa9e708ce0bd0, 0x3fbe91e4b503b332, 0xbff0000000000000, 0xbd02bf768cfd7854, + 0x3fde1893bf6a1b15, 0xbfc75679cdf0cd77, 0x3fd09f232306d34d, 0xbff0000000000000, 0x3d1e59ac20b4f266, 0xbfefcb7a62423c2c, 0x3fdb22302652215a, 0x3fd4fec23ac426b3, + 0xbff0000000000000, 0xbd12365fd44ec9ae, 0x3fe9ae6aba6a0c5b, 0x3fefcf117865afce, 0x3fdd65fe2db183e3, 0xbff0000000000000, 0x3cf840e311f61f09, 0x3fef6117fa4086ae, + 0xbfd90b48a460f2b0, 0x3fe469e394ce625d, 0xbff0000000000000, 0x3d1585e2564ffe16, 0xbfe15d33643502c1, 0xbfeb52437809e7ff, 0x3fe61f4bd3d12aa2, 0xbff0000000000000, + 0xbd02c52c13d3aabb, 0x3fe8bf796559910d, 0x3feab5542b668bd8, 0x3fecd0c1cfe733fe, 0xbff0000000000000, 0x3d09643117d6138b, 0x3fdb62d7bd7d7659, 0x3fd256cbc1094ceb, + 0x3fef1e1d3f0cb914, 0xbff0000000000000, 0x3d17b7cc59477063, 0x3f2b50ddd4ae47eb, 0xbfeffffb722113c5, 0x3feffe38991924ee, 0xbff0000000000000, 0x3ceef2760c30aba7, + 0xbfdb5cab81ceaade, 0x3fd2982e55c3e476, 0x3fef66cd5cb9af7f, 0xbff0000000000000, 0xbd1f7469dc539b4d, 0x3fefee7127f20cea, 0x3fe96172e72a696e, 0x3feee195bf2ad218, + 0xbff0000000000000, 0x3d13511d8fed7295, 0x3febf7b03767668e, 0x3fd6ac5f9124265d, 0x3fec6335bd26ed12, 0xbff0000000000000, 0x3d1118c755450793, 0xbfef0b2ab9d87a2e, + 0xbfe8aaf02acb84ff, 0x3fe9fe0eb602e86f, 0xbff0000000000000, 0xbd16a0a011eea6fc, 0x3fe2a101e4b505d8, 0xbfefec4384be6263, 0x3fe897a1328e2f08, 0xbff0000000000000, + 0x3d04faa78b10fc89, 0xbfe9b074127b6ace, 0x3fefd2b952679ff7, 0x3fdfbdde27e11bcb, 0xbff0000000000000, 0xbd0b99ac8f136558, 0xbfed2998c5c92b9c, 0xbfdcf35fa996aad8, + 0x3f92cb36f5a505d2, 0xbff0000000000000, 0xbcfca8ff3d05a971, 0x3fd890c0748129bd, 0x3fe657f3ffb41259, 0xbfbfd54f525fcc3e, 0xbff0000000000000, 0xbd1f70d8680dbbcc, + 0xbfeffeb89eb9ed3d, 0x3fef80723e5dad64, 0xbfc8f36768b90512, 0xbff0000000000000, 0xbd146bdb4b8c1b7c, 0x3fe7bdb989640d91, 0x3fdef8fe54dec590, 0xbfd54ba53c417f9a, + 0xbff0000000000000, 0x3ceed5ea6a01afa4, 0xbfccd5b05dfefe8c, 0x3fe4a64fd456b13c, 0xbfe7d30552b27476, 0xbff0000000000000, 0xbd18d1d3640b52fd, 0x3fcb46dda507e5d0, + 0x3fe17296739dc736, 0xbfebd38bfee47e5b, 0xbff0000000000000, 0x3d2e9ddc249ee693, 0x3fb87f252dcc47ab, 0xbfe2653a15da0fba, 0xbfef98cdee3bccad, 0xbff0000000000000, + 0x3cf84f28e30d9d0b, 0x3fec7fdf74bbb846, 0x3f81e53b76142066, 0xbfefe0beb8a53796, 0xbff0000000000000, 0x3cf83e084e8b05d6, 0xbfd5b67583a74e67, 0x3fee60d924d57743, + 0xbfeff3521f6f320f, 0xbff0000000000000, 0x3d1e561aac6f12e5, 0xbfe6b03f8df65bfe, 0x3f9ba9d2b8f492fb, 0xbfeed6cfac0da265, 0xbff0000000000000, 0x3d2ea000372f3979, + 0x3fe50733fc8ca908, 0xbfe4382465bdc5fc, 0xbfeb2d0d07da1074, 0xbff0000000000000, 0x3d09659e798ba024, 0x3f645300b2210ee6, 0xbfec859a523ff229, 0x3fd8e94538ed3a0b, +] )) ), + +################ chunk 18432 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x7f76c8e5ca239029, 0x40b0000000000001, 0x40affffffffffffe, 0x40b0000000000002, 0x40affffffffffffc, 0x40c0000000000001, 0x40bffffffffffffe, 0x40c0000000000002, + 0x40bffffffffffffc, 0x40d0000000000001, 0x40cffffffffffffe, 0x40d0000000000002, 0x40cffffffffffffc, 0x40e0000000000001, 0x40dffffffffffffe, 0x40e0000000000002, + 0x40dffffffffffffc, 0x40f0000000000001, 0x40effffffffffffe, 0x40f0000000000002, 0x40effffffffffffc, 0x4100000000000001, 0x40fffffffffffffe, 0x4100000000000002, + 0x40fffffffffffffc, 0x4110000000000001, 0x410ffffffffffffe, 0x4110000000000002, 0x410ffffffffffffc, 0x4120000000000001, 0x411ffffffffffffe, 0x4120000000000002, + 0x411ffffffffffffc, 0x4130000000000001, 0x412ffffffffffffe, 0x4130000000000002, 0x412ffffffffffffc, 0x4144bd24ea0af22d, 0x4179ec6e248daeb8, 0x41b033c4d6d88d33, + 0x413594458ff7aee3, 0x416af956f3f59a9c, 0x419086a2783956a1, 0x4175f58baee1093f, 0x40a88b2f6c200000, 0x40a8d54d48547b05, 0x40b88b2f6c200000, 0x40b8d54d48547b05, + 0x40c2686391180000, 0x40c29ff9f63f5c44, 0x40c88b2f6c200000, 0x40c8d54d48547b05, 0x40ceadfb47280000, 0x40cf0aa09a6999c6, 0x40d2686391180000, 0x40d29ff9f63f5c44, + 0x40d579c97e9c0000, 0x40d5baa39f49eba4, 0x40d88b2f6c200000, 0x40d8d54d48547b05, 0x40db9c9559a40000, 0x40dbeff6f15f0a66, 0x40deadfb47280000, 0x40df0aa09a6999c6, + 0x40e0dfb09a560000, 0x40e112a521ba1493, 0x40e2686391180000, 0x40e29ff9f63f5c44, 0x40e3f11687da0000, 0x40e42d4ecac4a3f4, 0x40e579c97e9c0000, 0x40e5baa39f49eba4, + 0x40e7027c755e0000, 0x40e747f873cf3355, 0x40e88b2f6c200000, 0x40e8d54d48547b05, 0x40ea13e262e20000, 0x40ea62a21cd9c2b5, 0x40eb9c9559a40000, 0x40ebeff6f15f0a66, + 0x40ed254850660000, 0x40ed7d4bc5e45216, 0x40eeadfb47280000, 0x40ef0aa09a6999c6, 0x40f01b571ef50000, 0x40f04bfab77770bb, 0x40f0dfb09a560000, 0x40f112a521ba1493, + 0x40f1a40a15b70000, 0x40f1d94f8bfcb86c, 0x40f2686391180000, 0x40f29ff9f63f5c44, 0x40f32cbd0c790000, 0x40f366a46082001c, 0x40f3f11687da0000, 0x40f42d4ecac4a3f4, + 0x40f4b570033b0000, 0x40f4f3f9350747cc, 0x40f579c97e9c0000, 0x40f5baa39f49eba4, 0x40f63e22f9fd0000, 0x40f6814e098c8f7d, 0x40f7027c755e0000, 0x40f747f873cf3355, + 0x40f7c6d5f0bf0000, 0x40f80ea2de11d72d, 0x40f88b2f6c200000, 0x40f8d54d48547b05, 0x40f94f88e7810000, 0x40f99bf7b2971edd, 0x40fa13e262e20000, 0x40fa62a21cd9c2b5, + 0x40fad83bde430000, 0x40fb294c871c668d, 0x40fb9c9559a40000, 0x40fbeff6f15f0a66, 0x40fc60eed5050000, 0x40fcb6a15ba1ae3e, 0x40fd254850660000, 0x40fd7d4bc5e45216, + 0x40fde9a1cbc70000, 0x40fe43f63026f5ee, 0x40feadfb47280000, 0x40ff0aa09a6999c6, 0x40ff7254c2890000, 0x40ffd14b04ac3d9e, 0x41001b571ef50000, 0x41004bfab77770bb, + 0x41007d83dca58000, 0x4100af4fec98c2a7, 0x4100dfb09a560000, 0x410112a521ba1493, 0x410141dd58068000, 0x410175fa56db6680, 0x4101a40a15b70000, 0x4101d94f8bfcb86c, + 0x41020636d3678000, 0x41023ca4c11e0a58, 0x4102686391180000, 0x41029ff9f63f5c44, 0x4102ca904ec88000, 0x4103034f2b60ae30, 0x41032cbd0c790000, 0x410366a46082001c, + 0x41038ee9ca298000, 0x4103c9f995a35208, 0x4103f11687da0000, 0x41042d4ecac4a3f4, 0x41045343458a8000, 0x410490a3ffe5f5e0, 0x4104b570033b0000, 0x4104f3f9350747cc, + 0x4105179cc0eb8000, 0x4105574e6a2899b8, 0x410579c97e9c0000, 0x4105baa39f49eba4, 0x4105dbf63c4c8000, 0x41061df8d46b3d90, 0x41063e22f9fd0000, 0x4106814e098c8f7d, + 0x4106a04fb7ad8000, 0x4106e4a33eade169, 0x4107027c755e0000, 0x410747f873cf3355, 0x410764a9330e8000, 0x4107ab4da8f08541, 0x4107c6d5f0bf0000, 0x41080ea2de11d72d, + 0x41082902ae6f8000, 0x410871f813332919, 0x41088b2f6c200000, 0x4108d54d48547b05, 0x4108ed5c29d08000, 0x410938a27d75ccf1, 0x41094f88e7810000, 0x41099bf7b2971edd, + 0x4109b1b5a5318000, 0x4109ff4ce7b870c9, 0x410a13e262e20000, 0x410a62a21cd9c2b5, 0x410a760f20928000, 0x410ac5f751fb14a1, 0x410ad83bde430000, 0x410b294c871c668d, + 0x410b3a689bf38000, 0x410b8ca1bc3db87a, 0x410b9c9559a40000, 0x410beff6f15f0a66, 0x410bfec217548000, 0x410c534c26805c52, 0x410c60eed5050000, 0x410cb6a15ba1ae3e, + 0x410cc31b92b58000, 0x410d19f690c3002a, 0x410d254850660000, 0x410d7d4bc5e45216, 0x410d87750e168000, 0x410de0a0fb05a402, 0x410de9a1cbc70000, 0x410e43f63026f5ee, + 0x410e4bce89778000, 0x410ea74b654847da, 0x410eadfb47280000, 0x410f0aa09a6999c6, 0x410f102804d88000, 0x410f6df5cf8aebb2, 0x410f7254c2890000, 0x410fd14b04ac3d9e, + 0x410fd48180398000, 0x41101a501ce6c7c5, 0x41101b571ef50000, 0x41104bfab77770bb, 0x41104c6d7dcd4000, 0x41107da5520819b1, 0x41107d83dca58000, 0x4110af4fec98c2a7, + 0x4110ae9a3b7dc000, 0x4110e0fa87296b9d, 0x4110dfb09a560000, 0x411112a521ba1493, 0x411110c6f92e4000, 0x4111444fbc4abd89, 0x411141dd58068000, 0x411175fa56db6680, + 0x411172f3b6dec000, 0x4111a7a4f16c0f76, 0x4111a40a15b70000, 0x4111d94f8bfcb86c, 0x4111d520748f4000, 0x41120afa268d6162, 0x41120636d3678000, 0x41123ca4c11e0a58, + 0x4112374d323fc000, 0x41126e4f5baeb34e, 0x4112686391180000, 0x41129ff9f63f5c44, 0x41129979eff04000, 0x4112d1a490d0053a, 0x4112ca904ec88000, 0x4113034f2b60ae30, + 0x4112fba6ada0c000, 0x411334f9c5f15726, 0x41132cbd0c790000, 0x411366a46082001c, 0x41135dd36b514000, 0x4113984efb12a912, 0x41138ee9ca298000, 0x4113c9f995a35208, + 0x4113c0002901c000, 0x4113fba43033fafe, 0x4113f11687da0000, 0x41142d4ecac4a3f4, 0x4114222ce6b24000, 0x41145ef965554cea, 0x41145343458a8000, 0x411490a3ffe5f5e0, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3f9041f386ab0d8e, 0x3fe9ba4a85e6e174, 0x3fe9ba4a85e6bb65, 0x3fe9ba4a85e6f47b, 0x3fe9ba4a85e6a85e, 0x3fd2bd43d0eba6f6, 0x3fd2bd43d0eab22e, 0x3fd2bd43d0ec215a, + 0x3fd2bd43d0ea37ca, 0xbfea835a25a9a62c, 0xbfea835a25aa3584, 0xbfea835a25a95e80, 0xbfea835a25aa7d30, 0x3fd7de36a117fc3b, 0x3fd7de36a11bb25b, 0x3fd7de36a116212b, + 0x3fd7de36a11d8d6b, 0xbfe71945310a8ae2, 0xbfe719453107c635, 0xbfe71945310bed38, 0xbfe71945310663df, 0x3fa58ced662c7ccb, 0x3fa58ced65ac99d5, 0x3fa58ced666c6e46, + 0x3fa58ced656ca85a, 0xbfefe2f9378b8cc8, 0xbfefe2f9378ce549, 0xbfefe2f9378ae088, 0xbfefe2f9378d9189, 0x3fef8c1986c7b96a, 0x3fef8c1986cd168b, 0x3fef8c1986c50ada, + 0x3fef8c1986cfc51b, 0x3fee33ada9254f48, 0x3fee33ada93a7614, 0x3fee33ada91abbe1, 0x3fee33ada945097b, 0x3fefeee78e111f71, 0x3fe98c8906317f89, 0x3fef7e0b0a6c4088, + 0x3fec22656e4b15af, 0x3fd011af6244cc6a, 0x3feff694e10528b3, 0x3feffaeca000f8eb, 0x3fefffffffba912b, 0x3fe9a6bd73fd4b47, 0x3feffffffeea44ad, 0x3fd23fb35cc33541, + 0x3feffffffd8f1a84, 0xbfd60bc5ad6595f8, 0x3feffffffba912b2, 0xbfeacbebb4bce650, 0x3feffffff9382d37, 0xbfefeffe6c39a05d, 0x3feffffff63c6a12, 0xbfe867e5ee73fcaa, + 0x3feffffff2b5c943, 0xbfccc2bf1879bfa5, 0x3fefffffeea44acb, 0x3fd9c1ca0c00f5fe, 0x3fefffffea07eeaa, 0x3febd64b658b31ea, 0x3fefffffe4e0b4df, 0x3fefc009b40e3602, + 0x3fefffffdf2e9d6b, 0x3fe710a41b143da1, 0x3fefffffd8f1a84d, 0x3fc4e951e2894bb9, 0x3fefffffd229d587, 0xbfdd5e0a168febe6, 0x3fefffffcad72518, 0xbfecc4d20c75a005, + 0x3fefffffc2f99700, 0xbfef7051d0f03aa9, 0x3fefffffba912b3f, 0xbfe5a24f5d88fe3e, 0x3fefffffb19de1d6, 0xbfb9f5f295f4b6df, 0x3fefffffa81fbac5, 0x3fe06e7498f55e6c, + 0x3fefffff9e16b60b, 0x3fed96910b510e68, 0x3fefffff9382d3a9, 0x3fef0126829e48d3, 0x3fefffff8864139f, 0x3fe41e562eab10af, 0x3fefffff7cba75ee, 0x3fa3fe91ca384f68, + 0x3fefffff7085fa95, 0xbfe21d74136007d7, 0x3fefffff63c6a195, 0xbfee4ab68e71fd1c, 0x3fefffff567c6aee, 0xbfee72f6ff5c9668, 0x3fefffff48a756a0, 0xbfe2863cade9b45e, + 0x3fefffff3a4764ab, 0x3f980584438de084, 0x3fefffff2b5c9511, 0x3fe3ba54509278fd, 0x3fefffff1be6e7d0, 0x3feee08e5e932130, 0x3fefffff0be65ce9, 0x3fedc65184b264ad, + 0x3feffffefb5af45c, 0x3fe0db9b1cffb356, 0x3feffffeea44ae2b, 0xbfb5fc090e4505ae, 0x3feffffed8a38a54, 0xbfe543784798f80a, 0x3feffffec67788d9, 0xbfef5782951f5382, + 0x3feffffeb3c0a9b9, 0xbfecfbe2c91e690a, 0x3feffffea07eecf5, 0xbfde40388f18cb74, 0x3feffffe8cb2528d, 0x3fc2f0596be5d162, 0x3feffffe785ada82, 0x3fe6b756adbce12d, + 0x3feffffe637884d4, 0x3fefaf1c32253068, 0x3feffffe4e0b5184, 0x3fec14754f525e95, 0x3feffffe38134091, 0x3fdaaaf7b036e391, 0x3feffffe219051fc, 0xbfcacfbc19547a50, + 0x3feffffe0a8285c5, 0xbfe8147b7ff0ee2b, 0x3feffffdf2e9dbed, 0xbfefe7039365b55c, 0x3feffffddac65474, 0xbfeb10f09b98b12d, 0x3feffffdc217ef5b, 0xbfd6fb0938af3272, + 0x3feffffda8deaca2, 0x3fd14a2632fec112, 0x3feffffd8f1a8c4a, 0x3fe9598976f40123, 0x3feffffd74cb8e52, 0x3fefff00cbfc613e, 0x3feffffd59f1b2bc, 0x3fe9f2584c3717ae, + 0x3feffffd3e8cf987, 0x3fd3341d73f785bc, 0x3feffffd229d62b5, 0xbfd51b227ed5ffca, 0x3feffffd0622ee45, 0xbfea853b64c91a8e, 0x3feffffce91d9c39, 0xbfeff6fbdc5399b3, + 0x3feffffccb8d6c90, 0xbfe8b9cb15bf5e14, 0x3feffffcad725f4c, 0xbfceb3f75a5a0e4e, 0x3feffffc8ecc746c, 0x3fd8d701938d260e, 0x3feffffc6f9babf2, 0x3feb966579f2a4f8, + 0x3feffffc4fe005dd, 0x3fefcefcca25873e, 0x3feffffc2f99822f, 0x3fe76881a43a400a, 0x3feffffc0ec820e7, 0x3fc6e0fccea8b647, 0x3feffffbed6be207, 0xbfdc7a0733cdfef2, + 0x3feffffbcb84c58f, 0xbfec8bf671722a6a, 0x3feffffba912cb7f, 0xbfef872b987510cb, 0x3feffffb8615f3d9, 0xbfe5ffcd6253c018, 0x3feffffb628e3e9c, 0xbfbdee3e09750482, + 0x3feffffb3e7babca, 0x3fe00047ff1fcc6f, 0x3feffffb19de3b62, 0x3fed64f8a218d4ef, 0x3feffffaf4b5ed66, 0x3fef1fd01f8876c2, 0x3feffffacf02c1d7, 0x3fe4811727df053f, + 0x3feffffaa8c4b8b4, 0x3fabf92288b6393e, 0x3feffffa81fbd1fe, 0xbfe1b38a88889401, 0x3feffffa5aa80db7, 0xbfee2092f45039b5, 0x3feffffa32c96bde, 0xbfee9951c50a2372, + 0x3feffffa0a5fec75, 0xbfe2edddd0d3d6f9, 0x3feffff9e16b8f7c, 0x3f8018cb98cfb9a8, 0x3feffff9b7ec54f4, 0x3fe35517c8b6864f, 0x3feffff98de23cde, 0x3feebe09bb4ab937, + 0x3feffff9634d473a, 0x3fedf43714948e65, 0x3feffff9382d7409, 0x3fe147b4be42b295, 0x3feffff90c82c34b, 0xbfb200c0de54eaa8, 0x3feffff8e04d3502, 0xbfe4e34e093cad75, + 0x3feffff8b38cc92e, 0xbfef3cbf70ba0350, 0x3feffff886417fd0, 0xbfed3125391fab53, 0x3feffff8586b58e9, 0xbfdf208485bdb4ec, 0x3feffff82a0a547a, 0x3fc0f632e12f9fb2, + 0x3feffff7fb1e7283, 0x3fe65c9eec994152, 0x3feffff7cba7b304, 0x3fef9c35526b042f, 0x3feffff79ba61600, 0x3fec50df57c1b498, 0x3feffff76b199b77, 0x3fdb927bf8f99253, + 0x3feffff73a024369, 0xbfc8db0d7428af50, 0x3feffff708600dd7, 0xbfe7bf90fcb19afa, 0x3feffff6d632fac3, 0xbfefdc0be11241e8, 0x3feffff6a37b0a2c, 0xbfeb5445cc7bef99, + 0x3feffff670383c15, 0xbfd7e8de385ee5c9, 0x3feffff63c6a907d, 0x3fd053854345cd43, 0x3feffff608120766, 0x3fe90ac1248353ee, 0x3feffff5d32ea0d1, 0x3feffc033fd80f93, + 0x3feffff59dc05cbe, 0x3fea3c5549b8575f, 0x3feffff567c73b2e, 0x3fd427553e29e8ac, 0x3feffff531433c23, 0xbfd4292eab31ccdf, 0x3feffff4fa345f9d, 0xbfea3ce4133b0874, + 0x3feffff4c29aa59d, 0xbfeffbfb7435b58b, 0x3feffff48a760e24, 0xbfe90a25db95f3d5, 0x3feffff451c69933, 0xbfd051a2f21e112a, 0x3feffff4188c46cb, 0x3fd7eaace7ab3ed8, +] )) ), + +################ chunk 18944 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x41148459a462c000, 0x4114c24e9a769ed6, 0x4114b570033b0000, 0x4114f3f9350747cc, 0x4114e68662134000, 0x411525a3cf97f0c2, 0x4115179cc0eb8000, 0x4115574e6a2899b8, + 0x411548b31fc3c000, 0x411588f904b942ae, 0x411579c97e9c0000, 0x4115baa39f49eba4, 0x4115aadfdd744000, 0x4115ec4e39da949a, 0x4115dbf63c4c8000, 0x41161df8d46b3d90, + 0x41160d0c9b24c000, 0x41164fa36efbe687, 0x41163e22f9fd0000, 0x4116814e098c8f7d, 0x41166f3958d54000, 0x4116b2f8a41d3873, 0x4116a04fb7ad8000, 0x4116e4a33eade169, + 0x4116d1661685c000, 0x4117164dd93e8a5f, 0x4117027c755e0000, 0x411747f873cf3355, 0x41173392d4364000, 0x411779a30e5fdc4b, 0x411764a9330e8000, 0x4117ab4da8f08541, + 0x411795bf91e6c000, 0x4117dcf843812e37, 0x4117c6d5f0bf0000, 0x41180ea2de11d72d, 0x4117f7ec4f974000, 0x4118404d78a28023, 0x41182902ae6f8000, 0x411871f813332919, + 0x41185a190d47c000, 0x4118a3a2adc3d20f, 0x41188b2f6c200000, 0x4118d54d48547b05, 0x4118bc45caf84000, 0x411906f7e2e523fb, 0x4118ed5c29d08000, 0x411938a27d75ccf1, + 0x41191e7288a8c000, 0x41196a4d180675e7, 0x41194f88e7810000, 0x41199bf7b2971edd, 0x4119809f46594000, 0x4119cda24d27c7d3, 0x4119b1b5a5318000, 0x4119ff4ce7b870c9, + 0x4119e2cc0409c000, 0x411a30f7824919bf, 0x411a13e262e20000, 0x411a62a21cd9c2b5, 0x411a44f8c1ba4000, 0x411a944cb76a6bab, 0x411a760f20928000, 0x411ac5f751fb14a1, + 0x411aa7257f6ac000, 0x411af7a1ec8bbd97, 0x411ad83bde430000, 0x411b294c871c668d, 0x411b09523d1b4000, 0x411b5af721ad0f84, 0x411b3a689bf38000, 0x411b8ca1bc3db87a, + 0x411b6b7efacbc000, 0x411bbe4c56ce6170, 0x411b9c9559a40000, 0x411beff6f15f0a66, 0x411bcdabb87c4000, 0x411c21a18befb35c, 0x411bfec217548000, 0x411c534c26805c52, + 0x411c2fd8762cc000, 0x411c84f6c1110548, 0x411c60eed5050000, 0x411cb6a15ba1ae3e, 0x411c920533dd4000, 0x411ce84bf6325734, 0x411cc31b92b58000, 0x411d19f690c3002a, + 0x411cf431f18dc000, 0x411d4ba12b53a920, 0x411d254850660000, 0x411d7d4bc5e45216, 0x411d565eaf3e4000, 0x411daef66074fb0c, 0x411d87750e168000, 0x411de0a0fb05a402, + 0x411db88b6ceec000, 0x411e124b95964cf8, 0x411de9a1cbc70000, 0x411e43f63026f5ee, 0x411e1ab82a9f4000, 0x411e75a0cab79ee4, 0x411e4bce89778000, 0x411ea74b654847da, + 0x411e7ce4e84fc000, 0x411ed8f5ffd8f0d0, 0x411eadfb47280000, 0x411f0aa09a6999c6, 0x411edf11a6004000, 0x411f3c4b34fa42bc, 0x411f102804d88000, 0x411f6df5cf8aebb2, + 0x411f413e63b0c000, 0x411f9fa06a1b94a8, 0x411f7254c2890000, 0x411fd14b04ac3d9e, 0x411fa36b21614000, 0x4120017acf9e734a, 0x411fd48180398000, 0x41201a501ce6c7c5, + 0x412002cbef88e000, 0x412033256a2f1c40, 0x41201b571ef50000, 0x41204bfab77770bb, 0x412033e24e612000, 0x412064d004bfc536, 0x41204c6d7dcd4000, 0x41207da5520819b1, + 0x412064f8ad396000, 0x4120967a9f506e2c, 0x41207d83dca58000, 0x4120af4fec98c2a7, 0x4120960f0c11a000, 0x4120c82539e11722, 0x4120ae9a3b7dc000, 0x4120e0fa87296b9d, + 0x4120c7256ae9e000, 0x4120f9cfd471c018, 0x4120dfb09a560000, 0x412112a521ba1493, 0x4120f83bc9c22000, 0x41212b7a6f02690e, 0x412110c6f92e4000, 0x4121444fbc4abd89, + 0x41212952289a6000, 0x41215d2509931205, 0x412141dd58068000, 0x412175fa56db6680, 0x41215a688772a000, 0x41218ecfa423bafb, 0x412172f3b6dec000, 0x4121a7a4f16c0f76, + 0x41218b7ee64ae000, 0x4121c07a3eb463f1, 0x4121a40a15b70000, 0x4121d94f8bfcb86c, 0x4121bc9545232000, 0x4121f224d9450ce7, 0x4121d520748f4000, 0x41220afa268d6162, + 0x4121edaba3fb6000, 0x412223cf73d5b5dd, 0x41220636d3678000, 0x41223ca4c11e0a58, 0x41221ec202d3a000, 0x4122557a0e665ed3, 0x4122374d323fc000, 0x41226e4f5baeb34e, + 0x41224fd861abe000, 0x41228724a8f707c9, 0x4122686391180000, 0x41229ff9f63f5c44, 0x412280eec0842000, 0x4122b8cf4387b0bf, 0x41229979eff04000, 0x4122d1a490d0053a, + 0x4122b2051f5c6000, 0x4122ea79de1859b5, 0x4122ca904ec88000, 0x4123034f2b60ae30, 0x4122e31b7e34a000, 0x41231c2478a902ab, 0x4122fba6ada0c000, 0x412334f9c5f15726, + 0x41231431dd0ce000, 0x41234dcf1339aba1, 0x41232cbd0c790000, 0x412366a46082001c, 0x412345483be52000, 0x41237f79adca5497, 0x41235dd36b514000, 0x4123984efb12a912, + 0x4123765e9abd6000, 0x4123b124485afd8d, 0x41238ee9ca298000, 0x4123c9f995a35208, 0x4123a774f995a000, 0x4123e2cee2eba683, 0x4123c0002901c000, 0x4123fba43033fafe, + 0x4123d88b586de000, 0x412414797d7c4f79, 0x4123f11687da0000, 0x41242d4ecac4a3f4, 0x412409a1b7462000, 0x41244624180cf86f, 0x4124222ce6b24000, 0x41245ef965554cea, + 0x41243ab8161e6000, 0x412477ceb29da165, 0x41245343458a8000, 0x412490a3ffe5f5e0, 0x41246bce74f6a000, 0x4124a9794d2e4a5b, 0x41248459a462c000, 0x4124c24e9a769ed6, + 0x41249ce4d3cee000, 0x4124db23e7bef351, 0x4124b570033b0000, 0x4124f3f9350747cc, 0x4124cdfb32a72000, 0x41250cce824f9c47, 0x4124e68662134000, 0x412525a3cf97f0c2, + 0x4124ff11917f6000, 0x41253e791ce0453d, 0x4125179cc0eb8000, 0x4125574e6a2899b8, 0x41253027f057a000, 0x41257023b770ee33, 0x412548b31fc3c000, 0x412588f904b942ae, + 0x4125613e4f2fe000, 0x4125a1ce52019729, 0x412579c97e9c0000, 0x4125baa39f49eba4, 0x41259254ae082000, 0x4125d378ec92401f, 0x4125aadfdd744000, 0x4125ec4e39da949a, + 0x4125c36b0ce06000, 0x412605238722e915, 0x4125dbf63c4c8000, 0x41261df8d46b3d90, 0x4125f4816bb8a000, 0x412636ce21b3920b, 0x41260d0c9b24c000, 0x41264fa36efbe687, + 0x41262597ca90e000, 0x41266878bc443b02, 0x41263e22f9fd0000, 0x4126814e098c8f7d, 0x412656ae29692000, 0x41269a2356d4e3f8, 0x41266f3958d54000, 0x4126b2f8a41d3873, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3feffff3dec716ed, 0x3feb54c787bc5b9b, 0x3feffff3a477099a, 0x3fefdbf485f79ae3, 0x3feffff3699c1ed3, 0x3fe7bee9cfb1c801, 0x3feffff32e365699, 0x3fc8d73ace9aee41, + 0x3feffff2f245b0ed, 0xbfdb943e1bad779a, 0x3feffff2b5ca2dcf, 0xbfec515382fb8b3c, 0x3feffff278c3cd42, 0xbfef9c0e7f34398b, 0x3feffff23b328f46, 0xbfe65bec82bebd2d, + 0x3feffff1fd1673dc, 0xbfc0f2560b699cbd, 0x3feffff1be6f7b04, 0x3fdf2238598a1329, 0x3feffff17f3da4c1, 0x3fed318b6014cf06, 0x3feffff13f80f114, 0x3fef3c894c409c02, + 0x3feffff0ff395ffc, 0x3fe4e291150e5571, 0x3feffff0be66f17c, 0x3fb1f8fa8cc6e0fc, 0x3feffff07d09a595, 0xbfe14886a6b5bca2, 0x3feffff03b217c47, 0xbfedf48ed117b1ea, + 0x3fefffeff8ae7594, 0xbfeebdc47bb7460e, 0x3fefffefb5b0917c, 0xbfe3545107357011, 0x3fefffef7227d002, 0xbf7fb4e429fab66c, 0x3fefffef2e143126, 0x3fe2eea6e5d697b0, + 0x3fefffeee975b4e9, 0x3fee999abf561d8a, 0x3fefffeea44c5b4c, 0x3fee203edee921b0, 0x3fefffee5e982452, 0x3fe1b2bac089d86c, 0x3fefffee18590ffa, 0xbfac08b30f990383, + 0x3fefffedd18f1e46, 0xbfe481d6a04bb98b, 0x3fefffed8a3a4f37, 0xbfef200a0e9cb7b4, 0x3fefffed425aa2ce, 0xbfed64960afa345a, 0x3fefffecf9f0190e, 0xbfdffee000f8de06, + 0x3fefffecb0fab1f6, 0x3fbdf5fb96f574bb, 0x3fefffec677a6d88, 0x3fe600827e9be1b3, 0x3fefffec1d6f4bc5, 0x3fef8756425ba2a3, 0x3fefffebd2d94caf, 0x3fec8b85bb3e3116, + 0x3fefffeb87b87047, 0x3fdc7848796c86ef, 0x3fefffeb3c0cb68e, 0xbfc6e4d25b380ea4, 0x3fefffeaefd61f86, 0xbfe7692baf2a381d, 0x3fefffeaa314ab2f, 0xbfefcf18042f6f4e, + 0x3fefffea55c8598b, 0xbfeb95e7156eb13b, 0x3fefffea07f12a9c, 0xbfd8d535dafebb99, 0x3fefffe9b98f1e62, 0x3fceb7bfd6bbad10, 0x3fefffe96aa234df, 0x3fe8ba696543d297, + 0x3fefffe91b2a6e14, 0x3feff7078b45ad38, 0x3fefffe8cb27ca03, 0x3fea84afd0604b54, 0x3fefffe87a9a48ae, 0x3fd5194b93f9587c, 0x3fefffe82981ea14, 0xbfd335f945ab6a1a, + 0x3fefffe7d7deae38, 0xbfe9f2ea41ee2edd, 0x3fefffe785b0951b, 0xbfeffefce4261776, 0x3fefffe732f79ebf, 0xbfe958f13e4a888c, 0x3fefffe6dfb3cb25, 0xbfd14845eced259f, + 0x3fefffe68be51a4e, 0x3fd6fcdac1e59028, 0x3fefffe6378b8c3c, 0x3feb1175a57e5081, 0x3fefffe5e2a720f0, 0x3fefe6f018aef736, 0x3fefffe58d37d86c, 0x3fe813d73b4bd4bc, + 0x3fefffe5373db2b0, 0x3fcacbec97a2898a, 0x3fefffe4e0b8afc0, 0xbfdaacbd1f3fe5bf, 0x3fefffe489a8cf9b, 0xbfec14ece8516e2a, 0x3fefffe4320e1244, 0xbfefaef9380ab030, + 0x3fefffe3d9e877bb, 0xbfe6b6a701736e65, 0x3fefffe381380004, 0xbfc2ec7ec4966a36, 0x3fefffe327fcab1e, 0x3fde41f01e513ed8, 0x3fefffe2ce36790b, 0x3fecfc4c7990d660, + 0x3fefffe273e569ce, 0x3fef57503e9e3716, 0x3fefffe219097d67, 0x3fe542bde3674806, 0x3fefffe1bda2b3d8, 0x3fb5f4452a6c7ec6, 0x3fefffe161b10d23, 0xbfe0dc6f18d81240, + 0x3fefffe105348949, 0xbfedc6ace2dc5ca0, 0x3fefffe0a82d284b, 0xbfeee04cde0727c6, 0x3fefffe04a9aea2c, 0xbfe3b98feeeef2ab, 0x3fefffdfec7dceed, 0xbf97e65971e36e1d, + 0x3fefffdf8dd5d690, 0x3fe2870809ed58d1, 0x3fefffdf2ea30115, 0x3fee7343afd78ab4, 0x3fefffdecee54e7f, 0x3fee4a66256182a4, 0x3fefffde6e9cbed0, 0x3fe21ca678c1293b, + 0x3fefffde0dc95208, 0xbfa40e253c3fe487, 0x3fefffddac6b082a, 0xbfe41f181f5d5517, 0x3fefffdd4a81e138, 0xbfef016438adfd10, 0x3fefffdce80ddd32, 0xbfed96320a32ec84, + 0x3fefffdc850efc1b, 0xbfe06d9e93160eb0, 0x3fefffdc21853df4, 0x3fb9fdb3898c0fc0, 0x3fefffdbbd70a2bf, 0x3fe5a30720f238d6, 0x3fefffdb58d12a7e, 0x3fef70804edd074e, + 0x3fefffdaf3a6d532, 0x3fecc464d24eee65, 0x3fefffda8df1a2dd, 0x3fdd5c4ee06bb7b4, 0x3fefffda27b19381, 0xbfc4ed2a18c31099, 0x3fefffd9c0e6a720, 0xbfe71150f95f8391, + 0x3fefffd95990ddba, 0xbfefc028cb55997e, 0x3fefffd8f1b03753, 0xbfebd5d05fa12071, 0x3fefffd88944b3ec, 0xbfd9c00166d9b1c5, 0x3fefffd8204e5386, 0x3fccc68b328e2e93, + 0x3fefffd7b6cd1623, 0x3fe868873ab1247d, 0x3fefffd74cc0fbc6, 0x3feff00dfdc0fb35, 0x3fefffd6e22a0470, 0x3feacb635e20fae4, 0x3fefffd677083022, 0x3fd609f1620d463d, + 0x3fefffd60b5b7edf, 0xbfd24191757c7e1a, 0x3fefffd59f23f0a8, 0xbfe9a7528cd08225, 0x3fefffd53261857f, 0xbfeffffffc341213, 0x3fefffd4c5143d67, 0xbfe9a62855138045, + 0x3fefffd4573c1860, 0xbfd23dd53fb2fdc7, 0x3fefffd3e8d9166d, 0x3fd60d99f38674c6, 0x3fefffd379eb3790, 0x3feacc7404fe69a5, 0x3fefffd30a727bca, 0x3fefefeed31e05fc, + 0x3fefffd29a6ee31d, 0x3fe867449c69b24d, 0x3fefffd229e06d8c, 0x3fccbef2f782a318, 0x3fefffd1b8c71b19, 0xbfd9c392ab14c224, 0x3fefffd14722ebc4, 0xbfebd6c664dd3e04, + 0x3fefffd0d4f3df90, 0xbfefbfea953d6485, 0x3fefffd06239f67f, 0xbfe70ff7374bb61a, 0x3fefffcfeef53094, 0xbfc4e579a739ae59, 0x3fefffcf7b258dcf, 0x3fdd5fc545ca67b1, + 0x3fefffcf06cb0e33, 0x3fecc53f3fcc3e1b, 0x3fefffce91e5b1c1, 0x3fef70234b8bccc1, 0x3fefffce1c75787d, 0x3fe5a19794f6396e, 0x3fefffcda67a6267, 0x3fb9ee319be4c795, + 0x3fefffcd2ff46f83, 0xbfe06f4a9af8d6a0, 0x3fefffccb8e39fd1, 0xbfed96f0056e68d3, 0x3fefffcc4147f353, 0xbfef00e8c530396e, 0x3fefffcbc9216a0d, 0xbfe41d9439295b21, + 0x3fefffcb50700400, 0xbfa3eefe52b24d44, 0x3fefffcad733c12d, 0x3fe21e41a9b27d56, 0x3fefffca5d6ca198, 0x3fee4b06f0525e82, 0x3fefffc9e31aa541, 0x3fee72aa47a7fbec, + 0x3fefffc9683dcc2c, 0x3fe285714d80c9a9, 0x3fefffc8ecd6165a, 0xbf9824af0f851e8c, 0x3fefffc870e383cd, 0xbfe3bb18ad879dc8, 0x3fefffc7f4661487, 0xbfeee0cfd7c84d11, + 0x3fefffc7775dc88b, 0xbfedc5f61f7c2417, 0x3fefffc6f9ca9fdb, 0xbfe0dac71d317d8d, 0x3fefffc67bac9a78, 0x3fb603ccec867110, 0x3fefffc5fd03b866, 0x3fe54432a6b60594, +] )) ), + +################ chunk 19456 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x412687c488416000, 0x4126cbcdf1658cee, 0x4126a04fb7ad8000, 0x4126e4a33eade169, 0x4126b8dae719a000, 0x4126fd788bf635e4, 0x4126d1661685c000, 0x4127164dd93e8a5f, + 0x4126e9f145f1e000, 0x41272f232686deda, 0x4127027c755e0000, 0x412747f873cf3355, 0x41271b07a4ca2000, 0x412760cdc11787d0, 0x41273392d4364000, 0x412779a30e5fdc4b, + 0x41274c1e03a26000, 0x412792785ba830c6, 0x412764a9330e8000, 0x4127ab4da8f08541, 0x41277d34627aa000, 0x4127c422f638d9bc, 0x412795bf91e6c000, 0x4127dcf843812e37, + 0x4127ae4ac152e000, 0x4127f5cd90c982b2, 0x4127c6d5f0bf0000, 0x41280ea2de11d72d, 0x4127df61202b2000, 0x412827782b5a2ba8, 0x4127f7ec4f974000, 0x4128404d78a28023, + 0x412810777f036000, 0x41285922c5ead49e, 0x41282902ae6f8000, 0x412871f813332919, 0x4128418ddddba000, 0x41288acd607b7d94, 0x41285a190d47c000, 0x4128a3a2adc3d20f, + 0x412872a43cb3e000, 0x4128bc77fb0c268a, 0x41288b2f6c200000, 0x4128d54d48547b05, 0x4128a3ba9b8c2000, 0x4128ee22959ccf80, 0x4128bc45caf84000, 0x412906f7e2e523fb, + 0x4128d4d0fa646000, 0x41291fcd302d7876, 0x4128ed5c29d08000, 0x412938a27d75ccf1, 0x412905e7593ca000, 0x41295177cabe216c, 0x41291e7288a8c000, 0x41296a4d180675e7, + 0x412936fdb814e000, 0x41298322654eca62, 0x41294f88e7810000, 0x41299bf7b2971edd, 0x4129681416ed2000, 0x4129b4ccffdf7358, 0x4129809f46594000, 0x4129cda24d27c7d3, + 0x4129992a75c56000, 0x4129e6779a701c4e, 0x4129b1b5a5318000, 0x4129ff4ce7b870c9, 0x4129ca40d49da000, 0x412a18223500c544, 0x4129e2cc0409c000, 0x412a30f7824919bf, + 0x4129fb573375e000, 0x412a49cccf916e3a, 0x412a13e262e20000, 0x412a62a21cd9c2b5, 0x412a2c6d924e2000, 0x412a7b776a221730, 0x412a44f8c1ba4000, 0x412a944cb76a6bab, + 0x412a5d83f1266000, 0x412aad2204b2c026, 0x412a760f20928000, 0x412ac5f751fb14a1, 0x412a8e9a4ffea000, 0x412adecc9f43691c, 0x412aa7257f6ac000, 0x412af7a1ec8bbd97, + 0x412abfb0aed6e000, 0x412b107739d41212, 0x412ad83bde430000, 0x412b294c871c668d, 0x412af0c70daf2000, 0x412b4221d464bb09, 0x412b09523d1b4000, 0x412b5af721ad0f84, + 0x412b21dd6c876000, 0x412b73cc6ef563ff, 0x412b3a689bf38000, 0x412b8ca1bc3db87a, 0x412b52f3cb5fa000, 0x412ba57709860cf5, 0x412b6b7efacbc000, 0x412bbe4c56ce6170, + 0x412b840a2a37e000, 0x412bd721a416b5eb, 0x412b9c9559a40000, 0x412beff6f15f0a66, 0x412bb52089102000, 0x412c08cc3ea75ee1, 0x412bcdabb87c4000, 0x412c21a18befb35c, + 0x412be636e7e86000, 0x412c3a76d93807d7, 0x412bfec217548000, 0x412c534c26805c52, 0x412c174d46c0a000, 0x412c6c2173c8b0cd, 0x412c2fd8762cc000, 0x412c84f6c1110548, + 0x412c4863a598e000, 0x412c9dcc0e5959c3, 0x412c60eed5050000, 0x412cb6a15ba1ae3e, 0x412c797a04712000, 0x412ccf76a8ea02b9, 0x412c920533dd4000, 0x412ce84bf6325734, + 0x412caa9063496000, 0x412d0121437aabaf, 0x412cc31b92b58000, 0x412d19f690c3002a, 0x412cdba6c221a000, 0x412d32cbde0b54a5, 0x412cf431f18dc000, 0x412d4ba12b53a920, + 0x412d0cbd20f9e000, 0x412d6476789bfd9b, 0x412d254850660000, 0x412d7d4bc5e45216, 0x412d3dd37fd22000, 0x412d9621132ca691, 0x412d565eaf3e4000, 0x412daef66074fb0c, + 0x412d6ee9deaa6000, 0x412dc7cbadbd4f87, 0x412d87750e168000, 0x412de0a0fb05a402, 0x412da0003d82a000, 0x412df976484df87d, 0x412db88b6ceec000, 0x412e124b95964cf8, + 0x412dd1169c5ae000, 0x412e2b20e2dea173, 0x412de9a1cbc70000, 0x412e43f63026f5ee, 0x412e022cfb332000, 0x412e5ccb7d6f4a69, 0x412e1ab82a9f4000, 0x412e75a0cab79ee4, + 0x412e33435a0b6000, 0x412e8e7617fff35f, 0x412e4bce89778000, 0x412ea74b654847da, 0x412e6459b8e3a000, 0x412ec020b2909c55, 0x412e7ce4e84fc000, 0x412ed8f5ffd8f0d0, + 0x412e957017bbe000, 0x412ef1cb4d21454b, 0x412eadfb47280000, 0x412f0aa09a6999c6, 0x412ec68676942000, 0x412f2375e7b1ee41, 0x412edf11a6004000, 0x412f3c4b34fa42bc, + 0x412ef79cd56c6000, 0x412f552082429737, 0x412f102804d88000, 0x412f6df5cf8aebb2, 0x412f28b33444a000, 0x412f86cb1cd3402d, 0x412f413e63b0c000, 0x412f9fa06a1b94a8, + 0x412f59c9931ce000, 0x412fb875b763e923, 0x412f7254c2890000, 0x412fd14b04ac3d9e, 0x412f8adff1f52000, 0x412fea2051f49219, 0x412fa36b21614000, 0x4130017acf9e734a, + 0x412fbbf650cd6000, 0x41300de576429d88, 0x412fd48180398000, 0x41301a501ce6c7c5, 0x412fed0cafa5a000, 0x413026bac38af203, 0x413002cbef88e000, 0x413033256a2f1c40, + 0x41300f11873ef000, 0x41303f9010d3467e, 0x41301b571ef50000, 0x41304bfab77770bb, 0x4130279cb6ab1000, 0x413058655e1b9af9, 0x413033e24e612000, 0x413064d004bfc536, + 0x41304027e6173000, 0x4130713aab63ef74, 0x41304c6d7dcd4000, 0x41307da5520819b1, 0x413058b315835000, 0x41308a0ff8ac43ef, 0x413064f8ad396000, 0x4130967a9f506e2c, + 0x4130713e44ef7000, 0x4130a2e545f4986a, 0x41307d83dca58000, 0x4130af4fec98c2a7, 0x413089c9745b9000, 0x4130bbba933cece5, 0x4130960f0c11a000, 0x4130c82539e11722, + 0x4130a254a3c7b000, 0x4130d48fe0854160, 0x4130ae9a3b7dc000, 0x4130e0fa87296b9d, 0x4130badfd333d000, 0x4130ed652dcd95db, 0x4130c7256ae9e000, 0x4130f9cfd471c018, + 0x4130d36b029ff000, 0x4131063a7b15ea56, 0x4130dfb09a560000, 0x413112a521ba1493, 0x4130ebf6320c1000, 0x41311f0fc85e3ed1, 0x4130f83bc9c22000, 0x41312b7a6f02690e, + 0x4131048161783000, 0x413137e515a6934c, 0x413110c6f92e4000, 0x4131444fbc4abd89, 0x41311d0c90e45000, 0x413150ba62eee7c7, 0x41312952289a6000, 0x41315d2509931205, + 0x41313597c0507000, 0x4131698fb0373c42, 0x413141dd58068000, 0x413175fa56db6680, 0x41314e22efbc9000, 0x41318264fd7f90bd, 0x41315a688772a000, 0x41318ecfa423bafb, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3fefffc57dcff9a5, 0x3fef57b4e42e2340, 0x3fefffc4fe115e39, 0x3fecfb7911d06c58, 0x3fefffc47dc7e623, 0x3fde3e80f8c0d65d, 0x3fefffc3fcf39165, 0xbfc2f4340e971ee4, + 0x3fefffc37b946002, 0xbfe6b806549cc957, 0x3fefffc2f9aa51fd, 0xbfefaf3f24b9e762, 0x3fefffc277356756, 0xbfec13fdafad6a10, 0x3fefffc1f435a010, 0xbfdaa9323ae878b3, + 0x3fefffc170aafc2f, 0x3fcad38b948a7337, 0x3fefffc0ec957bb3, 0x3fe8151fbeda01b3, 0x3fefffc067f51e9e, 0x3fefe7170689e59d, 0x3fefffbfe2c9e4f5, 0x3feb106b8b46eb54, + 0x3fefffbf5d13ceb7, 0x3fd6f937aa04dc41, 0x3fefffbed6d2dbe9, 0xbfd14c0674f6177c, 0x3fefffbe50070c8c, 0xbfe95a21a99996fe, 0x3fefffbdc8b060a2, 0xbfefff04ac3b0bb9, + 0x3fefffbd40ced82d, 0xbfe9f1c65057db5a, 0x3fefffbcb8627331, 0xbfd332419db51912, 0x3fefffbc2f6b31af, 0x3fd51cf964b08e7f, 0x3fefffbba5e913a9, 0x3fea85c6f2e6e9e4, + 0x3fefffbb1bdc1922, 0x3feff6f025cbce03, 0x3fefffba9144421d, 0x3fe8b92cc05cee8d, 0x3fefffba06218e9b, 0x3fceb02ed6af5d47, 0x3fefffb97a73fe9f, 0xbfd8d8cd4636a6f2, + 0x3fefffb8ee3b922c, 0xbfeb96e3d7eed50f, 0x3fefffb861784943, 0xbfefcee1888e84ee, 0x3fefffb7d42a23e7, 0xbfe767d793b6e140, 0x3fefffb74651221b, 0xbfc6dd273cab9397, + 0x3fefffb6b7ed43e1, 0x3fdc7bc5e76da1b2, 0x3fefffb628fe893b, 0x3fec8c6720e00d0b, 0x3fefffb59984f22b, 0x3fef8700e7134eba, 0x3fefffb509807eb5, 0x3fe5ff1840d3432e, + 0x3fefffb478f12edb, 0x3fbde68074da6ca6, 0x3fefffb3e7d7029e, 0xbfe0011ff9f72aba, 0x3fefffb35631fa02, 0xbfed655b323de07e, 0x3fefffb2c4021509, 0xbfef1f9629118c17, + 0x3fefffb2314753b6, 0xbfe48057aa94c5b6, 0x3fefffb19e01b60a, 0xbfabe991fab0605a, 0x3fefffb10a313c09, 0x3fe1b45a4c5ab274, 0x3fefffb075d5e5b5, 0x3fee20e70293eafd, + 0x3fefffafe0efb310, 0x3fee9908c3791228, 0x3fefffaf4b7ea41e, 0x3fe2ed14b74cc5da, 0x3fefffaeb582b8df, 0xbf8057251ad043cc, 0x3fefffae1efbf158, 0xbfe355de85a7a0da, + 0x3fefffad87ea4d8b, 0xbfeebe4ef394ee92, 0x3fefffacf04dcd79, 0xbfedf3df50f307d9, 0x3fefffac58267127, 0xbfe146e2d1bcb3c4, 0x3fefffabbf743896, 0x3fb208872b5d8399, + 0x3fefffab263723c8, 0x3fe4e40af8701cf1, 0x3fefffaa8c6f32c2, 0x3fef3cf58dc8273c, 0x3fefffa9f21c6584, 0x3fed30bf0b40862d, 0x3fefffa9573ebc12, 0x3fdf1ed0aa9c7d8c, + 0x3fefffa8bbd6366e, 0xbfc0fa0fb2cf919c, 0x3fefffa81fe2d49c, 0xbfe65d515119f219, 0x3fefffa78364969d, 0xbfef9c5c1e1f237d, 0x3fefffa6e65b7c74, 0xbfec506b25d740ff, + 0x3fefffa648c78624, 0xbfdb90b9cfbac946, 0x3fefffa5aaa8b3b0, 0x3fc8dee013d09101, 0x3fefffa50bff051b, 0x3fe7c038240ed31f, 0x3fefffa46cca7a66, 0x3fefdc23349d9518, + 0x3fefffa3cd0b1395, 0x3feb53c40abf62e5, 0x3fefffa32cc0d0aa, 0x3fd7e70f83662500, 0x3fefffa28bebb1a8, 0xbfd05567908dc9ed, 0x3fefffa1ea8bb693, 0xbfe90b5c677f82fb, + 0x3fefffa148a0df6c, 0xbfeffc0b03e37ff7, 0x3fefffa0a62b2c36, 0xbfea3bc679fbf2af, 0x3fefffa0032a9cf4, 0xbfd4257bcc59c5c1, 0x3fefff9f5f9f31a9, 0x3fd42b0813710205, + 0x3fefff9ebb88ea58, 0x3fea3d72d683e40d, 0x3fefff9e16e7c703, 0x3feffbf3a0fc73b8, 0x3fefff9d71bbc7ad, 0x3fe9098a8cb78789, 0x3fefff9ccc04ec5a, 0x3fd04fc09d170815, + 0x3fefff9c25c3350b, 0xbfd7ec7b914ac263, 0x3fefff9b7ef6a1c4, 0xbfeb55493c808822, 0x3fefff9ad79f3287, 0xbfefdbdd234da594, 0x3fefff9a2fbce757, 0xbfe7be429d0f81de, + 0x3fefff99874fc038, 0xbfc8d3682328360c, 0x3fefff98de57bd2b, 0x3fdb960037d60e4b, 0x3fefff9834d4de35, 0x3fec51c7a7797b44, 0x3fefff978ac72357, 0x3fef9be7a47e88dd, + 0x3fefff96e02e8c95, 0x3fe65b3a139bbadf, 0x3fefff96350b19f1, 0x3fc0ee79317e72fd, 0x3fefff95895ccb6e, 0xbfdf23ec26013022, 0x3fefff94dd23a110, 0xbfed31f1801fd85c, + 0x3fefff94305f9ad9, 0xbfef3c53205bfd76, 0x3fefff938310b8cd, 0xbfe4e1d41be54141, 0x3fefff92d536faed, 0xbfb1f13436b53e72, 0x3fefff9226d2613d, 0x3fe149588b159fb7, + 0x3fefff9177e2ebc1, 0x3fedf4e68681fe7c, 0x3fefff90c8689a7a, 0x3feebd7f34d63443, 0x3fefff9018636d6c, 0x3fe3538a4117cd21, 0x3fefff8f67d3649b, 0x3f7f383116cff7d0, + 0x3fefff8eb6b88008, 0xbfe2ef6ff661bea6, 0x3fefff8e0512bfb7, 0xbfee99e3b2619da2, 0x3fefff8d52e223ab, 0xbfee1feac25951fc, 0x3fefff8ca026abe7, 0xbfe1b1eaf4515c9e, + 0x3fefff8bece0586d, 0x3fac18438f550e54, 0x3fefff8b390f2942, 0x3fe4829613ddc72d, 0x3fefff8a84b31e68, 0x3fef2043f64b7822, 0x3fefff89cfcc37e2, 0x3fed64336ce0812f, + 0x3fefff891a5a75b4, 0x3fdffd2ffc2f54e2, 0x3fefff88645dd7df, 0xbfbdfdb91d79aeb3, 0x3fefff87add65e68, 0xbfe6013795a2c69d, 0x3fefff86f6c40951, 0xbfef8780e4c7a91f, + 0x3fefff863f26d89e, 0xbfec8b14fe49a895, 0x3fefff8586fecc51, 0xbfdc7689b8427959, 0x3fefff84ce4be46f, 0x3fc6e8a7e2297a2e, 0x3fefff84150e20f9, 0x3fe769d5b499b7c9, + 0x3fefff835b4581f3, 0x3fefcf3336ad8631, 0x3fefff82a0f20760, 0x3feb9568aa54e6ce, 0x3fefff81e613b144, 0x3fd8d36a1c8bd4aa, 0x3fefff812aaa7fa2, 0xbfcebb884c11747e, + 0x3fefff806eb6727c, 0xbfe8bb07aeea2686, 0x3fefff7fb23789d5, 0xbfeff71332a2c4f5, 0x3fefff7ef52dc5b2, 0xbfea842435ac9d56, 0x3fefff7e37992616, 0xbfd51774a3fcd1f7, + 0x3fefff7d7979ab02, 0x3fd337d512d05544, 0x3fefff7cbacf547c, 0x3fe9f37c31865ac6, 0x3fefff7bfb9a2285, 0x3feffef8f4b82f50, 0x3fefff7b3bda1522, 0x3fe95858ff938cd4, + 0x3fefff7a7b8f2c55, 0x3fd14665a2c1b71a, 0x3fefff79bab96822, 0xbfd6feac45c563e6, 0x3fefff78f958c88b, 0xbfeb11faa8f7a9bd, 0x3fefff78376d4d95, 0xbfefe6dc9667e02d, + 0x3fefff7774f6f743, 0xbfe81332f0f2c392, 0x3fefff76b1f5c597, 0xbfcac81d0fe30d21, 0x3fefff75ee69b896, 0x3fdaae8287ed4272, 0x3fefff752a52d042, 0x3fec15647a9d0fa5, +] )) ), + +################ chunk 19968 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x413166ae1f28b000, 0x41319b3a4ac7e538, 0x413172f3b6dec000, 0x4131a7a4f16c0f76, 0x41317f394e94d000, 0x4131b40f981039b3, 0x41318b7ee64ae000, 0x4131c07a3eb463f1, + 0x413197c47e00f000, 0x4131cce4e5588e2e, 0x4131a40a15b70000, 0x4131d94f8bfcb86c, 0x4131b04fad6d1000, 0x4131e5ba32a0e2a9, 0x4131bc9545232000, 0x4131f224d9450ce7, + 0x4131c8dadcd93000, 0x4131fe8f7fe93724, 0x4131d520748f4000, 0x41320afa268d6162, 0x4131e1660c455000, 0x41321764cd318b9f, 0x4131edaba3fb6000, 0x413223cf73d5b5dd, + 0x4131f9f13bb17000, 0x4132303a1a79e01a, 0x41320636d3678000, 0x41323ca4c11e0a58, 0x4132127c6b1d9000, 0x4132490f67c23495, 0x41321ec202d3a000, 0x4132557a0e665ed3, + 0x41322b079a89b000, 0x413261e4b50a8910, 0x4132374d323fc000, 0x41326e4f5baeb34e, 0x41324392c9f5d000, 0x41327aba0252dd8b, 0x41324fd861abe000, 0x41328724a8f707c9, + 0x41325c1df961f000, 0x4132938f4f9b3206, 0x4132686391180000, 0x41329ff9f63f5c44, 0x413274a928ce1000, 0x4132ac649ce38681, 0x413280eec0842000, 0x4132b8cf4387b0bf, + 0x41328d34583a3000, 0x4132c539ea2bdafc, 0x41329979eff04000, 0x4132d1a490d0053a, 0x4132a5bf87a65000, 0x4132de0f37742f77, 0x4132b2051f5c6000, 0x4132ea79de1859b5, + 0x4132be4ab7127000, 0x4132f6e484bc83f2, 0x4132ca904ec88000, 0x4133034f2b60ae30, 0x4132d6d5e67e9000, 0x41330fb9d204d86d, 0x4132e31b7e34a000, 0x41331c2478a902ab, + 0x4132ef6115eab000, 0x4133288f1f4d2ce8, 0x4132fba6ada0c000, 0x413334f9c5f15726, 0x413307ec4556d000, 0x413341646c958163, 0x41331431dd0ce000, 0x41334dcf1339aba1, + 0x4133207774c2f000, 0x41335a39b9ddd5de, 0x41332cbd0c790000, 0x413366a46082001c, 0x41333902a42f1000, 0x4133730f07262a59, 0x413345483be52000, 0x41337f79adca5497, + 0x4133518dd39b3000, 0x41338be4546e7ed4, 0x41335dd36b514000, 0x4133984efb12a912, 0x41336a1903075000, 0x4133a4b9a1b6d34f, 0x4133765e9abd6000, 0x4133b124485afd8d, + 0x413382a432737000, 0x4133bd8eeeff27ca, 0x41338ee9ca298000, 0x4133c9f995a35208, 0x41339b2f61df9000, 0x4133d6643c477c46, 0x4133a774f995a000, 0x4133e2cee2eba683, + 0x4133b3ba914bb000, 0x4133ef39898fd0c1, 0x4133c0002901c000, 0x4133fba43033fafe, 0x4133cc45c0b7d000, 0x4134080ed6d8253c, 0x4133d88b586de000, 0x413414797d7c4f79, + 0x4133e4d0f023f000, 0x413420e4242079b7, 0x4133f11687da0000, 0x41342d4ecac4a3f4, 0x4133fd5c1f901000, 0x413439b97168ce32, 0x413409a1b7462000, 0x41344624180cf86f, + 0x413415e74efc3000, 0x4134528ebeb122ad, 0x4134222ce6b24000, 0x41345ef965554cea, 0x41342e727e685000, 0x41346b640bf97728, 0x41343ab8161e6000, 0x413477ceb29da165, + 0x413446fdadd47000, 0x413484395941cba3, 0x41345343458a8000, 0x413490a3ffe5f5e0, 0x41345f88dd409000, 0x41349d0ea68a201e, 0x41346bce74f6a000, 0x4134a9794d2e4a5b, + 0x413478140cacb000, 0x4134b5e3f3d27499, 0x41348459a462c000, 0x4134c24e9a769ed6, 0x4134909f3c18d000, 0x4134ceb9411ac914, 0x41349ce4d3cee000, 0x4134db23e7bef351, + 0x4134a92a6b84f000, 0x4134e78e8e631d8f, 0x4134b570033b0000, 0x4134f3f9350747cc, 0x4134c1b59af11000, 0x41350063dbab720a, 0x4134cdfb32a72000, 0x41350cce824f9c47, + 0x4134da40ca5d3000, 0x4135193928f3c685, 0x4134e68662134000, 0x413525a3cf97f0c2, 0x4134f2cbf9c95000, 0x4135320e763c1b00, 0x4134ff11917f6000, 0x41353e791ce0453d, + 0x41350b5729357000, 0x41354ae3c3846f7b, 0x4135179cc0eb8000, 0x4135574e6a2899b8, 0x413523e258a19000, 0x413563b910ccc3f6, 0x41353027f057a000, 0x41357023b770ee33, + 0x41353c6d880db000, 0x41357c8e5e151871, 0x413548b31fc3c000, 0x413588f904b942ae, 0x413554f8b779d000, 0x41359563ab5d6cec, 0x4135613e4f2fe000, 0x4135a1ce52019729, + 0x41356d83e6e5f000, 0x4135ae38f8a5c167, 0x413579c97e9c0000, 0x4135baa39f49eba4, 0x4135860f16521000, 0x4135c70e45ee15e2, 0x41359254ae082000, 0x4135d378ec92401f, + 0x41359e9a45be3000, 0x4135dfe393366a5d, 0x4135aadfdd744000, 0x4135ec4e39da949a, 0x4135b725752a5000, 0x4135f8b8e07ebed8, 0x4135c36b0ce06000, 0x413605238722e915, + 0x4135cfb0a4967000, 0x4136118e2dc71353, 0x4135dbf63c4c8000, 0x41361df8d46b3d90, 0x4135e83bd4029000, 0x41362a637b0f67ce, 0x4135f4816bb8a000, 0x413636ce21b3920b, + 0x413600c7036eb000, 0x41364338c857bc49, 0x41360d0c9b24c000, 0x41364fa36efbe687, 0x4136195232dad000, 0x41365c0e15a010c4, 0x41362597ca90e000, 0x41366878bc443b02, + 0x413631dd6246f000, 0x413674e362e8653f, 0x41363e22f9fd0000, 0x4136814e098c8f7d, 0x41364a6891b31000, 0x41368db8b030b9ba, 0x413656ae29692000, 0x41369a2356d4e3f8, + 0x413662f3c11f3000, 0x4136a68dfd790e35, 0x41366f3958d54000, 0x4136b2f8a41d3873, 0x41367b7ef08b5000, 0x4136bf634ac162b0, 0x413687c488416000, 0x4136cbcdf1658cee, + 0x4136940a1ff77000, 0x4136d8389809b72b, 0x4136a04fb7ad8000, 0x4136e4a33eade169, 0x4136ac954f639000, 0x4136f10de5520ba6, 0x4136b8dae719a000, 0x4136fd788bf635e4, + 0x4136c5207ecfb000, 0x413709e3329a6021, 0x4136d1661685c000, 0x4137164dd93e8a5f, 0x4136ddabae3bd000, 0x413722b87fe2b49c, 0x4136e9f145f1e000, 0x41372f232686deda, + 0x4136f636dda7f000, 0x41373b8dcd2b0917, 0x4137027c755e0000, 0x413747f873cf3355, 0x41370ec20d141000, 0x413754631a735d92, 0x41371b07a4ca2000, 0x413760cdc11787d0, + 0x4137274d3c803000, 0x41376d3867bbb20d, 0x41373392d4364000, 0x413779a30e5fdc4b, 0x41373fd86bec5000, 0x4137860db5040688, 0x41374c1e03a26000, 0x413792785ba830c6, + 0x413758639b587000, 0x41379ee3024c5b03, 0x413764a9330e8000, 0x4137ab4da8f08541, 0x413770eecac49000, 0x4137b7b84f94af7e, 0x41377d34627aa000, 0x4137c422f638d9bc, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3fefff7465b10c9e, 0x3fefaed6366c1da9, 0x3fefff73a0846daf, 0x3fe6b5f74fd453f7, 0x3fefff72daccf378, 0x3fc2e8a418d94c40, 0x3fefff72148a9dfb, 0xbfde43a7a6386fb6, + 0x3fefff714dbd6d3c, 0xbfecfcb6231ffa52, 0x3fefff708665613f, 0xbfef571de0b1b71c, 0x3fefff6fbe827a07, 0xbfe542037a2e9550, 0x3fefff6ef614b797, 0xbfb5ec81420db379, + 0x3fefff6e2d1c19f2, 0x3fe0dd4310ab1b46, 0x3fefff6d6398a11d, 0x3fedc70839ed820a, 0x3fefff6c998a4d1b, 0x3feee00b56292a50, 0x3fefff6bcef11dee, 0x3fe3b8cb88b01fdb, + 0x3fefff6b03cd139b, 0x3f97c72e9b8d1af3, 0x3fefff6a381e2e24, 0xbfe287d36177f5bb, 0x3fefff696be46d8e, 0xbfee73905916513c, 0x3fefff689f1fd1dc, 0xbfee4a15b528c019, + 0x3fefff67d1d05b11, 0xbfe21bd8d9dcaad4, 0x3fefff6703f60930, 0x3fa41db8a9e52238, 0x3fefff663590dc3e, 0x3fe41fda0b5a6a55, 0x3fefff6566a0d43d, 0x3fef01a1e763bbef, + 0x3fefff649725f132, 0x3fed95d3020725ba, 0x3fefff63c720331f, 0x3fe06cc8894ba818, 0x3fefff62f68f9a08, 0xbfba0574779fb320, 0x3fefff62257425f2, 0xbfe5a3bedf3ccb18, + 0x3fefff6153cdd6de, 0xbfef70aec557ee83, 0x3fefff60819cacd2, 0xbfecc3f7915301ef, 0x3fefff5faee0a7d0, 0xbfdd5a93a32c71c2, 0x3fefff5edb99c7db, 0x3fc4f1024a156e57, + 0x3fefff5e07c80cf9, 0x3fe711fdd23eb270, 0x3fefff5d336b772c, 0x3fefc047db14a6f1, 0x3fefff5c5e840677, 0x3febd5555312d162, 0x3fefff5b8911badf, 0x3fd9be38bb91a689, + 0x3fefff5ab3149467, 0xbfccca574614c849, 0x3fefff59dc8c9312, 0xbfe869288124e4f0, 0x3fefff590579b6e5, 0xbfeff01d87b559c1, 0x3fefff582ddbffe2, 0xbfeacadb0128bafd, + 0x3fefff5755b36e0e, 0xbfd6081d115a4767, 0x3fefff567d00016d, 0x3fd2436f89e1ff05, 0x3fefff55a3c1ba01, 0x3fe9a7e79f972104, 0x3fefff54c9f897cf, 0x3feffffff0d0484c, + 0x3fefff53efa49ada, 0x3fe9a593300a4264, 0x3fefff5314c5c327, 0x3fd23bf71e4fe143, 0x3fefff52395c10b7, 0xbfd60f6e3487db80, 0x3fefff515d678391, 0xbfeaccfc4ee357ce, + 0x3fefff5080e81bb6, 0xbfefefdf326d76da, 0x3fefff4fa3ddd92b, 0xbfe866a344964d1f, 0x3fefff4ec648bbf4, 0xbfccbb26cfff806a, 0x3fefff4de828c415, 0x3fd9c55b4406ee92, + 0x3fefff4d097df190, 0x3febd7415d8ad3d7, 0x3fefff4c2a48446a, 0x3fefbfcb6ee44bc2, 0x3fefff4b4a87bca7, 0x3fe70f4a4e176af4, 0x3fefff4a6a3c5a4b, 0x3fc4e1a167047cee, + 0x3fefff4989661d59, 0xbfdd61806de90132, 0x3fefff48a80505d5, 0xbfecc5ac6c4d6d86, 0x3fefff47c61913c3, 0xbfef6ff4beb59165, 0x3fefff46e3a24726, 0xbfe5a0dfc745237d, + 0x3fefff4600a0a004, 0xbfb9e6709c54d262, 0x3fefff451d141e5e, 0x3fe070209910d267, 0x3fefff4438fcc23a, 0x3fed974ef87df310, 0x3fefff43545a8b9b, 0x3fef00ab006851f7, + 0x3fefff426f2d7a86, 0x3fe41cd23ef2d3ae, 0x3fefff4189758efd, 0x3fa3df6ad6d1580c, 0x3fefff40a332c905, 0xbfe21f0f3ba49106, 0x3fefff3fbc6528a1, 0xbfee4b574b00000e, + 0x3fefff3ed50cadd7, 0xbfee725d88c13068, 0x3fefff3ded2958a9, 0xbfe284a5e8b94f31, 0x3fefff3d04bb291b, 0x3f9843d9d2c1fa26, 0x3fefff3c1bc21f32, 0x3fe3bbdd05c7e63f, + 0x3fefff3b323e3af1, 0x3feee11149ab55d0, 0x3fefff3a482f7c5d, 0x3fedc59ab32d3a86, 0x3fefff395d95e379, 0x3fe0d9f3195e567b, 0x3fefff3872717049, 0xbfb60b90c63de750, + 0x3fefff3786c222d1, 0xbfe544ed00cbb7f8, 0x3fefff369a87fb16, 0xbfef57e72bd175a5, 0x3fefff35adc2f91b, 0xbfecfb0f539f586c, 0x3fefff34c0731ce4, 0xbfde3cc95b186d85, + 0x3fefff33d2986676, 0x3fc2f80eacd8e160, 0x3fefff32e432d5d3, 0x3fe6b8b5f626b51b, 0x3fefff31f5426b02, 0x3fefaf620fca7b76, 0x3fefff3105c72604, 0x3fec138609553e7f, + 0x3fefff3015c106e0, 0x3fdaa76cbf3f3f8b, 0x3fefff2f25300d97, 0xbfcad75b09b10fe8, 0x3fefff2e34143a30, 0xbfe815c3f80ecf8c, 0x3fefff2d426d8cad, 0xbfefe72a721db1cd, + 0x3fefff2c503c0513, 0xbfeb0fe674891e86, 0x3fefff2b5d7fa366, 0xbfd6f76615c91dae, 0x3fefff2a6a3867a9, 0x3fd14de6b2d2b6e7, 0x3fefff29766651e2, 0x3fe95ab9d644e8f6, + 0x3fefff2882096215, 0x3fefff0884e215fd, 0x3fefff278d219845, 0x3fe9f1344e473e6f, 0x3fefff2697aef476, 0x3fd33065c2e49505, 0x3fefff25a1b176ad, 0xbfd51ed045a6c9f2, + 0x3fefff24ab291eee, 0xbfea86527ab9983a, 0x3fefff23b415ed3d, 0xbfeff6e467ad8bda, 0x3fefff22bc77e19f, 0xbfe8b88e651ca995, 0x3fefff21c44efc17, 0xbfceac664b7e5d30, + 0x3fefff20cb9b3ca9, 0x3fd8da98f2fad130, 0x3fefff1fd25ca35b, 0x3feb97622f54f429, 0x3fefff1ed8933030, 0x3fefcec63f6bbe5f, 0x3fefff1dde3ee32c, 0x3fe7672d7db35c32, + 0x3fefff1ce35fbc53, 0x3fc6d951a5514db5, 0x3fefff1be7f5bbab, 0xbfdc7d84942733c7, 0x3fefff1aec00e136, 0xbfec8cd7c985efbb, 0x3fefff19ef812cfa, 0xbfef86d62e39d3e6, + 0x3fefff18f2769efb, 0xbfe5fe631a1d7dbf, 0x3fefff17f4e1373d, 0xbfbddec2d9c66b93, 0x3fefff16f6c0f5c4, 0x3fe001f7f0fedff8, 0x3fefff15f815da94, 0x3fed65bdbb61591a, + 0x3fefff14f8dfe5b3, 0x3fef1f5c2b38f39f, 0x3fefff13f91f1723, 0x3fe47f98287c83ff, 0x3fefff12f8d36eea, 0x3fabda01668ac8a8, 0x3fefff11f7fced0d, 0xbfe1b52a0be55a9f, + 0x3fefff10f69b918e, 0xbfee213b09aebd25, 0x3fefff0ff4af5c73, 0xbfee98bfbaac59a7, 0x3fefff0ef2384dc0, 0xbfe2ec4b994e7ab3, 0x3fefff0def366579, 0x3f80957e92f03efc, + 0x3fefff0ceba9a3a3, 0x3fe356a53dfbd0ac, 0x3fefff0be7920842, 0x3feebe94248cf4ce, 0x3fefff0ae2ef935b, 0x3fedf3878638d474, 0x3fefff09ddc244f2, 0x3fe14610e1167a6a, + 0x3fefff08d80a1d0b, 0xbfb2104d74de3097, 0x3fefff07d1c71bab, 0xbfe4e4c7e2b495ef, 0x3fefff06caf940d6, 0xbfef3d2ba371eba3, 0x3fefff05c3a08c91, 0xbfed3058d670e9ba, + 0x3fefff04bbbcfee1, 0xbfdf1d1cc7eee79e, 0x3fefff03b34e97c9, 0x3fc0fdec8087f73b, 0x3fefff02aa55574e, 0x3fe65e03b05d4148, 0x3fefff01a0d13d74, 0x3fef9c82e2544a56, +] )) ), + +################ chunk 20480 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x41378979fa30b000, 0x4137d08d9cdd03f9, 0x413795bf91e6c000, 0x4137dcf843812e37, 0x4137a205299cd000, 0x4137e962ea255874, 0x4137ae4ac152e000, 0x4137f5cd90c982b2, + 0x4137ba905908f000, 0x41380238376dacef, 0x4137c6d5f0bf0000, 0x41380ea2de11d72d, 0x4137d31b88751000, 0x41381b0d84b6016a, 0x4137df61202b2000, 0x413827782b5a2ba8, + 0x4137eba6b7e13000, 0x413833e2d1fe55e5, 0x4137f7ec4f974000, 0x4138404d78a28023, 0x41380431e74d5000, 0x41384cb81f46aa60, 0x413810777f036000, 0x41385922c5ead49e, + 0x41381cbd16b97000, 0x4138658d6c8efedb, 0x41382902ae6f8000, 0x413871f813332919, 0x4138354846259000, 0x41387e62b9d75356, 0x4138418ddddba000, 0x41388acd607b7d94, + 0x41384dd37591b000, 0x41389738071fa7d1, 0x41385a190d47c000, 0x4138a3a2adc3d20f, 0x4138665ea4fdd000, 0x4138b00d5467fc4c, 0x413872a43cb3e000, 0x4138bc77fb0c268a, + 0x41387ee9d469f000, 0x4138c8e2a1b050c8, 0x41388b2f6c200000, 0x4138d54d48547b05, 0x4138977503d61000, 0x4138e1b7eef8a543, 0x4138a3ba9b8c2000, 0x4138ee22959ccf80, + 0x4138b00033423000, 0x4138fa8d3c40f9be, 0x4138bc45caf84000, 0x413906f7e2e523fb, 0x4138c88b62ae5000, 0x4139136289894e39, 0x4138d4d0fa646000, 0x41391fcd302d7876, + 0x4138e116921a7000, 0x41392c37d6d1a2b4, 0x4138ed5c29d08000, 0x413938a27d75ccf1, 0x4138f9a1c1869000, 0x4139450d2419f72f, 0x413905e7593ca000, 0x41395177cabe216c, + 0x4139122cf0f2b000, 0x41395de271624baa, 0x41391e7288a8c000, 0x41396a4d180675e7, 0x41392ab8205ed000, 0x413976b7beaaa025, 0x413936fdb814e000, 0x41398322654eca62, + 0x413943434fcaf000, 0x41398f8d0bf2f4a0, 0x41394f88e7810000, 0x41399bf7b2971edd, 0x41395bce7f371000, 0x4139a862593b491b, 0x4139681416ed2000, 0x4139b4ccffdf7358, + 0x41397459aea33000, 0x4139c137a6839d96, 0x4139809f46594000, 0x4139cda24d27c7d3, 0x41398ce4de0f5000, 0x4139da0cf3cbf211, 0x4139992a75c56000, 0x4139e6779a701c4e, + 0x4139a5700d7b7000, 0x4139f2e24114468c, 0x4139b1b5a5318000, 0x4139ff4ce7b870c9, 0x4139bdfb3ce79000, 0x413a0bb78e5c9b07, 0x4139ca40d49da000, 0x413a18223500c544, + 0x4139d6866c53b000, 0x413a248cdba4ef82, 0x4139e2cc0409c000, 0x413a30f7824919bf, 0x4139ef119bbfd000, 0x413a3d6228ed43fd, 0x4139fb573375e000, 0x413a49cccf916e3a, + 0x413a079ccb2bf000, 0x413a563776359878, 0x413a13e262e20000, 0x413a62a21cd9c2b5, 0x413a2027fa981000, 0x413a6f0cc37decf3, 0x413a2c6d924e2000, 0x413a7b776a221730, + 0x413a38b32a043000, 0x413a87e210c6416e, 0x413a44f8c1ba4000, 0x413a944cb76a6bab, 0x413a513e59705000, 0x413aa0b75e0e95e9, 0x413a5d83f1266000, 0x413aad2204b2c026, + 0x413a69c988dc7000, 0x413ab98cab56ea64, 0x413a760f20928000, 0x413ac5f751fb14a1, 0x413a8254b8489000, 0x413ad261f89f3edf, 0x413a8e9a4ffea000, 0x413adecc9f43691c, + 0x413a9adfe7b4b000, 0x413aeb3745e7935a, 0x413aa7257f6ac000, 0x413af7a1ec8bbd97, 0x413ab36b1720d000, 0x413b040c932fe7d5, 0x413abfb0aed6e000, 0x413b107739d41212, + 0x413acbf6468cf000, 0x413b1ce1e0783c50, 0x413ad83bde430000, 0x413b294c871c668d, 0x413ae48175f91000, 0x413b35b72dc090cb, 0x413af0c70daf2000, 0x413b4221d464bb09, + 0x413afd0ca5653000, 0x413b4e8c7b08e546, 0x413b09523d1b4000, 0x413b5af721ad0f84, 0x413b1597d4d15000, 0x413b6761c85139c1, 0x413b21dd6c876000, 0x413b73cc6ef563ff, + 0x413b2e23043d7000, 0x413b803715998e3c, 0x413b3a689bf38000, 0x413b8ca1bc3db87a, 0x413b46ae33a99000, 0x413b990c62e1e2b7, 0x413b52f3cb5fa000, 0x413ba57709860cf5, + 0x413b5f396315b000, 0x413bb1e1b02a3732, 0x413b6b7efacbc000, 0x413bbe4c56ce6170, 0x413b77c49281d000, 0x413bcab6fd728bad, 0x413b840a2a37e000, 0x413bd721a416b5eb, + 0x413b904fc1edf000, 0x413be38c4abae028, 0x413b9c9559a40000, 0x413beff6f15f0a66, 0x413ba8daf15a1000, 0x413bfc61980334a3, 0x413bb52089102000, 0x413c08cc3ea75ee1, + 0x413bc16620c63000, 0x413c1536e54b891e, 0x413bcdabb87c4000, 0x413c21a18befb35c, 0x413bd9f150325000, 0x413c2e0c3293dd99, 0x413be636e7e86000, 0x413c3a76d93807d7, + 0x413bf27c7f9e7000, 0x413c46e17fdc3214, 0x413bfec217548000, 0x413c534c26805c52, 0x413c0b07af0a9000, 0x413c5fb6cd24868f, 0x413c174d46c0a000, 0x413c6c2173c8b0cd, + 0x413c2392de76b000, 0x413c788c1a6cdb0a, 0x413c2fd8762cc000, 0x413c84f6c1110548, 0x413c3c1e0de2d000, 0x413c916167b52f85, 0x413c4863a598e000, 0x413c9dcc0e5959c3, + 0x413c54a93d4ef000, 0x413caa36b4fd8400, 0x413c60eed5050000, 0x413cb6a15ba1ae3e, 0x413c6d346cbb1000, 0x413cc30c0245d87b, 0x413c797a04712000, 0x413ccf76a8ea02b9, + 0x413c85bf9c273000, 0x413cdbe14f8e2cf6, 0x413c920533dd4000, 0x413ce84bf6325734, 0x413c9e4acb935000, 0x413cf4b69cd68171, 0x413caa9063496000, 0x413d0121437aabaf, + 0x413cb6d5faff7000, 0x413d0d8bea1ed5ec, 0x413cc31b92b58000, 0x413d19f690c3002a, 0x413ccf612a6b9000, 0x413d266137672a67, 0x413cdba6c221a000, 0x413d32cbde0b54a5, + 0x413ce7ec59d7b000, 0x413d3f3684af7ee2, 0x413cf431f18dc000, 0x413d4ba12b53a920, 0x413d00778943d000, 0x413d580bd1f7d35d, 0x413d0cbd20f9e000, 0x413d6476789bfd9b, + 0x413d1902b8aff000, 0x413d70e11f4027d8, 0x413d254850660000, 0x413d7d4bc5e45216, 0x413d318de81c1000, 0x413d89b66c887c53, 0x413d3dd37fd22000, 0x413d9621132ca691, + 0x413d4a1917883000, 0x413da28bb9d0d0ce, 0x413d565eaf3e4000, 0x413daef66074fb0c, 0x413d62a446f45000, 0x413dbb610719254a, 0x413d6ee9deaa6000, 0x413dc7cbadbd4f87, + 0x413d7b2f76607000, 0x413dd436546179c5, 0x413d87750e168000, 0x413de0a0fb05a402, 0x413d93baa5cc9000, 0x413ded0ba1a9ce40, 0x413da0003d82a000, 0x413df976484df87d, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3fefff0096c24a41, 0x3fec4ff6ed29a901, 0x3feffeff8c287db9, 0x3fdb8ef79ff18743, 0x3feffefe8103d7e0, 0xbfc8e2b2add0727d, 0x3feffefd755458ba, 0xbfe7c0df45c948c6, + 0x3feffefc691a004d, 0xbfefdc3a809b0d47, 0x3feffefb5c54ce9d, 0xbfeb53424286d44b, 0x3feffefa4f04c3ae, 0xbfd7e540c8a3bab3, 0x3feffef94129df84, 0x3fd05749d9f594b7, + 0x3feffef832c42226, 0x3fe90bf7a494516f, 0x3feffef723d38b96, 0x3feffc12c05804de, 0x3feffef614581bda, 0x3fea3b37a3fcd249, 0x3feffef50451d2f7, 0x3fd423a255c1d478, + 0x3feffef3f3c0b0f0, 0xbfd42ce177057618, 0x3feffef2e2a4b5cb, 0xbfea3e019392c849, 0x3feffef1d0fde18c, 0xbfeffbebc62bcab7, 0x3feffef0becc3437, 0xbfe908ef37e833e4, + 0x3feffeefac0fadd3, 0xbfd04dde441232c0, 0x3feffeee98c84e62, 0x3fd7ee4a353d02a2, 0x3feffeed84f615ea, 0x3feb55caead0a7f3, 0x3feffeec7099046f, 0x3fefdbc5b9146787, + 0x3feffeeb5bb119f7, 0x3fe7bd9b64d5aaac, 0x3feffeea463e5685, 0x3fc8cf9571d16eec, 0x3feffee93040ba1f, 0xbfdb97c24d560c10, 0x3feffee819b844c9, 0xbfec523bc53f2328, + 0x3feffee702a4f688, 0xbfef9bc0c24b3b7e, 0x3feffee5eb06cf60, 0xbfe65a879f2aabc9, 0x3feffee4d2ddcf57, 0xbfc0ea9c53eded48, 0x3feffee3ba29f672, 0x3fdf259feb06af50, + 0x3feffee2a0eb44b4, 0x3fed32579933955f, 0x3feffee18721ba22, 0x3fef3c1ced0fae2e, 0x3feffee06ccd56c3, 0x3fe4e1171dd9dd3b, 0x3feffedf51ee1a99, 0x3fb1e96ddca18a9c, + 0x3feffede368405ab, 0xbfe14a2a6b473c4e, 0x3feffedd1a8f17fc, 0xbfedf53e34cdbedb, 0x3feffedbfe0f5192, 0xbfeebd39e6b07870, 0x3feffedae104b272, 0xbfe352c3766a8d1f, + 0x3feffed9c36f3aa0, 0xbf7ebb7e083cb036, 0x3feffed8a54eea21, 0x3fe2f03902683612, 0x3feffed786a3c0fa, 0x3fee9a2c9e233704, 0x3feffed6676dbf30, 0x3fee1f969ea643eb, + 0x3feffed547ace4c7, 0x3fe1b11b23f9fb9f, 0x3feffed4276131c5, 0xbfac27d409e5e286, 0x3feffed3068aa62f, 0xbfe48355827f82f2, 0x3feffed1e5294209, 0xbfef207dd69d0576, + 0x3feffed0c33d0559, 0xbfed63d0c7d6e5f8, 0x3feffecfa0c5f022, 0xbfdffb7fefa5078e, 0x3feffece7dc4026b, 0x3fbe05769c216790, 0x3feffecd5a373c38, 0x3fe601eca7826718, + 0x3feffecc361f9d8e, 0x3fef87ab7fb451b4, 0x3feffecb117d2672, 0x3fec8aa43a84654c, 0x3feffec9ec4fd6e9, 0x3fdc74caf08268d9, 0x3feffec8c697aef7, 0xbfc6ec7d6409bcc4, + 0x3feffec7a054aea3, 0xbfe76a7fb4652449, 0x3feffec67986d5f0, 0xbfefcf4e61a1138b, 0x3feffec5522e24e4, 0xbfeb94ea38bfbfb3, 0x3feffec42a4a9b85, 0xbfd8d19e58175f65, + 0x3feffec301dc39d6, 0x3fcebf50b9a01c8c, 0x3feffec1d8e2ffdc, 0x3fe8bba5f2bc5b50, 0x3feffec0af5eed9e, 0x3feff71ed268a0b3, 0x3feffebf85500320, 0x3fea839894a53c60, + 0x3feffebe5ab64067, 0x3fd5159daf3b7f11, 0x3feffebd2f91a578, 0xbfd339b0db845bf9, 0x3feffebc03e23258, 0xbfe9f40e1ae36343, 0x3feffebad7a7e70d, 0xbfeffef4fdb2685d, + 0x3feffeb9aae2c39a, 0xbfe957c0baec7fa3, 0x3feffeb87d92c807, 0xbfd14485545e1748, 0x3feffeb74fb7f456, 0x3fd7007dc3f4a848, 0x3feffeb62152488f, 0x3feb127fa60d252e, + 0x3feffeb4f261c4b5, 0x3fefe6c90c8c630e, 0x3feffeb3c2e668ce, 0x3fe8128ea0d8b492, 0x3feffeb292e034df, 0x3fcac44d814b875d, 0x3feffeb1624f28ed, 0xbfdab047ea28be14, + 0x3feffeb0313344fe, 0xbfec15dc064e1446, 0x3feffeaeff8c8917, 0xbfefaeb32d4b3139, 0x3feffeadcd5af53c, 0xbfe6b54798bb198e, 0x3feffeac9a9e8973, 0xbfc2e4c968dedb3d, + 0x3feffeab675745c1, 0x3fde455f2729991e, 0x3feffeaa33852a2b, 0x3fecfd1fc5c78028, 0x3feffea8ff2836b7, 0x3fef56eb7b4ef75e, 0x3feffea7ca406b6a, 0x3fe541490bf68634, + 0x3feffea694cdc849, 0x3fb5e4bd537c1209, 0x3feffea55ed04d59, 0xbfe0de1704701cea, 0x3feffea42847faa0, 0xbfedc76389f98598, 0x3feffea2f134d022, 0xbfeedfc9c6fbd9f3, + 0x3feffea1b996cde5, 0xbfe3b8071daa15c6, 0x3feffea0816df3ef, 0xbf97a803c1923b5a, 0x3feffe9f48ba4245, 0x3fe2889eb4b702dd, 0x3feffe9e0f7bb8eb, 0x3fee73dcfb166358, + 0x3feffe9cd5b257e8, 0x3fee49c53db5b892, 0x3feffe9b9b5e1f40, 0x3fe21b0b36b9567d, 0x3feffe9a607f0ef9, 0xbfa42d4c13c43627, 0x3feffe9925152718, 0xbfe4209bf2782612, + 0x3feffe97e92067a3, 0xbfef01df8ec1eef6, 0x3feffe96aca0d09f, 0xbfed9573f2e26466, 0x3feffe956f966211, 0xbfe06bf27b8dc7ef, 0x3feffe9432011bfe, 0x3fba0d355e87fbf0, + 0x3feffe92f3e0fe6d, 0x3fe5a4769870a35e, 0x3feffe91b5360962, 0x3fef70dd3457061f, 0x3feffe9076003ce3, 0x3fecc38a497cb209, 0x3feffe8f363f98f6, 0x3fdd58d85f2eed81, + 0x3feffe8df5f41d9f, 0xbfc4f4da76aed55e, 0x3feffe8cb51dcae4, 0xbfe712aaa58e4967, 0x3feffe8b73bca0cb, 0xbfefc066e34cf49a, 0x3feffe8a31d09f58, 0xbfebd4da3ff98bda, + 0x3feffe88ef59c692, 0xbfd9bc700a1087f3, 0x3feffe87ac58167e, 0x3fccce235249c5f3, 0x3feffe8668cb8f22, 0x3fe869c9c1d824aa, 0x3feffe8524b43082, 0x3feff02d0a13a376, + 0x3feffe83e011faa5, 0x3feaca529dcc35c7, 0x3feffe829ae4ed8f, 0x3fd60648bba90b28, 0x3feffe81552d0947, 0xbfd2454d9a10beef, 0x3feffe800eea4dd2, 0xbfe9a87cac342495, + 0x3feffe7ec81cbb35, 0xbfefffffddd4a137, 0x3feffe7d80c45176, 0xbfe9a4fe04fe3a00, 0x3feffe7c38e1109b, 0xbfd23a18f87a71b3, 0x3feffe7af072f8a9, 0x3fd6114270111dd3, + 0x3feffe79a77a09a5, 0x3feacd849274fd05, 0x3feffe785df64396, 0x3fefefcf8a2ae15f, 0x3feffe7713e7a680, 0x3fe86601e6ee4df6, 0x3feffe75c94e326a, 0x3fccb75aa12e58df, + 0x3feffe747e29e759, 0xbfd9c723d6f8ecd1, 0x3feffe73327ac553, 0xbfebd7bc4facfb0e, 0x3feffe71e640cc5d, 0xbfefbfac410493a2, 0x3feffe70997bfc7c, 0xbfe70e9d5f54292e, + 0x3feffe6f4c2c55b8, 0xbfc4ddc92219fce0, 0x3feffe6dfe51d814, 0x3fdd633b8f47b428, 0x3feffe6cafec8397, 0x3fecc61991f3d479, 0x3feffe6b60fc5847, 0x3fef6fc62a63aec0, +] )) ), + +################ chunk 20992 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x413dac45d538b000, 0x413e05e0eef222bb, 0x413db88b6ceec000, 0x413e124b95964cf8, 0x413dc4d104a4d000, 0x413e1eb63c3a7736, 0x413dd1169c5ae000, 0x413e2b20e2dea173, + 0x413ddd5c3410f000, 0x413e378b8982cbb1, 0x413de9a1cbc70000, 0x413e43f63026f5ee, 0x413df5e7637d1000, 0x413e5060d6cb202c, 0x413e022cfb332000, 0x413e5ccb7d6f4a69, + 0x413e0e7292e93000, 0x413e6936241374a7, 0x413e1ab82a9f4000, 0x413e75a0cab79ee4, 0x413e26fdc2555000, 0x413e820b715bc922, 0x413e33435a0b6000, 0x413e8e7617fff35f, + 0x413e3f88f1c17000, 0x413e9ae0bea41d9d, 0x413e4bce89778000, 0x413ea74b654847da, 0x413e5814212d9000, 0x413eb3b60bec7218, 0x413e6459b8e3a000, 0x413ec020b2909c55, + 0x413e709f5099b000, 0x413ecc8b5934c693, 0x413e7ce4e84fc000, 0x413ed8f5ffd8f0d0, 0x413e892a8005d000, 0x413ee560a67d1b0e, 0x413e957017bbe000, 0x413ef1cb4d21454b, + 0x413ea1b5af71f000, 0x413efe35f3c56f89, 0x413eadfb47280000, 0x413f0aa09a6999c6, 0x413eba40dede1000, 0x413f170b410dc404, 0x413ec68676942000, 0x413f2375e7b1ee41, + 0x413ed2cc0e4a3000, 0x413f2fe08e56187f, 0x413edf11a6004000, 0x413f3c4b34fa42bc, 0x413eeb573db65000, 0x413f48b5db9e6cfa, 0x413ef79cd56c6000, 0x413f552082429737, + 0x413f03e26d227000, 0x413f618b28e6c175, 0x413f102804d88000, 0x413f6df5cf8aebb2, 0x413f1c6d9c8e9000, 0x413f7a60762f15f0, 0x413f28b33444a000, 0x413f86cb1cd3402d, + 0x413f34f8cbfab000, 0x413f9335c3776a6b, 0x413f413e63b0c000, 0x413f9fa06a1b94a8, 0x413f4d83fb66d000, 0x413fac0b10bfbee6, 0x413f59c9931ce000, 0x413fb875b763e923, + 0x413f660f2ad2f000, 0x413fc4e05e081361, 0x413f7254c2890000, 0x413fd14b04ac3d9e, 0x413f7e9a5a3f1000, 0x413fddb5ab5067dc, 0x413f8adff1f52000, 0x413fea2051f49219, + 0x413f972589ab3000, 0x413ff68af898bc57, 0x413fa36b21614000, 0x4140017acf9e734a, 0x413fafb0b9175000, 0x414007b022f08869, 0x413fbbf650cd6000, 0x41400de576429d88, + 0x413fc83be8837000, 0x4140141ac994b2a7, 0x413fd48180398000, 0x41401a501ce6c7c5, 0x413fe0c717ef9000, 0x414020857038dce4, 0x413fed0cafa5a000, 0x414026bac38af203, + 0x413ff952475bb000, 0x41402cf016dd0722, 0x414002cbef88e000, 0x414033256a2f1c40, 0x414008eebb63e800, 0x4140395abd81315f, 0x41400f11873ef000, 0x41403f9010d3467e, + 0x414015345319f800, 0x414045c564255b9d, 0x41401b571ef50000, 0x41404bfab77770bb, 0x41402179ead00800, 0x414052300ac985da, 0x4140279cb6ab1000, 0x414058655e1b9af9, + 0x41402dbf82861800, 0x41405e9ab16db018, 0x414033e24e612000, 0x414064d004bfc536, 0x41403a051a3c2800, 0x41406b055811da55, 0x41404027e6173000, 0x4140713aab63ef74, + 0x4140464ab1f23800, 0x4140776ffeb60493, 0x41404c6d7dcd4000, 0x41407da5520819b1, 0x4140529049a84800, 0x414083daa55a2ed0, 0x414058b315835000, 0x41408a0ff8ac43ef, + 0x41405ed5e15e5800, 0x414090454bfe590e, 0x414064f8ad396000, 0x4140967a9f506e2c, 0x41406b1b79146800, 0x41409caff2a2834b, 0x4140713e44ef7000, 0x4140a2e545f4986a, + 0x4140776110ca7800, 0x4140a91a9946ad89, 0x41407d83dca58000, 0x4140af4fec98c2a7, 0x414083a6a8808800, 0x4140b5853fead7c6, 0x414089c9745b9000, 0x4140bbba933cece5, + 0x41408fec40369800, 0x4140c1efe68f0204, 0x4140960f0c11a000, 0x4140c82539e11722, 0x41409c31d7eca800, 0x4140ce5a8d332c41, 0x4140a254a3c7b000, 0x4140d48fe0854160, + 0x4140a8776fa2b800, 0x4140dac533d7567f, 0x4140ae9a3b7dc000, 0x4140e0fa87296b9d, 0x4140b4bd0758c800, 0x4140e72fda7b80bc, 0x4140badfd333d000, 0x4140ed652dcd95db, + 0x4140c1029f0ed800, 0x4140f39a811faafa, 0x4140c7256ae9e000, 0x4140f9cfd471c018, 0x4140cd4836c4e800, 0x4141000527c3d537, 0x4140d36b029ff000, 0x4141063a7b15ea56, + 0x4140d98dce7af800, 0x41410c6fce67ff75, 0x4140dfb09a560000, 0x414112a521ba1493, 0x4140e5d366310800, 0x414118da750c29b2, 0x4140ebf6320c1000, 0x41411f0fc85e3ed1, + 0x4140f218fde71800, 0x414125451bb053f0, 0x4140f83bc9c22000, 0x41412b7a6f02690e, 0x4140fe5e959d2800, 0x414131afc2547e2d, 0x4141048161783000, 0x414137e515a6934c, + 0x41410aa42d533800, 0x41413e1a68f8a86b, 0x414110c6f92e4000, 0x4141444fbc4abd89, 0x414116e9c5094800, 0x41414a850f9cd2a8, 0x41411d0c90e45000, 0x414150ba62eee7c7, + 0x4141232f5cbf5800, 0x414156efb640fce6, 0x41412952289a6000, 0x41415d2509931205, 0x41412f74f4756800, 0x4141635a5ce52723, 0x41413597c0507000, 0x4141698fb0373c42, + 0x41413bba8c2b7800, 0x41416fc503895161, 0x414141dd58068000, 0x414175fa56db6680, 0x4141480023e18800, 0x41417c2faa2d7b9e, 0x41414e22efbc9000, 0x41418264fd7f90bd, + 0x41415445bb979800, 0x4141889a50d1a5dc, 0x41415a688772a000, 0x41418ecfa423bafb, 0x4141608b534da800, 0x41419504f775d019, 0x414166ae1f28b000, 0x41419b3a4ac7e538, + 0x41416cd0eb03b800, 0x4141a16f9e19fa57, 0x414172f3b6dec000, 0x4141a7a4f16c0f76, 0x4141791682b9c800, 0x4141adda44be2494, 0x41417f394e94d000, 0x4141b40f981039b3, + 0x4141855c1a6fd800, 0x4141ba44eb624ed2, 0x41418b7ee64ae000, 0x4141c07a3eb463f1, 0x414191a1b225e800, 0x4141c6af9206790f, 0x414197c47e00f000, 0x4141cce4e5588e2e, + 0x41419de749dbf800, 0x4141d31a38aaa34d, 0x4141a40a15b70000, 0x4141d94f8bfcb86c, 0x4141aa2ce1920800, 0x4141df84df4ecd8a, 0x4141b04fad6d1000, 0x4141e5ba32a0e2a9, + 0x4141b67279481800, 0x4141ebef85f2f7c8, 0x4141bc9545232000, 0x4141f224d9450ce7, 0x4141c2b810fe2800, 0x4141f85a2c972205, 0x4141c8dadcd93000, 0x4141fe8f7fe93724, + 0x4141cefda8b43800, 0x414204c4d33b4c43, 0x4141d520748f4000, 0x41420afa268d6162, 0x4141db43406a4800, 0x4142112f79df7680, 0x4141e1660c455000, 0x41421764cd318b9f, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3feffe6a11815629, 0x3fe5a027f47e03f9, 0x3feffe68c17b7d43, 0x3fb9deaf95a0db7d, 0x3feffe6770eacd9a, 0xbfe070f693348afb, 0x3feffe661fcf4735, 0xbfed97ade49424ff, + 0x3feffe64ce28ea18, 0xbfef006d34491c12, 0x3feffe637bf7b64a, 0xbfe41c103fdda85d, 0x3feffe62293babd1, 0xbfa3cfd757390396, 0x3feffe60d5f4cab2, 0x3fe21fdcc9643a35, + 0x3feffe5f822312f3, 0x3fee4ba79e783be4, 0x3feffe5e2dc68499, 0x3fee7210c2970a54, 0x3feffe5cd8df1fab, 0x3fe283da7f99fc07, 0x3feffe5b836ce42e, 0xbf986304943c8d9b, + 0x3feffe5a2d6fd229, 0xbfe3bca1594cd82f, 0x3feffe58d6e7e9a0, 0xbfeee152b43ecaaf, 0x3feffe577fd52a99, 0xbfedc53f3fd98975, 0x3feffe562837951b, 0xbfe0d91f117defb3, + 0x3feffe54d00f292c, 0x3fb6135499bb2b4e, 0x3feffe53775be6d0, 0x3fe545a755e15b1d, 0x3feffe521e1dce0f, 0x3fef58196bfe5c54, 0x3feffe50c454deed, 0x3fecfaa58e870811, + 0x3feffe4f6a011971, 0x3fde3b11b67ba21e, 0x3feffe4e0f227da0, 0xbfc2fbe946d9a69a, 0x3feffe4cb3b90b81, 0xbfe6b9659235dcef, 0x3feffe4b57c4c319, 0xbfefaf84f358918c, + 0x3feffe49fb45a46f, 0xbfec130e5c62eb07, 0x3feffe489e3baf87, 0xbfdaa5a73d25d147, 0x3feffe4740a6e468, 0x3fcadb2a77fc089d, 0x3feffe45e2874319, 0x3fe816682b9716d7, + 0x3feffe4483dccb9e, 0x3fefe73dd61d094f, 0x3feffe4324a77dfe, 0x3feb0f615756e005, 0x3feffe41c4e75a3f, 0x3fd6f5947c560051, 0x3feffe40649c6067, 0xbfd14fc6ecb2fbfc, + 0x3feffe3f03c6907b, 0xbfe95b51fcd88a0a, 0x3feffe3da265ea82, 0xbfefff0c55f1bd8f, 0x3feffe3c407a6e82, 0xbfe9f0a246217dd4, 0x3feffe3ade041c80, 0xbfd32e89e367e317, + 0x3feffe397b02f484, 0x3fd520a7215da32e, 0x3feffe381776f691, 0x3fea86ddfc49f75b, 0x3feffe36b36022b0, 0x3feff6d8a1fb1949, 0x3feffe354ebe78e5, 0x3fe8b7f003f48b7e, + 0x3feffe33e991f937, 0x3fcea89db9825bb3, 0x3feffe3283daa3ad, 0xbfd8dc6499f6b462, 0x3feffe311d98784b, 0xbfeb97e0803f3b46, 0x3feffe2fb6cb7718, 0xbfefceaaeebe8b09, + 0x3feffe2e4f73a01a, 0xbfe766836222363d, 0x3feffe2ce790f357, 0xbfc6d57c084c164f, 0x3feffe2b7f2370d6, 0x3fdc7f433a576be5, 0x3feffe2a162b189b, 0x3fec8d486b5e4ceb, + 0x3feffe28aca7eaaf, 0x3fef86ab6de53e52, 0x3feffe274299e716, 0x3fe5fdadee241397, 0x3feffe25d8010dd7, 0x3fbdd705369daf25, 0x3feffe246cdd5ef8, 0xbfe002cfe42c5547, + 0x3feffe23012eda7f, 0xbfed66203d8b0f0a, 0x3feffe2194f58072, 0xbfef1f2225fa1413, 0x3feffe20283150d8, 0xbfe47ed8a16e7f7b, 0x3feffe1ebae24bb6, 0xbfabca70ccc8f3fa, + 0x3feffe1d4d087113, 0x3fe1b5f9c73c599b, 0x3feffe1bdea3c0f5, 0x3fee218f09a8b1e0, 0x3feffe1a6fb43b62, 0x3fee9876aa93a4da, 0x3feffe190039e061, 0x3fe2eb8276df995d, + 0x3feffe179034aff7, 0xbf80d3d80720d39f, 0x3feffe161fa4aa2b, 0xbfe3576bf1c605c3, 0x3feffe14ae89cf04, 0xbfeebed94e42444e, 0x3feffe133ce41e86, 0xbfedf32fb468daf9, + 0x3feffe11cab398ba, 0xbfe1453eec646c50, 0x3feffe1057f83da4, 0x3fb21813ba15930f, 0x3feffe0ee4b20d4c, 0x3fe4e584c80ffa2c, 0x3feffe0d70e107b7, 0x3fef3d61b1ab1f3c, + 0x3feffe0bfc852cec, 0x3fed2ff29abac45f, 0x3feffe0a879e7cf1, 0x3fdf1b68dddf4b4d, 0x3feffe09122cf7cc, 0xbfc101c94a779ce9, 0x3feffe079c309d85, 0xbfe65eb60a3af7e3, + 0x3feffe0625a96e20, 0xbfef9ca99f06b4e3, 0x3feffe04ae9769a5, 0xbfec4f82adc43649, 0x3feffe0336fa901a, 0xbfdb8d3569815513, 0x3feffe01bed2e185, 0x3fc8e685416b156f, + 0x3feffe0046205ded, 0x3fe7c18661d61c01, 0x3feffdfecce30557, 0x3fefdc51c5092598, 0x3feffdfd531ad7cb, 0x3feb52c073ca0e8b, 0x3feffdfbd8c7d54f, 0x3fd7e3720871236f, + 0x3feffdfa5de9fde8, 0xbfd0592c1f5dcaf6, 0x3feffdf8e281519f, 0xbfe90c92dbb7a466, 0x3feffdf7668dd078, 0xbfeffc1a75361ac6, 0x3feffdf5ea0f7a7b, 0xbfea3aa8c7d6960d, + 0x3feffdf46d064fae, 0xbfd421c8da80e54f, 0x3feffdf2ef725017, 0x3fd42ebad5d059d6, 0x3feffdf171537bbd, 0x3fea3e904a70bae3, 0x3feffdeff2a9d2a7, 0x3feffbe3e3c5401f, + 0x3feffdee737554da, 0x3fe90853dd321555, 0x3feffdecf3b6025d, 0x3fd04bfbe72ef4d8, 0x3feffdeb736bdb38, 0xbfd7f018d39f3f32, 0x3feffde9f296df6f, 0xbfeb564c9293a7a8, + 0x3feffde871370f0b, 0xbfefdbae474d6790, 0x3feffde6ef4c6a11, 0xbfe7bcf426cec538, 0x3feffde56cd6f088, 0xbfc8cbc2ba58b778, 0x3feffde3e9d6a276, 0x3fdb99845c83a4b3, + 0x3feffde2664b7fe2, 0x3fec52afdc44f506, 0x3feffde0e23588d3, 0x3fef9b99d897dccb, 0x3feffddf5d94bd4f, 0x3fe659d5256046fd, 0x3feffdddd8691d5d, 0x3fc0e6bf71daed82, + 0x3feffddc52b2a903, 0xbfdf2753a88c300b, 0x3feffddacc716049, 0xbfed32bdab59c1f6, 0x3feffdd945a54334, 0xbfef3be6b2568378, 0x3feffdd7be4e51cb, 0xbfe4e05a1ac1e696, + 0x3feffdd6366c8c14, 0xbfb1e1a77ecd7626, 0x3feffdd4adfff218, 0x3fe14afc475e9362, 0x3feffdd3250883db, 0x3fedf595dc034dda, 0x3feffdd19b864166, 0x3feebcf4913692fa, + 0x3feffdd011792abe, 0x3fe351fca7344040, 0x3feffdce86e13fea, 0x3f7e3ecaf25e8e1a, 0x3feffdccfbbe80f0, 0xbfe2f10209fd26b7, 0x3feffdcb7010edd9, 0xbfee9a7582ab3794, + 0x3feffdc9e3d886a9, 0xbfee1f4273d2bf65, 0x3feffdc857154b69, 0xbfe1b04b4f6fe7f5, 0x3feffdc6c9c73c1e, 0x3fac37647dc86219, 0x3feffdc53bee58d0, 0x3fe48414ec5bbad1, + 0x3feffdc3ad8aa185, 0x3fef20b7af84538f, 0x3feffdc21e9c1643, 0x3fed636e1bd3fd0d, 0x3feffdc08f22b713, 0x3fdff9cfdb83eec6, 0x3feffdbeff1e83fa, 0xbfbe0d3414a7b23c, + 0x3feffdbd6e8f7cff, 0xbfe602a1b411f070, 0x3feffdbbdd75a229, 0xbfef87d61325acea, 0x3feffdba4bd0f37f, 0xbfec8a336ff95ae9, 0x3feffdb8b9a17108, 0xbfdc730c21c86def, + 0x3feffdb726e71aca, 0x3fc6f052dffb8c46, 0x3feffdb593a1f0cc, 0x3fe76b29aea22625, 0x3feffdb3ffd1f316, 0x3fefcf6985085201, 0x3feffdb26b7721ad, 0x3feb946bc08ee794, +] )) ), + +################ chunk 21504 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4141e788d8205800, 0x41421d9a2083a0be, 0x4141edaba3fb6000, 0x414223cf73d5b5dd, 0x4141f3ce6fd66800, 0x41422a04c727cafb, 0x4141f9f13bb17000, 0x4142303a1a79e01a, + 0x41420014078c7800, 0x4142366f6dcbf539, 0x41420636d3678000, 0x41423ca4c11e0a58, 0x41420c599f428800, 0x414242da14701f76, 0x4142127c6b1d9000, 0x4142490f67c23495, + 0x4142189f36f89800, 0x41424f44bb1449b4, 0x41421ec202d3a000, 0x4142557a0e665ed3, 0x414224e4ceaea800, 0x41425baf61b873f1, 0x41422b079a89b000, 0x414261e4b50a8910, + 0x4142312a6664b800, 0x4142681a085c9e2f, 0x4142374d323fc000, 0x41426e4f5baeb34e, 0x41423d6ffe1ac800, 0x41427484af00c86c, 0x41424392c9f5d000, 0x41427aba0252dd8b, + 0x414249b595d0d800, 0x414280ef55a4f2aa, 0x41424fd861abe000, 0x41428724a8f707c9, 0x414255fb2d86e800, 0x41428d59fc491ce8, 0x41425c1df961f000, 0x4142938f4f9b3206, + 0x41426240c53cf800, 0x414299c4a2ed4725, 0x4142686391180000, 0x41429ff9f63f5c44, 0x41426e865cf30800, 0x4142a62f49917163, 0x414274a928ce1000, 0x4142ac649ce38681, + 0x41427acbf4a91800, 0x4142b299f0359ba0, 0x414280eec0842000, 0x4142b8cf4387b0bf, 0x414287118c5f2800, 0x4142bf0496d9c5de, 0x41428d34583a3000, 0x4142c539ea2bdafc, + 0x4142935724153800, 0x4142cb6f3d7df01b, 0x41429979eff04000, 0x4142d1a490d0053a, 0x41429f9cbbcb4800, 0x4142d7d9e4221a59, 0x4142a5bf87a65000, 0x4142de0f37742f77, + 0x4142abe253815800, 0x4142e4448ac64496, 0x4142b2051f5c6000, 0x4142ea79de1859b5, 0x4142b827eb376800, 0x4142f0af316a6ed4, 0x4142be4ab7127000, 0x4142f6e484bc83f2, + 0x4142c46d82ed7800, 0x4142fd19d80e9911, 0x4142ca904ec88000, 0x4143034f2b60ae30, 0x4142d0b31aa38800, 0x414309847eb2c34f, 0x4142d6d5e67e9000, 0x41430fb9d204d86d, + 0x4142dcf8b2599800, 0x414315ef2556ed8c, 0x4142e31b7e34a000, 0x41431c2478a902ab, 0x4142e93e4a0fa800, 0x41432259cbfb17ca, 0x4142ef6115eab000, 0x4143288f1f4d2ce8, + 0x4142f583e1c5b800, 0x41432ec4729f4207, 0x4142fba6ada0c000, 0x414334f9c5f15726, 0x414301c9797bc800, 0x41433b2f19436c45, 0x414307ec4556d000, 0x414341646c958163, + 0x41430e0f1131d800, 0x41434799bfe79682, 0x41431431dd0ce000, 0x41434dcf1339aba1, 0x41431a54a8e7e800, 0x41435404668bc0c0, 0x4143207774c2f000, 0x41435a39b9ddd5de, + 0x4143269a409df800, 0x4143606f0d2feafd, 0x41432cbd0c790000, 0x414366a46082001c, 0x414332dfd8540800, 0x41436cd9b3d4153b, 0x41433902a42f1000, 0x4143730f07262a59, + 0x41433f25700a1800, 0x414379445a783f78, 0x414345483be52000, 0x41437f79adca5497, 0x41434b6b07c02800, 0x414385af011c69b6, 0x4143518dd39b3000, 0x41438be4546e7ed4, + 0x414357b09f763800, 0x41439219a7c093f3, 0x41435dd36b514000, 0x4143984efb12a912, 0x414363f6372c4800, 0x41439e844e64be31, 0x41436a1903075000, 0x4143a4b9a1b6d34f, + 0x4143703bcee25800, 0x4143aaeef508e86e, 0x4143765e9abd6000, 0x4143b124485afd8d, 0x41437c8166986800, 0x4143b7599bad12ac, 0x414382a432737000, 0x4143bd8eeeff27ca, + 0x414388c6fe4e7800, 0x4143c3c442513ce9, 0x41438ee9ca298000, 0x4143c9f995a35208, 0x4143950c96048800, 0x4143d02ee8f56727, 0x41439b2f61df9000, 0x4143d6643c477c46, + 0x4143a1522dba9800, 0x4143dc998f999164, 0x4143a774f995a000, 0x4143e2cee2eba683, 0x4143ad97c570a800, 0x4143e904363dbba2, 0x4143b3ba914bb000, 0x4143ef39898fd0c1, + 0x4143b9dd5d26b800, 0x4143f56edce1e5df, 0x4143c0002901c000, 0x4143fba43033fafe, 0x4143c622f4dcc800, 0x414401d98386101d, 0x4143cc45c0b7d000, 0x4144080ed6d8253c, + 0x4143d2688c92d800, 0x41440e442a2a3a5a, 0x4143d88b586de000, 0x414414797d7c4f79, 0x4143deae2448e800, 0x41441aaed0ce6498, 0x4143e4d0f023f000, 0x414420e4242079b7, + 0x4143eaf3bbfef800, 0x4144271977728ed5, 0x4143f11687da0000, 0x41442d4ecac4a3f4, 0x4143f73953b50800, 0x414433841e16b913, 0x4143fd5c1f901000, 0x414439b97168ce32, + 0x4144037eeb6b1800, 0x41443feec4bae350, 0x414409a1b7462000, 0x41444624180cf86f, 0x41440fc483212800, 0x41444c596b5f0d8e, 0x414415e74efc3000, 0x4144528ebeb122ad, + 0x41441c0a1ad73800, 0x414458c4120337cb, 0x4144222ce6b24000, 0x41445ef965554cea, 0x4144284fb28d4800, 0x4144652eb8a76209, 0x41442e727e685000, 0x41446b640bf97728, + 0x414434954a435800, 0x414471995f4b8c46, 0x41443ab8161e6000, 0x414477ceb29da165, 0x414440dae1f96800, 0x41447e0405efb684, 0x414446fdadd47000, 0x414484395941cba3, + 0x41444d2079af7800, 0x41448a6eac93e0c1, 0x41445343458a8000, 0x414490a3ffe5f5e0, 0x4144596611658800, 0x414496d953380aff, 0x41445f88dd409000, 0x41449d0ea68a201e, + 0x414465aba91b9800, 0x4144a343f9dc353c, 0x41446bce74f6a000, 0x4144a9794d2e4a5b, 0x414471f140d1a800, 0x4144afaea0805f7a, 0x414478140cacb000, 0x4144b5e3f3d27499, + 0x41447e36d887b800, 0x4144bc19472489b7, 0x41448459a462c000, 0x4144c24e9a769ed6, 0x41448a7c703dc800, 0x4144c883edc8b3f5, 0x4144909f3c18d000, 0x4144ceb9411ac914, + 0x414496c207f3d800, 0x4144d4ee946cde32, 0x41449ce4d3cee000, 0x4144db23e7bef351, 0x4144a3079fa9e800, 0x4144e1593b110870, 0x4144a92a6b84f000, 0x4144e78e8e631d8f, + 0x4144af4d375ff800, 0x4144edc3e1b532ad, 0x4144b570033b0000, 0x4144f3f9350747cc, 0x4144bb92cf160800, 0x4144fa2e88595ceb, 0x4144c1b59af11000, 0x41450063dbab720a, + 0x4144c7d866cc1800, 0x414506992efd8729, 0x4144cdfb32a72000, 0x41450cce824f9c47, 0x4144d41dfe822800, 0x41451303d5a1b166, 0x4144da40ca5d3000, 0x4145193928f3c685, + 0x4144e06396383800, 0x41451f6e7c45dba4, 0x4144e68662134000, 0x414525a3cf97f0c2, 0x4144eca92dee4800, 0x41452bd922ea05e1, 0x4144f2cbf9c95000, 0x4145320e763c1b00, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3feffdb0d6917c9a, 0x3fd8cfd28dfa45b9, 0x3feffdaf412103e2, 0xbfcec3191fe301de, 0x3feffdadab25b78c, 0xbfe8bc4430b023a8, 0x3feffdac149f97a0, 0xbfeff72a6a9a394e, + 0x3feffdaa7d8ea425, 0xbfea830ced65298f, 0x3feffda8e5f2dd20, 0xbfd513c6b5796374, 0x3feffda74dcc429a, 0x3fd33b8c9fa88717, 0x3feffda5b51ad498, 0x3fe9f49ffe2a96f1, + 0x3feffda41bde9323, 0x3feffef0ff1587a4, 0x3feffda282177e41, 0x3fe957287041fcdc, 0x3feffda0e7c595f8, 0x3fd142a501e187cd, 0x3feffd9f4ce8da51, 0xbfd7024f3cea620d, + 0x3feffd9db1814b51, 0xbfeb13049ca50baf, 0x3feffd9c158ee900, 0xbfefe6b57b218801, 0x3feffd9a7911b364, 0xbfe811ea4b0858ae, 0x3feffd98dc09aa85, 0xbfcac07dec5a099f, + 0x3feffd973e76ce6b, 0x3fdab20d46492e3f, 0x3feffd95a0591f1a, 0x3fec16538b45b280, 0x3feffd9401b09c9c, 0x3fefae901ca5b483, 0x3feffd92627d46f6, 0x3fe6b497dc3e735d, + 0x3feffd90c2bf1e31, 0x3fc2e0eeb3ea1bb6, 0x3feffd8f22762252, 0xbfde4716a0b38aec, 0x3feffd8d81a25361, 0xbfecfd89618e1654, 0x3feffd8be043b165, 0xbfef56b90e7c79b0, + 0x3feffd8a3e5a3c65, 0xbfe5408e989b6531, 0x3feffd889be5f468, 0xbfb5dcf960b7914b, 0x3feffd86f8e6d976, 0x3fe0deeaf4347e29, 0x3feffd85555ceb95, 0x3fedc7bed2f49902, + 0x3feffd83b1482acc, 0x3feedf883072a77f, 0x3feffd820ca89723, 0x3fe3b742ae0f6a20, 0x3feffd80677e30a1, 0x3f9788d8e1fa584e, 0x3feffd7ec1c8f74c, 0xbfe2896a039038b4, + 0x3feffd7d1b88eb2d, 0xbfee742995e66dc9, 0x3feffd7b74be0c4a, 0xbfee4974bf1d252b, 0x3feffd79cd685aaa, 0xbfe21a3d8f4a2c3f, 0x3feffd782587d654, 0x3fa43cdf78d9a075, + 0x3feffd767d1c7f51, 0x3fe4215dd4e81c2a, 0x3feffd74d42655a6, 0x3fef021d2ebcaa9c, 0x3feffd732aa5595b, 0x3fed9514dcb88e1f, 0x3feffd7180998a78, 0x3fe06b1c69ea5c08, + 0x3feffd6fd602e903, 0xbfba14f640406b8a, 0x3feffd6e2ae17504, 0xbfe5a52e4c6a3ab4, 0x3feffd6c7f352e81, 0xbfef710b9be039b6, 0x3feffd6ad2fe1584, 0xbfecc31cfad31aaf, + 0x3feffd69263c2a11, 0xbfdd571d1401d517, 0x3feffd6778ef6c32, 0x3fc4f8b29dd0f361, 0x3feffd65cb17dbec, 0x3fe7135773644d23, 0x3feffd641cb57948, 0x3fefc085e3fc7cbf, + 0x3feffd626dc8444c, 0x3febd45f2635d808, 0x3feffd60be503d01, 0x3fd9baa752aea7c8, 0x3feffd5f0e4d636c, 0xbfccd1ef57a8fa25, 0x3feffd5d5dbfb797, 0xbfe86a6afcc06499, + 0x3feffd5baca73987, 0xbfeff03c84dfcf7d, 0x3feffd59fb03e944, 0xbfeac9ca3425cbee, 0x3feffd5848d5c6d6, 0xbfd6047460bdeab4, 0x3feffd56961cd244, 0x3fd2472ba5e9a0c4, + 0x3feffd54e2d90b95, 0x3fe9a911b2cda8d5, 0x3feffd532f0a72d1, 0x3fefffffc341213d, 0x3feffd517ab107ff, 0x3fe9a468d3dc6813, 0x3feffd4fc5cccb27, 0x3fd2383ace51ccbf, + 0x3feffd4e105dbc50, 0xbfd61316a699f3ce, 0x3feffd4c5a63db80, 0xbfeace0ccf98fffc, 0x3feffd4aa3df28c1, 0xbfefefbfda544870, 0x3feffd48eccfa419, 0xbfe86560837c34ab, + 0x3feffd4735354d8f, 0xbfccb38e6b8cce22, 0x3feffd457d10252b, 0x3fd9c8ec63927233, 0x3feffd43c4602af5, 0x3febd8373b2409ee, 0x3feffd420b255ef4, 0x3fefbf8d0b944116, + 0x3feffd40515fc130, 0x3fe70df06b1848e7, 0x3feffd3e970f51af, 0x3fc4d9f0d7bda940, 0x3feffd3cdc34107a, 0xbfdd64f6a9746153, 0x3feffd3b20cdfd98, 0xbfecc686b0c65a3a, + 0x3feffd3964dd1910, 0xbfef6f978e9c2862, 0x3feffd37a86162eb, 0xbfe59f701c7da535, 0x3feffd35eb5adb2f, 0xbfb9d6ee89c81a2a, 0x3feffd342dc981e4, 0x3fe071cc8971881f, + 0x3feffd326fad5711, 0x3fed980cc9a4b8f1, 0x3feffd30b1065abf, 0x3fef002f60c6c103, 0x3feffd2ef1d48cf5, 0x3fe41b4e3c1bcf37, 0x3feffd2d3217edba, 0x3fa3c043d2ed33c2, + 0x3feffd2b71d07d16, 0xbfe220aa52d6e7aa, 0x3feffd29b0fe3b10, 0xbfee4bf7eaca73da, 0x3feffd27efa127b1, 0xbfee71c3f53d4f58, 0x3feffd262db942ff, 0xbfe2830f1215f43e, + 0x3feffd246b468d03, 0x3f98822f4fedbc87, 0x3feffd22a84905c4, 0x3fe3bd65a83c0d5d, 0x3feffd20e4c0ad49, 0x3feee194177605df, 0x3feffd1f20ad839b, 0x3fedc4e3c5756c2b, + 0x3feffd1d5c0f88c1, 0x3fe0d84b059e1550, 0x3feffd1b96e6bcc3, 0xbfb61b1868fa7dc9, 0x3feffd19d1331fa8, 0xbfe54661a5d2e6e3, 0x3feffd180af4b178, 0xbfef584ba4bb3f55, + 0x3feffd16442b723a, 0xbfecfa3bc28e5cc7, 0x3feffd147cd761f8, 0xbfde395a0a7a0b6b, 0x3feffd12b4f880b7, 0x3fc2ffc3dbdaa410, 0x3feffd10ec8ece80, 0x3fe6ba1528e0a043, + 0x3feffd0f239a4b5b, 0x3fefafa7cf61e3a9, 0x3feffd0d5a1af74f, 0x3fec1296a8b7d651, 0x3feffd0b9010d265, 0x3fdaa3e1b4f3e200, 0x3feffd09c57bdca3, 0xbfcadef9dfe79e26, + 0x3feffd07fa5c1612, 0xbfe8170c59682763, 0x3feffd062eb17eb9, 0xbfefe751328ce15a, 0x3feffd04627c16a1, 0xbfeb0edc33c9ee66, 0x3feffd0295bbddd1, 0xbfd6f3c2dd70369a, + 0x3feffd00c870d450, 0x3fd151a72277a5a4, 0x3feffcfefa9afa28, 0x3fe95bea1d7b6136, 0x3feffcfd2c3a4f5e, 0x3fefff101f694639, 0x3feffcfb5d4ed3fd, 0x3fe9f01037d400ce, + 0x3feffcf98dd8880a, 0x3fd32cadff5dfb06, 0x3feffcf7bdd76b8e, 0xbfd5227df84d7e1f, 0x3feffcf5ed4b7e92, 0xbfea8769777d0d75, 0x3feffcf41c34c11c, 0xbfeff6ccd4b2f7e2, + 0x3feffcf24a933335, 0xbfe8b7519ceee25d, 0x3feffcf07866d4e4, 0xbfcea4d51fc3b33f, 0x3feffceea5afa632, 0x3fd8de303ad16d71, 0x3feffcecd26da726, 0x3feb985eca8d2279, + 0x3feffceafea0d7c8, 0x3fefce8f967e2c3e, 0x3feffce92a493821, 0x3fe765d940d7eee3, 0x3feffce75566c838, 0x3fc6d1a66659c1eb, 0x3feffce57ff98815, 0xbfdc8101d98b42cc, + 0x3feffce3aa0177c0, 0xbfec8db90670444a, 0x3feffce1d37e9741, 0xbfef8680a60a9cd3, 0x3feffcdffc70e6a1, 0xbfe5fcf8bd0a0e58, 0x3feffcde24d865e6, 0xbfbdcf478d5e8f33, + 0x3feffcdc4cb51519, 0x3fe003a7d38d3253, 0x3feffcda7406f442, 0x3fed6682b8d42f78, 0x3feffcd89ace0369, 0x3fef1ee81960268a, 0x3feffcd6c10a4297, 0x3fe47e19159c0b6e, +] )) ), + +################ chunk 22016 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x4144f8eec5a45800, 0x41453843c98e301f, 0x4144ff11917f6000, 0x41453e791ce0453d, 0x414505345d5a6800, 0x414544ae70325a5c, 0x41450b5729357000, 0x41454ae3c3846f7b, + 0x41451179f5107800, 0x4145511916d6849a, 0x4145179cc0eb8000, 0x4145574e6a2899b8, 0x41451dbf8cc68800, 0x41455d83bd7aaed7, 0x414523e258a19000, 0x414563b910ccc3f6, + 0x41452a05247c9800, 0x414569ee641ed915, 0x41453027f057a000, 0x41457023b770ee33, 0x4145364abc32a800, 0x414576590ac30352, 0x41453c6d880db000, 0x41457c8e5e151871, + 0x4145429053e8b800, 0x414582c3b1672d90, 0x414548b31fc3c000, 0x414588f904b942ae, 0x41454ed5eb9ec800, 0x41458f2e580b57cd, 0x414554f8b779d000, 0x41459563ab5d6cec, + 0x41455b1b8354d800, 0x41459b98feaf820b, 0x4145613e4f2fe000, 0x4145a1ce52019729, 0x414567611b0ae800, 0x4145a803a553ac48, 0x41456d83e6e5f000, 0x4145ae38f8a5c167, + 0x414573a6b2c0f800, 0x4145b46e4bf7d686, 0x414579c97e9c0000, 0x4145baa39f49eba4, 0x41457fec4a770800, 0x4145c0d8f29c00c3, 0x4145860f16521000, 0x4145c70e45ee15e2, + 0x41458c31e22d1800, 0x4145cd4399402b01, 0x41459254ae082000, 0x4145d378ec92401f, 0x4145987779e32800, 0x4145d9ae3fe4553e, 0x41459e9a45be3000, 0x4145dfe393366a5d, + 0x4145a4bd11993800, 0x4145e618e6887f7c, 0x4145aadfdd744000, 0x4145ec4e39da949a, 0x4145b102a94f4800, 0x4145f2838d2ca9b9, 0x4145b725752a5000, 0x4145f8b8e07ebed8, + 0x4145bd4841055800, 0x4145feee33d0d3f7, 0x4145c36b0ce06000, 0x414605238722e915, 0x4145c98dd8bb6800, 0x41460b58da74fe34, 0x4145cfb0a4967000, 0x4146118e2dc71353, + 0x4145d5d370717800, 0x414617c381192872, 0x4145dbf63c4c8000, 0x41461df8d46b3d90, 0x4145e21908278800, 0x4146242e27bd52af, 0x4145e83bd4029000, 0x41462a637b0f67ce, + 0x4145ee5e9fdd9800, 0x41463098ce617ced, 0x4145f4816bb8a000, 0x414636ce21b3920b, 0x4145faa43793a800, 0x41463d037505a72a, 0x414600c7036eb000, 0x41464338c857bc49, + 0x414606e9cf49b800, 0x4146496e1ba9d168, 0x41460d0c9b24c000, 0x41464fa36efbe687, 0x4146132f66ffc800, 0x414655d8c24dfba5, 0x4146195232dad000, 0x41465c0e15a010c4, + 0x41461f74feb5d800, 0x4146624368f225e3, 0x41462597ca90e000, 0x41466878bc443b02, 0x41462bba966be800, 0x41466eae0f965020, 0x414631dd6246f000, 0x414674e362e8653f, + 0x414638002e21f800, 0x41467b18b63a7a5e, 0x41463e22f9fd0000, 0x4146814e098c8f7d, 0x41464445c5d80800, 0x414687835cdea49b, 0x41464a6891b31000, 0x41468db8b030b9ba, + 0x4146508b5d8e1800, 0x414693ee0382ced9, 0x414656ae29692000, 0x41469a2356d4e3f8, 0x41465cd0f5442800, 0x4146a058aa26f916, 0x414662f3c11f3000, 0x4146a68dfd790e35, + 0x414669168cfa3800, 0x4146acc350cb2354, 0x41466f3958d54000, 0x4146b2f8a41d3873, 0x4146755c24b04800, 0x4146b92df76f4d91, 0x41467b7ef08b5000, 0x4146bf634ac162b0, + 0x414681a1bc665800, 0x4146c5989e1377cf, 0x414687c488416000, 0x4146cbcdf1658cee, 0x41468de7541c6800, 0x4146d20344b7a20c, 0x4146940a1ff77000, 0x4146d8389809b72b, + 0x41469a2cebd27800, 0x4146de6deb5bcc4a, 0x4146a04fb7ad8000, 0x4146e4a33eade169, 0x4146a67283888800, 0x4146ead891fff687, 0x4146ac954f639000, 0x4146f10de5520ba6, + 0x4146b2b81b3e9800, 0x4146f74338a420c5, 0x4146b8dae719a000, 0x4146fd788bf635e4, 0x4146befdb2f4a800, 0x414703addf484b02, 0x4146c5207ecfb000, 0x414709e3329a6021, + 0x4146cb434aaab800, 0x4147101885ec7540, 0x4146d1661685c000, 0x4147164dd93e8a5f, 0x4146d788e260c800, 0x41471c832c909f7d, 0x4146ddabae3bd000, 0x414722b87fe2b49c, + 0x4146e3ce7a16d800, 0x414728edd334c9bb, 0x4146e9f145f1e000, 0x41472f232686deda, 0x4146f01411cce800, 0x4147355879d8f3f8, 0x4146f636dda7f000, 0x41473b8dcd2b0917, + 0x4146fc59a982f800, 0x414741c3207d1e36, 0x4147027c755e0000, 0x414747f873cf3355, 0x4147089f41390800, 0x41474e2dc7214873, 0x41470ec20d141000, 0x414754631a735d92, + 0x414714e4d8ef1800, 0x41475a986dc572b1, 0x41471b07a4ca2000, 0x414760cdc11787d0, 0x4147212a70a52800, 0x4147670314699cee, 0x4147274d3c803000, 0x41476d3867bbb20d, + 0x41472d70085b3800, 0x4147736dbb0dc72c, 0x41473392d4364000, 0x414779a30e5fdc4b, 0x414739b5a0114800, 0x41477fd861b1f16a, 0x41473fd86bec5000, 0x4147860db5040688, + 0x414745fb37c75800, 0x41478c4308561ba7, 0x41474c1e03a26000, 0x414792785ba830c6, 0x41475240cf7d6800, 0x414798adaefa45e5, 0x414758639b587000, 0x41479ee3024c5b03, + 0x41475e8667337800, 0x4147a518559e7022, 0x414764a9330e8000, 0x4147ab4da8f08541, 0x41476acbfee98800, 0x4147b182fc429a60, 0x414770eecac49000, 0x4147b7b84f94af7e, + 0x41477711969f9800, 0x4147bdeda2e6c49d, 0x41477d34627aa000, 0x4147c422f638d9bc, 0x414783572e55a800, 0x4147ca58498aeedb, 0x41478979fa30b000, 0x4147d08d9cdd03f9, + 0x41478f9cc60bb800, 0x4147d6c2f02f1918, 0x414795bf91e6c000, 0x4147dcf843812e37, 0x41479be25dc1c800, 0x4147e32d96d34356, 0x4147a205299cd000, 0x4147e962ea255874, + 0x4147a827f577d800, 0x4147ef983d776d93, 0x4147ae4ac152e000, 0x4147f5cd90c982b2, 0x4147b46d8d2de800, 0x4147fc02e41b97d1, 0x4147ba905908f000, 0x41480238376dacef, + 0x4147c0b324e3f800, 0x4148086d8abfc20e, 0x4147c6d5f0bf0000, 0x41480ea2de11d72d, 0x4147ccf8bc9a0800, 0x414814d83163ec4c, 0x4147d31b88751000, 0x41481b0d84b6016a, + 0x4147d93e54501800, 0x41482142d8081689, 0x4147df61202b2000, 0x414827782b5a2ba8, 0x4147e583ec062800, 0x41482dad7eac40c7, 0x4147eba6b7e13000, 0x414833e2d1fe55e5, + 0x4147f1c983bc3800, 0x41483a1825506b04, 0x4147f7ec4f974000, 0x4148404d78a28023, 0x4137f7ec53a8d491, 0x4137f7ec53a8d492, 0x4137f7ec53a8d490, 0x40fe240c9fbe76c9, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3feffcd4e6bbb1d2, 0x3fabbae02c6ef544, 0x3feffcd30be25123, 0xbfe1b6c97e94cad3, 0x3feffcd1307e2093, 0xbfee21e302718b59, 0x3feffccf548f2029, 0xbfee982d9341c4bd, + 0x3feffccd78154fed, 0xbfe2eab94ff36ac3, 0x3feffccb9b10afe7, 0x3f811231875311d6, 0x3feffcc9bd814020, 0x3fe35832a0dfd38f, 0x3feffcc7df6700a0, 0x3feebf1e70a30d36, + 0x3feffcc600c1f16e, 0x3fedf2d7db7d8ea9, 0x3feffcc421921293, 0x3fe1446cf363618c, 0x3feffcc241d76416, 0xbfb21fd9fa02772f, 0x3feffcc06191e601, 0xbfe4e641a85dc29a, + 0x3feffcbe80c1985b, 0xbfef3d97b87aa622, 0x3feffcbc9f667b2c, 0xbfed2f8c57fd6178, 0x3feffcbabd808e7d, 0xbfdf19b4eca5ff7e, 0x3feffcb8db0fd255, 0x3fc105a60fdf4bcf, + 0x3feffcb6f81446bd, 0x3fe65f685ec9cebe, 0x3feffcb5148debbe, 0x3fef9cd05442c4b1, 0x3feffcb3307cc15e, 0x3fec4f0e67b5effc, 0x3feffcb14be0c7a7, 0x3fdb8b732cc143ac, + 0x3feffcaf66b9fea0, 0xbfc8ea57cf1d2125, 0x3feffcad81086652, 0xbfe7c22d786abdc3, 0x3feffcab9acbfec5, 0xbfefdc6901e4ddbe, 0x3feffca9b404c802, 0xbfeb523e9ea22c8f, + 0x3feffca7ccb2c210, 0xbfd7e1a342936e91, 0x3feffca5e4d5ecf8, 0x3fd05b0e6160aada, 0x3feffca3fc6e48c2, 0x3fe90d2e0cd56dfd, 0x3feffca2137bd577, 0x3feffc22227c44e3, + 0x3feffca029fe931e, 0x3fea3a19e5770cb0, 0x3feffc9e3ff681c0, 0x3fd41fef59ff8744, 0x3feffc9c5563a166, 0xbfd430942f94818a, 0x3feffc9a6a45f217, 0xbfea3f1efb022333, + 0x3feffc987e9d73db, 0xbfeffbdbf9c7d44e, 0x3feffc96926a26bd, 0xbfe907b87c637a14, 0x3feffc94a5ac0ac2, 0xbfd04a1986aba53f, 0x3feffc92b8631ff5, 0x3fd7f1e76c18021c, + 0x3feffc90ca8f665d, 0x3feb56ce33da0c68, 0x3feffc8edc30de03, 0x3fefdb96cdf123ed, 0x3feffc8ced4786ee, 0x3fe7bc4ce350ce18, 0x3feffc8afdd36129, 0x3fc8c7effd7b54d8, + 0x3feffc890dd46cba, 0xbfdb9b4664eaf023, 0x3feffc871d4aa9aa, 0xbfec5323ecb0101d, 0x3feffc852c361802, 0xbfef9b72e75a76d9, 0x3feffc833a96b7ca, 0xbfe65922a65f10a9, + 0x3feffc81486c890a, 0xbfc0e2e28c441ffc, 0x3feffc7f55b78bcc, 0x3fdf29075ead3fcf, 0x3feffc7d6277c017, 0x3fed3323b6ac747f, 0x3feffc7b6ead25f4, 0x3fef3bb0703afabc, + 0x3feffc797a57bd6b, 0x3fe4df9d12ce0abe, 0x3feffc7785778685, 0x3fb1d9e11cbb29ee, 0x3feffc75900c814a, 0xbfe14bce1f914bb3, 0x3feffc739a16adc4, 0xbfedf5ed7c11b8c7, + 0x3feffc71a3960bf9, 0xbfeebcaf347a5f01, 0x3feffc6fac8a9bf4, 0xbfe35135d3685517, 0x3feffc6db4f45dbc, 0xbf7dc217b5535fc3, 0x3feffc6bbcd35159, 0x3fe2f1cb0cf9b0cb, + 0x3feffc69c42776d6, 0x3fee9abe5fe6d98e, 0x3feffc67caf0ce39, 0x3fee1eee41d972cb, 0x3feffc65d12f578c, 0x3fe1af7b767dfc86, 0x3feffc63d6e312d7, 0xbfac46f4e8f9a3a3, + 0x3feffc61dc0c0023, 0xbfe484d45141230c, 0x3feffc5fe0aa1f78, 0xbfef20f18108c22d, 0x3feffc5de4bd70df, 0xbfed630b68be8932, 0x3feffc5be845f460, 0xbfdff81fc003e291, + 0x3feffc59eb43aa05, 0x3fbe14f1850e41dd, 0x3feffc57edb691d6, 0x3fe60356bb687372, 0x3feffc55ef9eabdb, 0x3fef88009f269aac, 0x3feffc53f0fbf81d, 0x3fec89c29eb71e3a, + 0x3feffc51f1ce76a5, 0x3fdc714d4c879a4a, 0x3feffc4ff216277b, 0xbfc6f428567beeb9, 0x3feffc4df1d30aa8, 0xbfe76bd3a37c3111, 0x3feffc4bf1052035, 0xbfefcf84a0dfc136, + 0x3feffc49efac682b, 0xbfeb93ed41e2f078, 0x3feffc47edc8e292, 0xbfd8ce06bdf9f79e, 0x3feffc45eb5a8f72, 0x3fcec6e17fd1bc05, 0x3feffc43e8616ed5, 0x3fe8bce268b10d86, + 0x3feffc41e4dd80c4, 0x3feff735fb34925b, 0x3feffc3fe0cec546, 0x3fea82813fda9c2e, 0x3feffc3ddc353c66, 0x3fd511efb63e1198, 0x3feffc3bd710e62b, 0xbfd33d685eff5b9a, + 0x3feffc39d161c29e, 0xbfe9f531db36638a, 0x3feffc37cb27d1c8, 0xbfeffeecf8e10c57, 0x3feffc35c46313b2, 0xbfe956901f6d11f6, 0x3feffc33bd138865, 0xbfd140c4ab8a1c13, + 0x3feffc31b5392fea, 0x3fd70420b02eb0f6, 0x3feffc2facd40a48, 0x3feb13898cd04e3f, 0x3feffc2da3e4178a, 0x3fefe6a1e21fca04, 0x3feffc2b9a6957b8, 0x3fe81145ef96edc0, + 0x3feffc299063cadb, 0x3fcabcae518ca890, 0x3feffc2785d370fb, 0xbfdab3d29bd9d147, 0x3feffc257ab84a21, 0xbfec16cb09b1cde5, 0x3feffc236f125657, 0xbfefae6d0472ad78, + 0x3feffc2162e195a6, 0xbfe6b3e81a75185c, 0x3feffc1f56260815, 0xbfc2dd13faf92a80, 0x3feffc1d48dfadae, 0x3fde48ce130e413a, 0x3feffc1b3b0e867b, 0x3fecfdf2f68ebac5, + 0x3feffc192cb29283, 0x3fef56869a40c3bb, 0x3feffc171dcbd1d0, 0x3fe53fd4204d36d2, 0x3feffc150e5a446b, 0x3fb5d53568c2f9bc, 0x3feffc12fe5dea5c, 0xbfe0dfbee02e6dbc, + 0x3feffc10edd6c3ad, 0xbfedc81a14d2f1a2, 0x3feffc0edcc4d066, 0xbfeedf46929e771f, 0x3feffc0ccb281091, 0xbfe3b67e39c71845, 0x3feffc0ab9008436, 0xbf9769adf4cd6026, + 0x3feffc08a64e2b5f, 0x3fe28a354de95202, 0x3feffc0693110615, 0x3fee74762972b610, 0x3feffc047f49145f, 0x3fee49243954c671, 0x3feffc026af65649, 0x3fe2196fe35a9565, + 0x3feffc005618cbda, 0xbfa44c72d7221607, 0x3feffbfe40b0751b, 0xbfe4221fb2785df7, 0x3feffbfc2abd5216, 0xbfef025ac75bc9cc, 0x3feffbfa143f62d3, 0xbfed94b5bf715053, + 0x3feffbf7fd36a75d, 0xbfe06a46547d0f3d, 0x3feffbf5e5a31fbb, 0x3fba1cb71ac9d42e, 0x3feffbf3cd84cbf7, 0x3fe5a5e5fb40f868, 0x3feffbf1b4dbac1a, 0x3fef7139fbff63cd, + 0x3feffbef9ba7c02d, 0x3fecc2afa5645d6f, 0x3feffbed81e90839, 0x3fdd5561c2175287, 0x3feffbeb679f8447, 0xbfc4fc8abff92554, 0x3feffbe94ccb3461, 0xbfe714043becea63, + 0x3feffbe7316c188f, 0xbfefc0a4dd1f3f28, 0x3feffbe5158230db, 0xbfebd3e405e769da, 0x3feffbe2f90d7d4d, 0xbfd9b8de9531da40, 0x3feffbe0dc0dfdf0, 0x3fccd5bb572ae9ac, + 0x3feffbdebe83b2cc, 0x3fe86b0c31c8cfd5, 0x3feffbdca06e9bea, 0x3feff04bf815e146, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3faa74d27c41b22a, +] )) ), + +################ chunk 22528 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0x412e240ca45a1cac, 0x41132cbd0f5c28f6, 0x41109750ba5e353f, 0x41219d7f53f7ced9, 0x412a6dd2ce560419, 0x412594458fdf3b64, 0x4132d687e3d70a3d, 0x4162d687e6b851ec, + 0x4147f7ec53333333, 0x4144bd24e8f5c28f, 0x415604df28f5c28f, 0x416084a3c0f5c28f, 0x415af956f3d70a3d, 0x41678c29dccccccd, 0x41978c29e0666666, 0x417df5e768000000, + 0x4179ec6e23333333, 0x418b8616f3333333, 0x4194a5ccb1333333, 0x4190dbd658666666, 0x419d6f3454000000, 0x41cd6f3458800000, 0x41b2b9b0a1000000, 0x41b033c4d6000000, + 0x41c133ce58000000, 0x41c9cf3fdd800000, 0x41c512cbee800000, 0x41d26580b4800000, 0x42026580b7500000, 0x41e7681cc9400000, 0x41e440b60b800000, 0x41f580c1ee000000, + 0x42002187ea700000, 0x41fa577eea200000, 0x4206fee0e1a00000, 0x4236fee0e5240000, 0x421d4223fb900000, 0x421950e38e600000, 0x422ae0f269800000, 0x423429e9e50c0000, + 0x423076af52540000, 0x423cbe991a080000, 0x426cbe991e6d0000, 0x425249567d3a0000, 0x424fa51c71f80000, 0x4260cc9781f00000, 0x426934645e4f0000, 0x4264945b26e90000, + 0x4271f71fb0450000, 0x42a1f71fb3042000, 0x4286dbac1c888000, 0x4283c731c73b0000, 0x4294ffbd626c0000, 0x429f817d75e2c000, 0x4299b971f0a34000, 0x42a674e79c564000, + 0x42d674e79fc52800, 0x42bc929723aaa000, 0x42b8b8fe3909c000, 0x42ca3facbb070000, 0x42d3b0ee69adb800, 0x42d013e736660800, 0x42dc1221836bd000, 0x430c122187b67200, + 0x42f1db9e764aa400, 0x42eee73dc74c3000, 0x430067cbf4e46000, 0x43089d2a04192600, 0x430418e103ff8a00, 0x43118b54f2236200, 0x43418b54f4d20740, 0x4326528613dd4d00, + 0x432350869c8f9e00, 0x433481bef21d7800, 0x433ec474851f6f80, 0x43391f1944ff6c80, 0x4345ee2a2eac3a80, 0x4375ee2a32068910, 0x435be72798d4a040, 0x435824a843b38580, + 0x4369a22eaea4d600, 0x43733ac8d333a5b0, 0x436f66df963f47a0, 0xc073a28c59d5433b, 0xc073a28c59d5433b, 0xc073a28c59d5433b, 0xc073a28c59d5434d, 0xc073a28c59d54329, + 0xc083a28c59d5433b, 0xc083a28c59d5433b, 0xc083a28c59d5433b, 0xc083a28c59d54344, 0xc083a28c59d54332, 0xc08d73d286bfe4d8, 0xc08d73d286bfe4d8, 0xc08d73d286bfe4d8, + 0xc08d73d286bfe4e1, 0xc08d73d286bfe4d0, 0xc093a28c59d5433b, 0xc093a28c59d5433b, 0xc093a28c59d5433b, 0xc093a28c59d5433f, 0xc093a28c59d54337, 0xc0988b2f704a940a, + 0xc0988b2f704a940a, 0xc0988b2f704a940a, 0xc0988b2f704a940e, 0xc0988b2f704a9405, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4dd, + 0xc09d73d286bfe4d4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad6, 0xc0a12e3ace9a9ad1, 0xc0a3a28c59d5433b, 0xc0a3a28c59d5433b, + 0xc0a3a28c59d5433b, 0xc0a3a28c59d5433d, 0xc0a3a28c59d54339, 0xc0a616dde50feba2, 0xc0a616dde50feba2, 0xc0a616dde50feba2, 0xc0a616dde50feba5, 0xc0a616dde50feba0, + 0xc0a88b2f704a940a, 0xc0a88b2f704a940a, 0xc0a88b2f704a940a, 0xc0a88b2f704a940c, 0xc0a88b2f704a9408, 0xc0aaff80fb853c71, 0xc0aaff80fb853c71, 0xc0aaff80fb853c71, + 0xc0aaff80fb853c73, 0xc0aaff80fb853c6f, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4db, 0xc0ad73d286bfe4d6, 0xc0afe82411fa8d40, + 0xc0afe82411fa8d40, 0xc0afe82411fa8d40, 0xc0afe82411fa8d42, 0xc0afe82411fa8d3e, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad5, + 0xc0b12e3ace9a9ad2, 0xc0b268639437ef07, 0xc0b268639437ef07, 0xc0b268639437ef07, 0xc0b268639437ef08, 0xc0b268639437ef06, 0xc0b3a28c59d5433b, 0xc0b3a28c59d5433b, + 0xc0b3a28c59d5433b, 0xc0b3a28c59d5433c, 0xc0b3a28c59d5433a, 0xc0b4dcb51f72976f, 0xc0b4dcb51f72976f, 0xc0b4dcb51f72976f, 0xc0b4dcb51f729770, 0xc0b4dcb51f72976e, + 0xc0b616dde50feba2, 0xc0b616dde50feba2, 0xc0b616dde50feba2, 0xc0b616dde50feba3, 0xc0b616dde50feba1, 0xc0b75106aaad3fd6, 0xc0b75106aaad3fd6, 0xc0b75106aaad3fd6, + 0xc0b75106aaad3fd7, 0xc0b75106aaad3fd5, 0xc0b88b2f704a940a, 0xc0b88b2f704a940a, 0xc0b88b2f704a940a, 0xc0b88b2f704a940b, 0xc0b88b2f704a9409, 0xc0b9c55835e7e83d, + 0xc0b9c55835e7e83d, 0xc0b9c55835e7e83d, 0xc0b9c55835e7e83e, 0xc0b9c55835e7e83c, 0xc0baff80fb853c71, 0xc0baff80fb853c71, 0xc0baff80fb853c71, 0xc0baff80fb853c72, + 0xc0baff80fb853c70, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a6, 0xc0bc39a9c12290a4, 0xc0bd73d286bfe4d8, 0xc0bd73d286bfe4d8, + 0xc0bd73d286bfe4d8, 0xc0bd73d286bfe4da, 0xc0bd73d286bfe4d7, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390d, 0xc0beadfb4c5d390b, + 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d41, 0xc0bfe82411fa8d3f, 0xc0c091266bcbf0ba, 0xc0c091266bcbf0ba, 0xc0c091266bcbf0ba, + 0xc0c091266bcbf0ba, 0xc0c091266bcbf0b9, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad3, 0xc0c1cb4f316944ed, + 0xc0c1cb4f316944ed, 0xc0c1cb4f316944ed, 0xc0c1cb4f316944ee, 0xc0c1cb4f316944ed, 0xc0c268639437ef07, 0xc0c268639437ef07, 0xc0c268639437ef07, 0xc0c268639437ef08, + 0xc0c268639437ef07, 0xc0c30577f7069921, 0xc0c30577f7069921, 0xc0c30577f7069921, 0xc0c30577f7069922, 0xc0c30577f7069921, 0xc0c3a28c59d5433b, 0xc0c3a28c59d5433b, + 0xc0c3a28c59d5433b, 0xc0c3a28c59d5433c, 0xc0c3a28c59d5433a, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed54, + 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976e, 0xc0c579c982414188, 0xc0c579c982414188, 0xc0c579c982414188, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3fed2f6f0efb879c, 0x3fefffffdd6862d4, 0x3fd354ef4eeb296b, 0xbfc31ae721d88897, 0x3fc50803b072659b, 0xbfef051f1616c063, 0xbfebd188b4c3ea9a, 0xbfddefa201dc4365, + 0x3feffff27cc76e6c, 0x3fefea2338506f71, 0xbfb292946dd109b8, 0x3fb46586ce99c116, 0xbfe945c70b018cca, 0x3fdc4004c876f9c8, 0xbfc3c490795a3687, 0x3feffab8e2b22112, + 0x3fe7d465c9fd8b23, 0xbfe7ed91a1aa981e, 0xbfe659959aa37055, 0x3fee5ee96a2ae1ce, 0x3fc1f4077c91589f, 0xbf94b68580d20bf8, 0x3fedf5ceebb0e676, 0x3fe0a19cc105385e, + 0x3fe1dfffaf282c79, 0xbfbf205e48aa5e43, 0xbfefefaadcb31651, 0xbfc4d7a73594d7c1, 0xbfef58f5899ce4b0, 0xbfecd6dcca389e02, 0xbfe5e190f8ecbd22, 0xbfedfd830826ec89, + 0xbfd60f5459110aa5, 0x3fe9d3ca4864fb6a, 0x3fb093aa7555aa1a, 0xbfdbf556a3739319, 0xbfcd3a973e71e730, 0xbfd4697d9419ef57, 0xbfed338cf3702a43, 0x3fedbf5b217178e9, + 0x3feffbad8aab2368, 0xbfe9837e378fb1da, 0x3fc85b7332c205cb, 0x3fe5697f73d6a01e, 0x3fefd34f5ba66292, 0xbfdea0becf4bd6d8, 0xbfe9cd7d18c9cd11, 0x3fee538a233719ed, + 0x3fef62152aa93bce, 0x3fd59250bc766e05, 0xbfe0003bdcbb5867, 0x3fe00f77e53d2b20, 0xbfd18c960b364ae8, 0x3feff78554f1430f, 0xbfefd134af6e8276, 0xbfd8ae26649a794f, + 0x3fee9b0ff3d9ae3b, 0xbfe0025692312ac2, 0xbfe099cb4114749e, 0x3fede763c8ee17df, 0x3fecbe77dcb0cc2e, 0x3fdec395f14cad52, 0x3fe5e4e0f0f150d0, 0xbfef7d72968bb5b6, + 0xbfe0175c92d67335, 0xbfe59e76ee01d8ab, 0xbfec1d1d8d3591af, 0xbfc4aa11d86885a6, 0xbfd30910683f3a93, 0xbfd4135721db8fe3, 0xbfcb8b67f21fcee2, 0xbfe0e7926ce82753, + 0xbfdb0b733d217050, 0x3fd0e79ac03aeb41, 0x3fa9f2a3d88e7f28, 0x3fefc37ea5658871, 0x3feff6234baa481f, 0x3fe2049a95f69b22, 0xbfe81bca40e52323, 0x3fd5eb3320f09276, + 0x3fec8d3cee73e810, 0xbfebf97265c912a8, 0x3fd6399b4ab1a90d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 23040 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0xc0c579c982414189, 0xc0c579c982414188, 0xc0c616dde50feba2, 0xc0c616dde50feba2, 0xc0c616dde50feba2, 0xc0c616dde50feba3, 0xc0c616dde50feba2, 0xc0c6b3f247de95bc, + 0xc0c6b3f247de95bc, 0xc0c6b3f247de95bc, 0xc0c6b3f247de95bd, 0xc0c6b3f247de95bc, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd7, + 0xc0c75106aaad3fd5, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9ef, 0xc0c88b2f704a940a, 0xc0c88b2f704a940a, + 0xc0c88b2f704a940a, 0xc0c88b2f704a940a, 0xc0c88b2f704a9409, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e23, + 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83e, 0xc0c9c55835e7e83d, 0xc0ca626c98b69257, 0xc0ca626c98b69257, 0xc0ca626c98b69257, + 0xc0ca626c98b69258, 0xc0ca626c98b69257, 0xc0caff80fb853c71, 0xc0caff80fb853c71, 0xc0caff80fb853c71, 0xc0caff80fb853c72, 0xc0caff80fb853c71, 0xc0cb9c955e53e68b, + 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68a, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, + 0xc0cc39a9c12290a4, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abe, 0xc0cd73d286bfe4d8, 0xc0cd73d286bfe4d8, + 0xc0cd73d286bfe4d8, 0xc0cd73d286bfe4d9, 0xc0cd73d286bfe4d8, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef3, 0xc0ce10e6e98e8ef2, + 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390d, 0xc0ceadfb4c5d390c, 0xc0cf4b0faf2be326, 0xc0cf4b0faf2be326, 0xc0cf4b0faf2be326, + 0xc0cf4b0faf2be327, 0xc0cf4b0faf2be325, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d3f, 0xc0d0429c3a649bad, + 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, + 0xc0d091266bcbf0b9, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c6, 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad4, + 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad3, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe0, + 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ee, 0xc0d1cb4f316944ed, 0xc0d219d962d099fa, 0xc0d219d962d099fa, 0xc0d219d962d099fa, + 0xc0d219d962d099fb, 0xc0d219d962d099fa, 0xc0d268639437ef07, 0xc0d268639437ef07, 0xc0d268639437ef07, 0xc0d268639437ef08, 0xc0d268639437ef07, 0xc0d2b6edc59f4414, + 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d30577f7069921, 0xc0d30577f7069921, 0xc0d30577f7069921, 0xc0d30577f7069921, + 0xc0d30577f7069921, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, + 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, + 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4262, + 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4261, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976e, 0xc0d52b3f50d9ec7c, + 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7b, 0xc0d579c982414188, 0xc0d579c982414188, 0xc0d579c982414188, 0xc0d579c982414189, + 0xc0d579c982414188, 0xc0d5c853b3a89695, 0xc0d5c853b3a89695, 0xc0d5c853b3a89695, 0xc0d5c853b3a89696, 0xc0d5c853b3a89695, 0xc0d616dde50feba2, 0xc0d616dde50feba2, + 0xc0d616dde50feba2, 0xc0d616dde50feba3, 0xc0d616dde50feba2, 0xc0d66568167740af, 0xc0d66568167740af, 0xc0d66568167740af, 0xc0d66568167740b0, 0xc0d66568167740af, + 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, + 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d79f90dc1494e3, + 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, + 0xc0d7ee1b0d7be9f0, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d88b2f704a940a, 0xc0d88b2f704a940a, + 0xc0d88b2f704a940a, 0xc0d88b2f704a940a, 0xc0d88b2f704a9409, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e916, + 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e23, 0xc0d976ce04809330, 0xc0d976ce04809330, 0xc0d976ce04809330, + 0xc0d976ce04809331, 0xc0d976ce04809330, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83e, 0xc0d9c55835e7e83d, 0xc0da13e2674f3d4a, + 0xc0da13e2674f3d4a, 0xc0da13e2674f3d4a, 0xc0da13e2674f3d4b, 0xc0da13e2674f3d4a, 0xc0da626c98b69257, 0xc0da626c98b69257, 0xc0da626c98b69257, 0xc0da626c98b69258, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), + +################ chunk 23552 ################ + ( bitcast(float64_t, Vec(uint64_t)( [ + 0xc0da626c98b69257, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0daff80fb853c71, 0xc0daff80fb853c71, + 0xc0daff80fb853c71, 0xc0daff80fb853c71, 0xc0daff80fb853c71, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, + 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, + 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a4, 0xc0dc8833f289e5b2, + 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b1, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, + 0xc0dcd6be23f13abe, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcb, 0xc0dd73d286bfe4d8, 0xc0dd73d286bfe4d8, + 0xc0dd73d286bfe4d8, 0xc0dd73d286bfe4d9, 0xc0dd73d286bfe4d8, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e6, 0xc0ddc25cb82739e5, + 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef3, 0xc0de10e6e98e8ef2, 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, + 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0defc857dc48e19, + 0x4330000000000000, 0x4330000000000001, 0x432ffffffffffffe, 0x4340000000000000, 0x433fffffffffffff, 0x43265286144ada42, 0x432350869d91c44a, 0x431418e104164f9c, + 0x401921fb54442d18, 0x402921fb54442d18, 0x403921fb54442d18, 0x4127f7eac1891f4d, 0x415df5e7364f130d, 0x5fe7dddf6b095ff1, 0x601dd55745cbb7ed, 0x6052a5568b9f52f4, + 0x7fefffffffffffff, 0x7fdfffffffffffff, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5434d, 0x4073a28c59d54329, 0x4083a28c59d5433b, + 0x4083a28c59d5433b, 0x4083a28c59d5433b, 0x4083a28c59d54344, 0x4083a28c59d54332, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4e1, + 0x408d73d286bfe4d0, 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433f, 0x4093a28c59d54337, 0x40988b2f704a940a, 0x40988b2f704a940a, + 0x40988b2f704a940a, 0x40988b2f704a940e, 0x40988b2f704a9405, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4dd, 0x409d73d286bfe4d4, + 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad6, 0x40a12e3ace9a9ad1, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, + 0x40a3a28c59d5433d, 0x40a3a28c59d54339, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba5, 0x40a616dde50feba0, 0x40a88b2f704a940a, + 0x40a88b2f704a940a, 0x40a88b2f704a940a, 0x40a88b2f704a940c, 0x40a88b2f704a9408, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c73, + 0x40aaff80fb853c6f, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4db, 0x40ad73d286bfe4d6, 0x40afe82411fa8d40, 0x40afe82411fa8d40, + 0x40afe82411fa8d40, 0x40afe82411fa8d42, 0x40afe82411fa8d3e, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad5, 0x40b12e3ace9a9ad2, + 0x40b268639437ef07, 0x40b268639437ef07, 0x40b268639437ef07, 0x40b268639437ef08, 0x40b268639437ef06, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, + 0x40b3a28c59d5433c, 0x40b3a28c59d5433a, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f729770, 0x40b4dcb51f72976e, 0x40b616dde50feba2, + 0x40b616dde50feba2, 0x40b616dde50feba2, 0x40b616dde50feba3, 0x40b616dde50feba1, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd7, + 0x40b75106aaad3fd5, 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940b, 0x40b88b2f704a9409, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, + 0x40b9c55835e7e83d, 0x40b9c55835e7e83e, 0x40b9c55835e7e83c, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c72, 0x40baff80fb853c70, + 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, 0x40bc39a9c12290a6, 0x40bc39a9c12290a4, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, + 0x40bd73d286bfe4da, 0x40bd73d286bfe4d7, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390d, 0x40beadfb4c5d390b, 0x40bfe82411fa8d40, + 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, 0x40bfe82411fa8d41, 0x40bfe82411fa8d3f, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, + 0x40c091266bcbf0b9, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad3, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, + 0x40c1cb4f316944ed, 0x40c1cb4f316944ee, 0x40c1cb4f316944ed, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef08, 0x40c268639437ef07, + 0x40c30577f7069921, 0x40c30577f7069921, 0x40c30577f7069921, 0x40c30577f7069922, 0x40c30577f7069921, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, + 0x40c3a28c59d5433c, 0x40c3a28c59d5433a, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed54, 0x40c4dcb51f72976f, +] )), bitcast(float64_t, Vec(uint64_t)( [ + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0xbfdf1300d681503f, 0xbfefef526a39c993, 0x3fde4a6e3ea69b14, 0xbfe0e9918bb35aac, 0xbfefff33f44e67c2, 0x3fef182f56d0a5a4, 0xbfeff9e26bf38768, 0xbfeff108c736c908, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3fe6a09e667cc390, 0x3fe6a09e66629663, 0x3feeac4e86fbcb5d, 0xbfeffb11b8b828dc, 0x3fc718b841bb6d99, + 0xbfefffe62ecfab75, 0x3f645300b2210ee6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, + 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, +] )) ), +] +cos_float32_t = [ + +################ chunk 0 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x441d1463, 0x441d1463, 0x441d1463, + 0x441d1463, 0x441d1463, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x449d1463, + 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x44c4597c, 0x44c4597c, 0x44c4597c, 0x44c4597c, + 0x44c4597c, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x450971d6, 0x450971d6, + 0x450971d6, 0x450971d6, 0x450971d6, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, + 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4544597c, 0x4544597c, 0x4544597c, + 0x4544597c, 0x4544597c, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x456b9e94, + 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x457f4121, 0x457f4121, 0x457f4121, 0x457f4121, + 0x457f4121, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x4593431d, 0x4593431d, + 0x4593431d, 0x4593431d, 0x4593431d, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, + 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45b0b6ef, 0x45b0b6ef, 0x45b0b6ef, + 0x45b0b6ef, 0x45b0b6ef, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45c4597c, + 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, + 0x45ce2ac2, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45e1cd4e, 0x45e1cd4e, + 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, + 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45ff4121, 0x45ff4121, 0x45ff4121, + 0x45ff4121, 0x45ff4121, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x460971d6, + 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, + 0x460e5a7a, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x46182bc0, 0x46182bc0, + 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, + 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4626e5a9, 0x4626e5a9, 0x4626e5a9, + 0x4626e5a9, 0x4626e5a9, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x4630b6ef, + 0x4630b6ef, 0x4630b6ef, 0x4630b6ef, 0x4630b6ef, 0x46359f92, 0x46359f92, 0x46359f92, 0x46359f92, + 0x46359f92, 0x463a8835, 0x463a8835, 0x463a8835, 0x463a8835, 0x463a8835, 0x463f70d8, 0x463f70d8, + 0x463f70d8, 0x463f70d8, 0x463f70d8, 0x4644597c, 0x4644597c, 0x4644597c, 0x4644597c, 0x4644597c, + 0x4649421f, 0x4649421f, 0x4649421f, 0x4649421f, 0x4649421f, 0x464e2ac2, 0x464e2ac2, 0x464e2ac2, + 0x464e2ac2, 0x464e2ac2, 0x46531365, 0x46531365, 0x46531365, 0x46531365, 0x46531365, 0x4657fc08, + 0x4657fc08, 0x4657fc08, 0x4657fc08, 0x4657fc08, 0x465ce4ab, 0x465ce4ab, 0x465ce4ab, 0x465ce4ab, + 0x465ce4ab, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4666b5f1, 0x4666b5f1, + 0x4666b5f1, 0x4666b5f1, 0x4666b5f1, 0x466b9e94, 0x466b9e94, 0x466b9e94, 0x466b9e94, 0x466b9e94, + 0x46708737, 0x46708737, 0x46708737, 0x46708737, 0x46708737, 0x46756fda, 0x46756fda, 0x46756fda, + 0x46756fda, 0x46756fda, 0x467a587d, 0x467a587d, 0x467a587d, 0x467a587d, 0x467a587d, 0x467f4121, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, +] )) ), + +################ chunk 512 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x467f4121, 0x467f4121, 0x467f4121, 0x467f4121, 0x468214e2, 0x468214e2, 0x468214e2, 0x468214e2, + 0x468214e2, 0x46848933, 0x46848933, 0x46848933, 0x46848933, 0x46848933, 0x4686fd85, 0x4686fd85, + 0x4686fd85, 0x4686fd85, 0x4686fd85, 0x468971d6, 0x468971d6, 0x468971d6, 0x468971d6, 0x468971d6, + 0x468be628, 0x468be628, 0x468be628, 0x468be628, 0x468be628, 0x468e5a7a, 0x468e5a7a, 0x468e5a7a, + 0x468e5a7a, 0x468e5a7a, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4693431d, + 0x4693431d, 0x4693431d, 0x4693431d, 0x4693431d, 0x4695b76e, 0x4695b76e, 0x4695b76e, 0x4695b76e, + 0x4695b76e, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x469aa011, 0x469aa011, + 0x469aa011, 0x469aa011, 0x469aa011, 0x469d1463, 0x469d1463, 0x469d1463, 0x469d1463, 0x469d1463, + 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x46a1fd06, 0x46a1fd06, 0x46a1fd06, + 0x46a1fd06, 0x46a1fd06, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a6e5a9, + 0x46a6e5a9, 0x46a6e5a9, 0x46a6e5a9, 0x46a6e5a9, 0x46a959fb, 0x46a959fb, 0x46a959fb, 0x46a959fb, + 0x46a959fb, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46ae429e, 0x46ae429e, + 0x46ae429e, 0x46ae429e, 0x46ae429e, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, + 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b59f92, 0x46b59f92, 0x46b59f92, + 0x46b59f92, 0x46b59f92, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46ba8835, + 0x46ba8835, 0x46ba8835, 0x46ba8835, 0x46ba8835, 0x46bcfc87, 0x46bcfc87, 0x46bcfc87, 0x46bcfc87, + 0x46bcfc87, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46c1e52a, 0x46c1e52a, + 0x46c1e52a, 0x46c1e52a, 0x46c1e52a, 0x46c4597c, 0x46c4597c, 0x46c4597c, 0x46c4597c, 0x46c4597c, + 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c9421f, 0x46c9421f, 0x46c9421f, + 0x46c9421f, 0x46c9421f, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46ce2ac2, + 0x46ce2ac2, 0x46ce2ac2, 0x46ce2ac2, 0x46ce2ac2, 0x46d09f13, 0x46d09f13, 0x46d09f13, 0x46d09f13, + 0x46d09f13, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d587b6, 0x46d587b6, + 0x46d587b6, 0x46d587b6, 0x46d587b6, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, + 0x46da7059, 0x46da7059, 0x46da7059, 0x46da7059, 0x46da7059, 0x46dce4ab, 0x46dce4ab, 0x46dce4ab, + 0x46dce4ab, 0x46dce4ab, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46e1cd4e, + 0x46e1cd4e, 0x46e1cd4e, 0x46e1cd4e, 0x46e1cd4e, 0x46e441a0, 0x46e441a0, 0x46e441a0, 0x46e441a0, + 0x46e441a0, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e92a43, 0x46e92a43, + 0x46e92a43, 0x46e92a43, 0x46e92a43, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, + 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46f08737, 0x46f08737, 0x46f08737, + 0x46f08737, 0x46f08737, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f56fda, + 0x46f56fda, 0x46f56fda, 0x46f56fda, 0x46f56fda, 0x46f7e42c, 0x46f7e42c, 0x46f7e42c, 0x46f7e42c, + 0x46f7e42c, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fccccf, 0x46fccccf, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, + 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, + 0x3f7ffffb, 0x3f7ffffb, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffb, + 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, 0x3f800000, +] )) ), + +################ chunk 1024 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x46fccccf, 0x46fccccf, 0x46fccccf, 0x46ff4121, 0x46ff4121, 0x46ff4121, 0x46ff4121, 0x46ff4121, + 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x470214e2, 0x470214e2, 0x470214e2, + 0x470214e2, 0x470214e2, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47048933, + 0x47048933, 0x47048933, 0x47048933, 0x47048933, 0x4705c35c, 0x4705c35c, 0x4705c35c, 0x4705c35c, + 0x4705c35c, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x470837ae, 0x470837ae, + 0x470837ae, 0x470837ae, 0x470837ae, 0x470971d6, 0x470971d6, 0x470971d6, 0x470971d6, 0x470971d6, + 0x470aabff, 0x470aabff, 0x470aabff, 0x470aabff, 0x470aabff, 0x470be628, 0x470be628, 0x470be628, + 0x470be628, 0x470be628, 0x470d2051, 0x470d2051, 0x470d2051, 0x470d2051, 0x470d2051, 0x470e5a7a, + 0x470e5a7a, 0x470e5a7a, 0x470e5a7a, 0x470e5a7a, 0x470f94a2, 0x470f94a2, 0x470f94a2, 0x470f94a2, + 0x470f94a2, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x471208f4, 0x471208f4, + 0x471208f4, 0x471208f4, 0x471208f4, 0x4713431d, 0x4713431d, 0x4713431d, 0x4713431d, 0x4713431d, + 0x47147d45, 0x47147d45, 0x47147d45, 0x47147d45, 0x47147d45, 0x4715b76e, 0x4715b76e, 0x4715b76e, + 0x4715b76e, 0x4715b76e, 0x4716f197, 0x4716f197, 0x4716f197, 0x4716f197, 0x4716f197, 0x47182bc0, + 0x47182bc0, 0x47182bc0, 0x47182bc0, 0x47182bc0, 0x471965e8, 0x471965e8, 0x471965e8, 0x471965e8, + 0x471965e8, 0x471aa011, 0x471aa011, 0x471aa011, 0x471aa011, 0x471aa011, 0x471bda3a, 0x471bda3a, + 0x471bda3a, 0x471bda3a, 0x471bda3a, 0x471d1463, 0x471d1463, 0x471d1463, 0x471d1463, 0x471d1463, + 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471f88b4, 0x471f88b4, 0x471f88b4, + 0x471f88b4, 0x471f88b4, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4721fd06, + 0x4721fd06, 0x4721fd06, 0x4721fd06, 0x4721fd06, 0x4723372f, 0x4723372f, 0x4723372f, 0x4723372f, + 0x4723372f, 0x47247157, 0x47247157, 0x47247157, 0x47247157, 0x47247157, 0x4725ab80, 0x4725ab80, + 0x4725ab80, 0x4725ab80, 0x4725ab80, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, + 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x472959fb, 0x472959fb, 0x472959fb, + 0x472959fb, 0x472959fb, 0x472a9423, 0x472a9423, 0x472a9423, 0x472a9423, 0x472a9423, 0x472bce4c, + 0x472bce4c, 0x472bce4c, 0x472bce4c, 0x472bce4c, 0x472d0875, 0x472d0875, 0x472d0875, 0x472d0875, + 0x472d0875, 0x472e429e, 0x472e429e, 0x472e429e, 0x472e429e, 0x472e429e, 0x472f7cc6, 0x472f7cc6, + 0x472f7cc6, 0x472f7cc6, 0x472f7cc6, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, + 0x4731f118, 0x4731f118, 0x4731f118, 0x4731f118, 0x4731f118, 0x47332b41, 0x47332b41, 0x47332b41, + 0x47332b41, 0x47332b41, 0x47346569, 0x47346569, 0x47346569, 0x47346569, 0x47346569, 0x47359f92, + 0x47359f92, 0x47359f92, 0x47359f92, 0x47359f92, 0x4736d9bb, 0x4736d9bb, 0x4736d9bb, 0x4736d9bb, + 0x4736d9bb, 0x473813e4, 0x473813e4, 0x473813e4, 0x473813e4, 0x473813e4, 0x47394e0d, 0x47394e0d, + 0x47394e0d, 0x47394e0d, 0x47394e0d, 0x473a8835, 0x473a8835, 0x473a8835, 0x473a8835, 0x473a8835, + 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473cfc87, 0x473cfc87, 0x473cfc87, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffef, + 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffff3, 0x3f7ffff3, + 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, + 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7fffe5, + 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, + 0x3f7ffff3, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, + 0x3f7ffff2, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, + 0x3f7fffe3, 0x3f7fffe3, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, + 0x3f7ffff5, 0x3f7ffff5, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7ffff8, + 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffe7, 0x3f7fffe7, + 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, +] )) ), + +################ chunk 1536 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x473cfc87, 0x473cfc87, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473f70d8, + 0x473f70d8, 0x473f70d8, 0x473f70d8, 0x473f70d8, 0x4740ab01, 0x4740ab01, 0x4740ab01, 0x4740ab01, + 0x4740ab01, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x47431f53, 0x47431f53, + 0x47431f53, 0x47431f53, 0x47431f53, 0x4744597c, 0x4744597c, 0x4744597c, 0x4744597c, 0x4744597c, + 0x474593a4, 0x474593a4, 0x474593a4, 0x474593a4, 0x474593a4, 0x4746cdcd, 0x4746cdcd, 0x4746cdcd, + 0x4746cdcd, 0x4746cdcd, 0x474807f6, 0x474807f6, 0x474807f6, 0x474807f6, 0x474807f6, 0x4749421f, + 0x4749421f, 0x4749421f, 0x4749421f, 0x4749421f, 0x474a7c47, 0x474a7c47, 0x474a7c47, 0x474a7c47, + 0x474a7c47, 0x474bb670, 0x474bb670, 0x474bb670, 0x474bb670, 0x474bb670, 0x474cf099, 0x474cf099, + 0x474cf099, 0x474cf099, 0x474cf099, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, + 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x47509f13, 0x47509f13, 0x47509f13, + 0x47509f13, 0x47509f13, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x47531365, + 0x47531365, 0x47531365, 0x47531365, 0x47531365, 0x47544d8e, 0x47544d8e, 0x47544d8e, 0x47544d8e, + 0x47544d8e, 0x475587b6, 0x475587b6, 0x475587b6, 0x475587b6, 0x475587b6, 0x4756c1df, 0x4756c1df, + 0x4756c1df, 0x4756c1df, 0x4756c1df, 0x4757fc08, 0x4757fc08, 0x4757fc08, 0x4757fc08, 0x4757fc08, + 0x47593631, 0x47593631, 0x47593631, 0x47593631, 0x47593631, 0x475a7059, 0x475a7059, 0x475a7059, + 0x475a7059, 0x475a7059, 0x475baa82, 0x475baa82, 0x475baa82, 0x475baa82, 0x475baa82, 0x475ce4ab, + 0x475ce4ab, 0x475ce4ab, 0x475ce4ab, 0x475ce4ab, 0x475e1ed4, 0x475e1ed4, 0x475e1ed4, 0x475e1ed4, + 0x475e1ed4, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x47609325, 0x47609325, + 0x47609325, 0x47609325, 0x47609325, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, + 0x47630777, 0x47630777, 0x47630777, 0x47630777, 0x47630777, 0x476441a0, 0x476441a0, 0x476441a0, + 0x476441a0, 0x476441a0, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x4766b5f1, + 0x4766b5f1, 0x4766b5f1, 0x4766b5f1, 0x4766b5f1, 0x4767f01a, 0x4767f01a, 0x4767f01a, 0x4767f01a, + 0x4767f01a, 0x47692a43, 0x47692a43, 0x47692a43, 0x47692a43, 0x47692a43, 0x476a646b, 0x476a646b, + 0x476a646b, 0x476a646b, 0x476a646b, 0x476b9e94, 0x476b9e94, 0x476b9e94, 0x476b9e94, 0x476b9e94, + 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476e12e6, 0x476e12e6, 0x476e12e6, + 0x476e12e6, 0x476e12e6, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x47708737, + 0x47708737, 0x47708737, 0x47708737, 0x47708737, 0x4771c160, 0x4771c160, 0x4771c160, 0x4771c160, + 0x4771c160, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x477435b2, 0x477435b2, + 0x477435b2, 0x477435b2, 0x477435b2, 0x47756fda, 0x47756fda, 0x47756fda, 0x47756fda, 0x47756fda, + 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4777e42c, 0x4777e42c, 0x4777e42c, + 0x4777e42c, 0x4777e42c, 0x47791e55, 0x47791e55, 0x47791e55, 0x47791e55, 0x47791e55, 0x477a587d, + 0x477a587d, 0x477a587d, 0x477a587d, 0x477a587d, 0x477b92a6, 0x477b92a6, 0x477b92a6, 0x477b92a6, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, + 0x3f7ffffb, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffeb, + 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, + 0x3f7fffef, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, + 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, + 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, + 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, + 0x3f7fffeb, 0x3f7fffeb, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7fffe7, 0x3f7fffe7, + 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, + 0x3f7ffff8, 0x3f7ffff8, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7ffff5, + 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7fffe3, + 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, +] )) ), + +################ chunk 2048 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x477b92a6, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477e06f8, 0x477e06f8, + 0x477e06f8, 0x477e06f8, 0x477e06f8, 0x477f4121, 0x477f4121, 0x477f4121, 0x477f4121, 0x477f4121, + 0x47803da5, 0x47803da5, 0x47803da5, 0x47803da5, 0x47803da5, 0x4780dab9, 0x4780dab9, 0x4780dab9, + 0x4780dab9, 0x4780dab9, 0x478177cd, 0x478177cd, 0x478177cd, 0x478177cd, 0x478177cd, 0x478214e2, + 0x478214e2, 0x478214e2, 0x478214e2, 0x478214e2, 0x4782b1f6, 0x4782b1f6, 0x4782b1f6, 0x4782b1f6, + 0x4782b1f6, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x4783ec1f, 0x4783ec1f, + 0x4783ec1f, 0x4783ec1f, 0x4783ec1f, 0x47848933, 0x47848933, 0x47848933, 0x47848933, 0x47848933, + 0x47852648, 0x47852648, 0x47852648, 0x47852648, 0x47852648, 0x4785c35c, 0x4785c35c, 0x4785c35c, + 0x4785c35c, 0x4785c35c, 0x47866071, 0x47866071, 0x47866071, 0x47866071, 0x47866071, 0x4786fd85, + 0x4786fd85, 0x4786fd85, 0x4786fd85, 0x4786fd85, 0x47879a99, 0x47879a99, 0x47879a99, 0x47879a99, + 0x47879a99, 0x478837ae, 0x478837ae, 0x478837ae, 0x478837ae, 0x478837ae, 0x4788d4c2, 0x4788d4c2, + 0x4788d4c2, 0x4788d4c2, 0x4788d4c2, 0x478971d6, 0x478971d6, 0x478971d6, 0x478971d6, 0x478971d6, + 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478aabff, 0x478aabff, 0x478aabff, + 0x478aabff, 0x478aabff, 0x478b4914, 0x478b4914, 0x478b4914, 0x478b4914, 0x478b4914, 0x478be628, + 0x478be628, 0x478be628, 0x478be628, 0x478be628, 0x478c833c, 0x478c833c, 0x478c833c, 0x478c833c, + 0x478c833c, 0x478d2051, 0x478d2051, 0x478d2051, 0x478d2051, 0x478d2051, 0x478dbd65, 0x478dbd65, + 0x478dbd65, 0x478dbd65, 0x478dbd65, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, + 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478f94a2, 0x478f94a2, 0x478f94a2, + 0x478f94a2, 0x478f94a2, 0x479031b7, 0x479031b7, 0x479031b7, 0x479031b7, 0x479031b7, 0x4790cecb, + 0x4790cecb, 0x4790cecb, 0x4790cecb, 0x4790cecb, 0x47916bdf, 0x47916bdf, 0x47916bdf, 0x47916bdf, + 0x47916bdf, 0x479208f4, 0x479208f4, 0x479208f4, 0x479208f4, 0x479208f4, 0x4792a608, 0x4792a608, + 0x4792a608, 0x4792a608, 0x4792a608, 0x4793431d, 0x4793431d, 0x4793431d, 0x4793431d, 0x4793431d, + 0x4793e031, 0x4793e031, 0x4793e031, 0x4793e031, 0x4793e031, 0x47947d45, 0x47947d45, 0x47947d45, + 0x47947d45, 0x47947d45, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x4795b76e, + 0x4795b76e, 0x4795b76e, 0x4795b76e, 0x4795b76e, 0x47965483, 0x47965483, 0x47965483, 0x47965483, + 0x47965483, 0x4796f197, 0x4796f197, 0x4796f197, 0x4796f197, 0x4796f197, 0x47978eab, 0x47978eab, + 0x47978eab, 0x47978eab, 0x47978eab, 0x47982bc0, 0x47982bc0, 0x47982bc0, 0x47982bc0, 0x47982bc0, + 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x479965e8, 0x479965e8, 0x479965e8, + 0x479965e8, 0x479965e8, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479aa011, + 0x479aa011, 0x479aa011, 0x479aa011, 0x479aa011, 0x479b3d26, 0x479b3d26, 0x479b3d26, 0x479b3d26, + 0x479b3d26, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479c774e, 0x479c774e, + 0x479c774e, 0x479c774e, 0x479c774e, 0x479d1463, 0x479d1463, 0x479d1463, 0x479d1463, 0x479d1463, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffff8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, + 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, + 0x3f7fffd2, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, + 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, + 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, + 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, + 0x3f7fff8d, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, + 0x3f7fffad, 0x3f7fffad, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, + 0x3f7fff9e, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc7, 0x3f7fffc7, + 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, + 0x3f7fff84, 0x3f7fff84, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fffdc, + 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, +] )) ), + +################ chunk 2560 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x479db177, 0x479db177, 0x479db177, 0x479db177, 0x479db177, 0x479e4e8c, 0x479e4e8c, 0x479e4e8c, + 0x479e4e8c, 0x479e4e8c, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479f88b4, + 0x479f88b4, 0x479f88b4, 0x479f88b4, 0x479f88b4, 0x47a025c9, 0x47a025c9, 0x47a025c9, 0x47a025c9, + 0x47a025c9, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a15ff2, 0x47a15ff2, + 0x47a15ff2, 0x47a15ff2, 0x47a15ff2, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, + 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a3372f, 0x47a3372f, 0x47a3372f, + 0x47a3372f, 0x47a3372f, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a47157, + 0x47a47157, 0x47a47157, 0x47a47157, 0x47a47157, 0x47a50e6c, 0x47a50e6c, 0x47a50e6c, 0x47a50e6c, + 0x47a50e6c, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a64895, 0x47a64895, + 0x47a64895, 0x47a64895, 0x47a64895, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, + 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a81fd2, 0x47a81fd2, 0x47a81fd2, + 0x47a81fd2, 0x47a81fd2, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a959fb, + 0x47a959fb, 0x47a959fb, 0x47a959fb, 0x47a959fb, 0x47a9f70f, 0x47a9f70f, 0x47a9f70f, 0x47a9f70f, + 0x47a9f70f, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47ab3138, 0x47ab3138, + 0x47ab3138, 0x47ab3138, 0x47ab3138, 0x47abce4c, 0x47abce4c, 0x47abce4c, 0x47abce4c, 0x47abce4c, + 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ad0875, 0x47ad0875, 0x47ad0875, + 0x47ad0875, 0x47ad0875, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ae429e, + 0x47ae429e, 0x47ae429e, 0x47ae429e, 0x47ae429e, 0x47aedfb2, 0x47aedfb2, 0x47aedfb2, 0x47aedfb2, + 0x47aedfb2, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47b019db, 0x47b019db, + 0x47b019db, 0x47b019db, 0x47b019db, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, + 0x47b15404, 0x47b15404, 0x47b15404, 0x47b15404, 0x47b15404, 0x47b1f118, 0x47b1f118, 0x47b1f118, + 0x47b1f118, 0x47b1f118, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b32b41, + 0x47b32b41, 0x47b32b41, 0x47b32b41, 0x47b32b41, 0x47b3c855, 0x47b3c855, 0x47b3c855, 0x47b3c855, + 0x47b3c855, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b5027e, 0x47b5027e, + 0x47b5027e, 0x47b5027e, 0x47b5027e, 0x47b59f92, 0x47b59f92, 0x47b59f92, 0x47b59f92, 0x47b59f92, + 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b6d9bb, 0x47b6d9bb, 0x47b6d9bb, + 0x47b6d9bb, 0x47b6d9bb, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b813e4, + 0x47b813e4, 0x47b813e4, 0x47b813e4, 0x47b813e4, 0x47b8b0f8, 0x47b8b0f8, 0x47b8b0f8, 0x47b8b0f8, + 0x47b8b0f8, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b9eb21, 0x47b9eb21, + 0x47b9eb21, 0x47b9eb21, 0x47b9eb21, 0x47ba8835, 0x47ba8835, 0x47ba8835, 0x47ba8835, 0x47ba8835, + 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bbc25e, 0x47bbc25e, 0x47bbc25e, + 0x47bbc25e, 0x47bbc25e, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bcfc87, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, + 0x3f7fffdd, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fff85, 0x3f7fff85, + 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, + 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fff9d, + 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffad, 0x3f7fffad, + 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff8d, + 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, + 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffb4, + 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffe5, 0x3f7fffe5, + 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, + 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffd3, + 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffff8, +] )) ), + +################ chunk 3072 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47bcfc87, 0x47bcfc87, 0x47bcfc87, 0x47bcfc87, 0x47bd999b, 0x47bd999b, 0x47bd999b, 0x47bd999b, + 0x47bd999b, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47bed3c4, 0x47bed3c4, + 0x47bed3c4, 0x47bed3c4, 0x47bed3c4, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, + 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c0ab01, 0x47c0ab01, 0x47c0ab01, + 0x47c0ab01, 0x47c0ab01, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c1e52a, + 0x47c1e52a, 0x47c1e52a, 0x47c1e52a, 0x47c1e52a, 0x47c2823e, 0x47c2823e, 0x47c2823e, 0x47c2823e, + 0x47c2823e, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c3bc67, 0x47c3bc67, + 0x47c3bc67, 0x47c3bc67, 0x47c3bc67, 0x47c4597c, 0x47c4597c, 0x47c4597c, 0x47c4597c, 0x47c4597c, + 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c593a4, 0x47c593a4, 0x47c593a4, + 0x47c593a4, 0x47c593a4, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c6cdcd, + 0x47c6cdcd, 0x47c6cdcd, 0x47c6cdcd, 0x47c6cdcd, 0x47c76ae1, 0x47c76ae1, 0x47c76ae1, 0x47c76ae1, + 0x47c76ae1, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c8a50a, 0x47c8a50a, + 0x47c8a50a, 0x47c8a50a, 0x47c8a50a, 0x47c9421f, 0x47c9421f, 0x47c9421f, 0x47c9421f, 0x47c9421f, + 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47ca7c47, 0x47ca7c47, 0x47ca7c47, + 0x47ca7c47, 0x47ca7c47, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cbb670, + 0x47cbb670, 0x47cbb670, 0x47cbb670, 0x47cbb670, 0x47cc5385, 0x47cc5385, 0x47cc5385, 0x47cc5385, + 0x47cc5385, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47cd8dad, 0x47cd8dad, + 0x47cd8dad, 0x47cd8dad, 0x47cd8dad, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, + 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cf64ea, 0x47cf64ea, 0x47cf64ea, + 0x47cf64ea, 0x47cf64ea, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d09f13, + 0x47d09f13, 0x47d09f13, 0x47d09f13, 0x47d09f13, 0x47d13c28, 0x47d13c28, 0x47d13c28, 0x47d13c28, + 0x47d13c28, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d27650, 0x47d27650, + 0x47d27650, 0x47d27650, 0x47d27650, 0x47d31365, 0x47d31365, 0x47d31365, 0x47d31365, 0x47d31365, + 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d44d8e, 0x47d44d8e, 0x47d44d8e, + 0x47d44d8e, 0x47d44d8e, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d587b6, + 0x47d587b6, 0x47d587b6, 0x47d587b6, 0x47d587b6, 0x47d624cb, 0x47d624cb, 0x47d624cb, 0x47d624cb, + 0x47d624cb, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d75ef3, 0x47d75ef3, + 0x47d75ef3, 0x47d75ef3, 0x47d75ef3, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, + 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d93631, 0x47d93631, 0x47d93631, + 0x47d93631, 0x47d93631, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47da7059, + 0x47da7059, 0x47da7059, 0x47da7059, 0x47da7059, 0x47db0d6e, 0x47db0d6e, 0x47db0d6e, 0x47db0d6e, + 0x47db0d6e, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dc4797, 0x47dc4797, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, + 0x3f7fffdc, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7ffff8, 0x3f7ffff8, + 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, + 0x3f7fff9d, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, + 0x3f7fffba, 0x3f7fffba, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, + 0x3f7fff8d, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffd2, 0x3f7fffd2, + 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, + 0x3f7fff95, 0x3f7fff95, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, + 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, + 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, + 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, + 0x3f7fffd3, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fff8d, 0x3f7fff8d, + 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, + 0x3f7fffbb, 0x3f7fffbb, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffac, + 0x3f7fffac, 0x3f7fffac, 0x3f7fffac, 0x3f7fffac, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff9e, 0x3f7fff9e, +] )) ), + +################ chunk 3584 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47dc4797, 0x47dc4797, 0x47dc4797, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, + 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47de1ed4, 0x47de1ed4, 0x47de1ed4, + 0x47de1ed4, 0x47de1ed4, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47df58fc, + 0x47df58fc, 0x47df58fc, 0x47df58fc, 0x47df58fc, 0x47dff611, 0x47dff611, 0x47dff611, 0x47dff611, + 0x47dff611, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e1303a, 0x47e1303a, + 0x47e1303a, 0x47e1303a, 0x47e1303a, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, + 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e30777, 0x47e30777, 0x47e30777, + 0x47e30777, 0x47e30777, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e441a0, + 0x47e441a0, 0x47e441a0, 0x47e441a0, 0x47e441a0, 0x47e4deb4, 0x47e4deb4, 0x47e4deb4, 0x47e4deb4, + 0x47e4deb4, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e618dd, 0x47e618dd, + 0x47e618dd, 0x47e618dd, 0x47e618dd, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, + 0x47e75306, 0x47e75306, 0x47e75306, 0x47e75306, 0x47e75306, 0x47e7f01a, 0x47e7f01a, 0x47e7f01a, + 0x47e7f01a, 0x47e7f01a, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e92a43, + 0x47e92a43, 0x47e92a43, 0x47e92a43, 0x47e92a43, 0x47e9c757, 0x47e9c757, 0x47e9c757, 0x47e9c757, + 0x47e9c757, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47eb0180, 0x47eb0180, + 0x47eb0180, 0x47eb0180, 0x47eb0180, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, + 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ecd8bd, 0x47ecd8bd, 0x47ecd8bd, + 0x47ecd8bd, 0x47ecd8bd, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ee12e6, + 0x47ee12e6, 0x47ee12e6, 0x47ee12e6, 0x47ee12e6, 0x47eeaffa, 0x47eeaffa, 0x47eeaffa, 0x47eeaffa, + 0x47eeaffa, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47efea23, 0x47efea23, + 0x47efea23, 0x47efea23, 0x47efea23, 0x47f08737, 0x47f08737, 0x47f08737, 0x47f08737, 0x47f08737, + 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1c160, 0x47f1c160, 0x47f1c160, + 0x47f1c160, 0x47f1c160, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f2fb89, + 0x47f2fb89, 0x47f2fb89, 0x47f2fb89, 0x47f2fb89, 0x47f3989d, 0x47f3989d, 0x47f3989d, 0x47f3989d, + 0x47f3989d, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f4d2c6, 0x47f4d2c6, + 0x47f4d2c6, 0x47f4d2c6, 0x47f4d2c6, 0x47f56fda, 0x47f56fda, 0x47f56fda, 0x47f56fda, 0x47f56fda, + 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f6aa03, 0x47f6aa03, 0x47f6aa03, + 0x47f6aa03, 0x47f6aa03, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f7e42c, + 0x47f7e42c, 0x47f7e42c, 0x47f7e42c, 0x47f7e42c, 0x47f88140, 0x47f88140, 0x47f88140, 0x47f88140, + 0x47f88140, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f9bb69, 0x47f9bb69, + 0x47f9bb69, 0x47f9bb69, 0x47f9bb69, 0x47fa587d, 0x47fa587d, 0x47fa587d, 0x47fa587d, 0x47fa587d, + 0x47faf592, 0x47faf592, 0x47faf592, 0x47faf592, 0x47faf592, 0x47fb92a6, 0x47fb92a6, 0x47fb92a6, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, + 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, + 0x3f7ffff8, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, + 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffdd, 0x3f7fffdd, + 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, + 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffc7, + 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffff3, + 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, + 0x3f7fffe5, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, + 0x3f7ffff3, 0x3f7ffff3, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, +] )) ), + +################ chunk 4096 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47fb92a6, 0x47fb92a6, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fccccf, + 0x47fccccf, 0x47fccccf, 0x47fccccf, 0x47fccccf, 0x47fd69e3, 0x47fd69e3, 0x47fd69e3, 0x47fd69e3, + 0x47fd69e3, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fea40c, 0x47fea40c, + 0x47fea40c, 0x47fea40c, 0x47fea40c, 0x47ff4121, 0x47ff4121, 0x47ff4121, 0x47ff4121, 0x47ff4121, + 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x48003da5, 0x48003da5, 0x48003da5, + 0x48003da5, 0x48003da5, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x4800dab9, + 0x4800dab9, 0x4800dab9, 0x4800dab9, 0x4800dab9, 0x48012943, 0x48012943, 0x48012943, 0x48012943, + 0x48012943, 0x480177cd, 0x480177cd, 0x480177cd, 0x480177cd, 0x480177cd, 0x4801c658, 0x4801c658, + 0x4801c658, 0x4801c658, 0x4801c658, 0x480214e2, 0x480214e2, 0x480214e2, 0x480214e2, 0x480214e2, + 0x4802636c, 0x4802636c, 0x4802636c, 0x4802636c, 0x4802636c, 0x4802b1f6, 0x4802b1f6, 0x4802b1f6, + 0x4802b1f6, 0x4802b1f6, 0x48030080, 0x48030080, 0x48030080, 0x48030080, 0x48030080, 0x48034f0b, + 0x48034f0b, 0x48034f0b, 0x48034f0b, 0x48034f0b, 0x48039d95, 0x48039d95, 0x48039d95, 0x48039d95, + 0x48039d95, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x48043aa9, 0x48043aa9, + 0x48043aa9, 0x48043aa9, 0x48043aa9, 0x48048933, 0x48048933, 0x48048933, 0x48048933, 0x48048933, + 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x48052648, 0x48052648, 0x48052648, + 0x48052648, 0x48052648, 0x480574d2, 0x480574d2, 0x480574d2, 0x480574d2, 0x480574d2, 0x4805c35c, + 0x4805c35c, 0x4805c35c, 0x4805c35c, 0x4805c35c, 0x480611e6, 0x480611e6, 0x480611e6, 0x480611e6, + 0x480611e6, 0x48066071, 0x48066071, 0x48066071, 0x48066071, 0x48066071, 0x4806aefb, 0x4806aefb, + 0x4806aefb, 0x4806aefb, 0x4806aefb, 0x4806fd85, 0x4806fd85, 0x4806fd85, 0x4806fd85, 0x4806fd85, + 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48079a99, 0x48079a99, 0x48079a99, + 0x48079a99, 0x48079a99, 0x4807e923, 0x4807e923, 0x4807e923, 0x4807e923, 0x4807e923, 0x480837ae, + 0x480837ae, 0x480837ae, 0x480837ae, 0x480837ae, 0x48088638, 0x48088638, 0x48088638, 0x48088638, + 0x48088638, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4809234c, 0x4809234c, + 0x4809234c, 0x4809234c, 0x4809234c, 0x480971d6, 0x480971d6, 0x480971d6, 0x480971d6, 0x480971d6, + 0x4809c061, 0x4809c061, 0x4809c061, 0x4809c061, 0x4809c061, 0x480a0eeb, 0x480a0eeb, 0x480a0eeb, + 0x480a0eeb, 0x480a0eeb, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480aabff, + 0x480aabff, 0x480aabff, 0x480aabff, 0x480aabff, 0x480afa89, 0x480afa89, 0x480afa89, 0x480afa89, + 0x480afa89, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b979e, 0x480b979e, + 0x480b979e, 0x480b979e, 0x480b979e, 0x480be628, 0x480be628, 0x480be628, 0x480be628, 0x480be628, + 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c833c, 0x480c833c, 0x480c833c, + 0x480c833c, 0x480c833c, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480d2051, + 0x480d2051, 0x480d2051, 0x480d2051, 0x480d2051, 0x480d6edb, 0x480d6edb, 0x480d6edb, 0x480d6edb, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffac, 0x3f7fffac, 0x3f7fffac, 0x3f7fffac, + 0x3f7fffac, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, + 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, + 0x3f7fff84, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffeea, 0x3f7ffeea, + 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, + 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, + 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, + 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, + 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, + 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, + 0x3f7fff4a, 0x3f7fff4a, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, + 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, + 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, + 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, + 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, + 0x3f7ffe95, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, + 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7fff96, + 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, +] )) ), + +################ chunk 4608 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x480d6edb, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480e0bef, 0x480e0bef, + 0x480e0bef, 0x480e0bef, 0x480e0bef, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, + 0x480ea904, 0x480ea904, 0x480ea904, 0x480ea904, 0x480ea904, 0x480ef78e, 0x480ef78e, 0x480ef78e, + 0x480ef78e, 0x480ef78e, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f94a2, + 0x480f94a2, 0x480f94a2, 0x480f94a2, 0x480f94a2, 0x480fe32d, 0x480fe32d, 0x480fe32d, 0x480fe32d, + 0x480fe32d, 0x481031b7, 0x481031b7, 0x481031b7, 0x481031b7, 0x481031b7, 0x48108041, 0x48108041, + 0x48108041, 0x48108041, 0x48108041, 0x4810cecb, 0x4810cecb, 0x4810cecb, 0x4810cecb, 0x4810cecb, + 0x48111d55, 0x48111d55, 0x48111d55, 0x48111d55, 0x48111d55, 0x48116bdf, 0x48116bdf, 0x48116bdf, + 0x48116bdf, 0x48116bdf, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x481208f4, + 0x481208f4, 0x481208f4, 0x481208f4, 0x481208f4, 0x4812577e, 0x4812577e, 0x4812577e, 0x4812577e, + 0x4812577e, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812f492, 0x4812f492, + 0x4812f492, 0x4812f492, 0x4812f492, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, + 0x481391a7, 0x481391a7, 0x481391a7, 0x481391a7, 0x481391a7, 0x4813e031, 0x4813e031, 0x4813e031, + 0x4813e031, 0x4813e031, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48147d45, + 0x48147d45, 0x48147d45, 0x48147d45, 0x48147d45, 0x4814cbd0, 0x4814cbd0, 0x4814cbd0, 0x4814cbd0, + 0x4814cbd0, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x481568e4, 0x481568e4, + 0x481568e4, 0x481568e4, 0x481568e4, 0x4815b76e, 0x4815b76e, 0x4815b76e, 0x4815b76e, 0x4815b76e, + 0x481605f8, 0x481605f8, 0x481605f8, 0x481605f8, 0x481605f8, 0x48165483, 0x48165483, 0x48165483, + 0x48165483, 0x48165483, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816f197, + 0x4816f197, 0x4816f197, 0x4816f197, 0x4816f197, 0x48174021, 0x48174021, 0x48174021, 0x48174021, + 0x48174021, 0x48178eab, 0x48178eab, 0x48178eab, 0x48178eab, 0x48178eab, 0x4817dd36, 0x4817dd36, + 0x4817dd36, 0x4817dd36, 0x4817dd36, 0x48182bc0, 0x48182bc0, 0x48182bc0, 0x48182bc0, 0x48182bc0, + 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x4818c8d4, 0x4818c8d4, 0x4818c8d4, + 0x4818c8d4, 0x4818c8d4, 0x4819175e, 0x4819175e, 0x4819175e, 0x4819175e, 0x4819175e, 0x481965e8, + 0x481965e8, 0x481965e8, 0x481965e8, 0x481965e8, 0x4819b473, 0x4819b473, 0x4819b473, 0x4819b473, + 0x4819b473, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a5187, 0x481a5187, + 0x481a5187, 0x481a5187, 0x481a5187, 0x481aa011, 0x481aa011, 0x481aa011, 0x481aa011, 0x481aa011, + 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481b3d26, 0x481b3d26, 0x481b3d26, + 0x481b3d26, 0x481b3d26, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481bda3a, + 0x481bda3a, 0x481bda3a, 0x481bda3a, 0x481bda3a, 0x481c28c4, 0x481c28c4, 0x481c28c4, 0x481c28c4, + 0x481c28c4, 0x481c774e, 0x481c774e, 0x481c774e, 0x481c774e, 0x481c774e, 0x481cc5d9, 0x481cc5d9, + 0x481cc5d9, 0x481cc5d9, 0x481cc5d9, 0x481d1463, 0x481d1463, 0x481d1463, 0x481d1463, 0x481d1463, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff04, 0x3f7fff04, + 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, + 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, + 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, + 0x3f7ffe12, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, + 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe76, 0x3f7ffe76, + 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, + 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, + 0x3f7ffeb3, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, + 0x3f7ffe76, 0x3f7ffe76, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, + 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7ffe11, + 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, + 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, + 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, + 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, + 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffecf, 0x3f7ffecf, + 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, +] )) ), + +################ chunk 5120 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481db177, 0x481db177, 0x481db177, + 0x481db177, 0x481db177, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e4e8c, + 0x481e4e8c, 0x481e4e8c, 0x481e4e8c, 0x481e4e8c, 0x481e9d16, 0x481e9d16, 0x481e9d16, 0x481e9d16, + 0x481e9d16, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481f3a2a, 0x481f3a2a, + 0x481f3a2a, 0x481f3a2a, 0x481f3a2a, 0x481f88b4, 0x481f88b4, 0x481f88b4, 0x481f88b4, 0x481f88b4, + 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x482025c9, 0x482025c9, 0x482025c9, + 0x482025c9, 0x482025c9, 0x48207453, 0x48207453, 0x48207453, 0x48207453, 0x48207453, 0x4820c2dd, + 0x4820c2dd, 0x4820c2dd, 0x4820c2dd, 0x4820c2dd, 0x48211167, 0x48211167, 0x48211167, 0x48211167, + 0x48211167, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x4821ae7c, 0x4821ae7c, + 0x4821ae7c, 0x4821ae7c, 0x4821ae7c, 0x4821fd06, 0x4821fd06, 0x4821fd06, 0x4821fd06, 0x4821fd06, + 0x48224b90, 0x48224b90, 0x48224b90, 0x48224b90, 0x48224b90, 0x48229a1a, 0x48229a1a, 0x48229a1a, + 0x48229a1a, 0x48229a1a, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4823372f, + 0x4823372f, 0x4823372f, 0x4823372f, 0x4823372f, 0x482385b9, 0x482385b9, 0x482385b9, 0x482385b9, + 0x482385b9, 0x4823d443, 0x4823d443, 0x4823d443, 0x4823d443, 0x4823d443, 0x482422cd, 0x482422cd, + 0x482422cd, 0x482422cd, 0x482422cd, 0x48247157, 0x48247157, 0x48247157, 0x48247157, 0x48247157, + 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x48250e6c, 0x48250e6c, 0x48250e6c, + 0x48250e6c, 0x48250e6c, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x4825ab80, + 0x4825ab80, 0x4825ab80, 0x4825ab80, 0x4825ab80, 0x4825fa0a, 0x4825fa0a, 0x4825fa0a, 0x4825fa0a, + 0x4825fa0a, 0x48264895, 0x48264895, 0x48264895, 0x48264895, 0x48264895, 0x4826971f, 0x4826971f, + 0x4826971f, 0x4826971f, 0x4826971f, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, + 0x48273433, 0x48273433, 0x48273433, 0x48273433, 0x48273433, 0x482782bd, 0x482782bd, 0x482782bd, + 0x482782bd, 0x482782bd, 0x4827d148, 0x4827d148, 0x4827d148, 0x4827d148, 0x4827d148, 0x48281fd2, + 0x48281fd2, 0x48281fd2, 0x48281fd2, 0x48281fd2, 0x48286e5c, 0x48286e5c, 0x48286e5c, 0x48286e5c, + 0x48286e5c, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x48290b70, 0x48290b70, + 0x48290b70, 0x48290b70, 0x48290b70, 0x482959fb, 0x482959fb, 0x482959fb, 0x482959fb, 0x482959fb, + 0x4829a885, 0x4829a885, 0x4829a885, 0x4829a885, 0x4829a885, 0x4829f70f, 0x4829f70f, 0x4829f70f, + 0x4829f70f, 0x4829f70f, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a9423, + 0x482a9423, 0x482a9423, 0x482a9423, 0x482a9423, 0x482ae2ad, 0x482ae2ad, 0x482ae2ad, 0x482ae2ad, + 0x482ae2ad, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b7fc2, 0x482b7fc2, + 0x482b7fc2, 0x482b7fc2, 0x482b7fc2, 0x482bce4c, 0x482bce4c, 0x482bce4c, 0x482bce4c, 0x482bce4c, + 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c6b60, 0x482c6b60, 0x482c6b60, + 0x482c6b60, 0x482c6b60, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482d0875, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0x3f7fffb4, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffe95, + 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, + 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, + 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, + 0x3f7fff72, 0x3f7fff72, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, + 0x3f7fff33, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7fff4a, 0x3f7fff4a, + 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, + 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, + 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, + 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, + 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, + 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, + 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, + 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, + 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, + 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, + 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, + 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, + 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, +] )) ), + +################ chunk 5632 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x482d0875, 0x482d0875, 0x482d0875, 0x482d0875, 0x482d56ff, 0x482d56ff, 0x482d56ff, 0x482d56ff, + 0x482d56ff, 0x482da589, 0x482da589, 0x482da589, 0x482da589, 0x482da589, 0x482df413, 0x482df413, + 0x482df413, 0x482df413, 0x482df413, 0x482e429e, 0x482e429e, 0x482e429e, 0x482e429e, 0x482e429e, + 0x482e9128, 0x482e9128, 0x482e9128, 0x482e9128, 0x482e9128, 0x482edfb2, 0x482edfb2, 0x482edfb2, + 0x482edfb2, 0x482edfb2, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f7cc6, + 0x482f7cc6, 0x482f7cc6, 0x482f7cc6, 0x482f7cc6, 0x482fcb51, 0x482fcb51, 0x482fcb51, 0x482fcb51, + 0x482fcb51, 0x483019db, 0x483019db, 0x483019db, 0x483019db, 0x483019db, 0x48306865, 0x48306865, + 0x48306865, 0x48306865, 0x48306865, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, + 0x48310579, 0x48310579, 0x48310579, 0x48310579, 0x48310579, 0x48315404, 0x48315404, 0x48315404, + 0x48315404, 0x48315404, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831f118, + 0x4831f118, 0x4831f118, 0x4831f118, 0x4831f118, 0x48323fa2, 0x48323fa2, 0x48323fa2, 0x48323fa2, + 0x48323fa2, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x4832dcb7, 0x4832dcb7, + 0x4832dcb7, 0x4832dcb7, 0x4832dcb7, 0x48332b41, 0x48332b41, 0x48332b41, 0x48332b41, 0x48332b41, + 0x483379cb, 0x483379cb, 0x483379cb, 0x483379cb, 0x483379cb, 0x4833c855, 0x4833c855, 0x4833c855, + 0x4833c855, 0x4833c855, 0x483416df, 0x483416df, 0x483416df, 0x483416df, 0x483416df, 0x48346569, + 0x48346569, 0x48346569, 0x48346569, 0x48346569, 0x4834b3f4, 0x4834b3f4, 0x4834b3f4, 0x4834b3f4, + 0x4834b3f4, 0x4835027e, 0x4835027e, 0x4835027e, 0x4835027e, 0x4835027e, 0x48355108, 0x48355108, + 0x48355108, 0x48355108, 0x48355108, 0x48359f92, 0x48359f92, 0x48359f92, 0x48359f92, 0x48359f92, + 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x48363ca7, 0x48363ca7, 0x48363ca7, + 0x48363ca7, 0x48363ca7, 0x48368b31, 0x48368b31, 0x48368b31, 0x48368b31, 0x48368b31, 0x4836d9bb, + 0x4836d9bb, 0x4836d9bb, 0x4836d9bb, 0x4836d9bb, 0x48372845, 0x48372845, 0x48372845, 0x48372845, + 0x48372845, 0x483776cf, 0x483776cf, 0x483776cf, 0x483776cf, 0x483776cf, 0x4837c55a, 0x4837c55a, + 0x4837c55a, 0x4837c55a, 0x4837c55a, 0x483813e4, 0x483813e4, 0x483813e4, 0x483813e4, 0x483813e4, + 0x4838626e, 0x4838626e, 0x4838626e, 0x4838626e, 0x4838626e, 0x4838b0f8, 0x4838b0f8, 0x4838b0f8, + 0x4838b0f8, 0x4838b0f8, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x48394e0d, + 0x48394e0d, 0x48394e0d, 0x48394e0d, 0x48394e0d, 0x48399c97, 0x48399c97, 0x48399c97, 0x48399c97, + 0x48399c97, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x483a39ab, 0x483a39ab, + 0x483a39ab, 0x483a39ab, 0x483a39ab, 0x483a8835, 0x483a8835, 0x483a8835, 0x483a8835, 0x483a8835, + 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483b254a, 0x483b254a, 0x483b254a, + 0x483b254a, 0x483b254a, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483bc25e, + 0x483bc25e, 0x483bc25e, 0x483bc25e, 0x483bc25e, 0x483c10e8, 0x483c10e8, 0x483c10e8, 0x483c10e8, + 0x483c10e8, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483cadfd, 0x483cadfd, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, + 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, + 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, + 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, + 0x3f7ffe95, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, + 0x3f7ffe56, 0x3f7ffe56, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffe12, 0x3f7ffe12, + 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, + 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, + 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, + 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, + 0x3f7ffeea, 0x3f7ffeea, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, + 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffe77, + 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, + 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd7, 0x3f7fffd7, + 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, + 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, + 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, + 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, +] )) ), + +################ chunk 6144 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x483cadfd, 0x483cadfd, 0x483cadfd, 0x483cfc87, 0x483cfc87, 0x483cfc87, 0x483cfc87, 0x483cfc87, + 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d999b, 0x483d999b, 0x483d999b, + 0x483d999b, 0x483d999b, 0x483de825, 0x483de825, 0x483de825, 0x483de825, 0x483de825, 0x483e36b0, + 0x483e36b0, 0x483e36b0, 0x483e36b0, 0x483e36b0, 0x483e853a, 0x483e853a, 0x483e853a, 0x483e853a, + 0x483e853a, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483f224e, 0x483f224e, + 0x483f224e, 0x483f224e, 0x483f224e, 0x483f70d8, 0x483f70d8, 0x483f70d8, 0x483f70d8, 0x483f70d8, + 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x48400ded, 0x48400ded, 0x48400ded, + 0x48400ded, 0x48400ded, 0x48405c77, 0x48405c77, 0x48405c77, 0x48405c77, 0x48405c77, 0x4840ab01, + 0x4840ab01, 0x4840ab01, 0x4840ab01, 0x4840ab01, 0x4840f98b, 0x4840f98b, 0x4840f98b, 0x4840f98b, + 0x4840f98b, 0x48414816, 0x48414816, 0x48414816, 0x48414816, 0x48414816, 0x484196a0, 0x484196a0, + 0x484196a0, 0x484196a0, 0x484196a0, 0x4841e52a, 0x4841e52a, 0x4841e52a, 0x4841e52a, 0x4841e52a, + 0x484233b4, 0x484233b4, 0x484233b4, 0x484233b4, 0x484233b4, 0x4842823e, 0x4842823e, 0x4842823e, + 0x4842823e, 0x4842823e, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x48431f53, + 0x48431f53, 0x48431f53, 0x48431f53, 0x48431f53, 0x48436ddd, 0x48436ddd, 0x48436ddd, 0x48436ddd, + 0x48436ddd, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x48440af1, 0x48440af1, + 0x48440af1, 0x48440af1, 0x48440af1, 0x4844597c, 0x4844597c, 0x4844597c, 0x4844597c, 0x4844597c, + 0x4844a806, 0x4844a806, 0x4844a806, 0x4844a806, 0x4844a806, 0x4844f690, 0x4844f690, 0x4844f690, + 0x4844f690, 0x4844f690, 0x4845451a, 0x4845451a, 0x4845451a, 0x4845451a, 0x4845451a, 0x484593a4, + 0x484593a4, 0x484593a4, 0x484593a4, 0x484593a4, 0x4845e22e, 0x4845e22e, 0x4845e22e, 0x4845e22e, + 0x4845e22e, 0x484630b9, 0x484630b9, 0x484630b9, 0x484630b9, 0x484630b9, 0x48467f43, 0x48467f43, + 0x48467f43, 0x48467f43, 0x48467f43, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, + 0x48471c57, 0x48471c57, 0x48471c57, 0x48471c57, 0x48471c57, 0x48476ae1, 0x48476ae1, 0x48476ae1, + 0x48476ae1, 0x48476ae1, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x484807f6, + 0x484807f6, 0x484807f6, 0x484807f6, 0x484807f6, 0x48485680, 0x48485680, 0x48485680, 0x48485680, + 0x48485680, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848f394, 0x4848f394, + 0x4848f394, 0x4848f394, 0x4848f394, 0x4849421f, 0x4849421f, 0x4849421f, 0x4849421f, 0x4849421f, + 0x484990a9, 0x484990a9, 0x484990a9, 0x484990a9, 0x484990a9, 0x4849df33, 0x4849df33, 0x4849df33, + 0x4849df33, 0x4849df33, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a7c47, + 0x484a7c47, 0x484a7c47, 0x484a7c47, 0x484a7c47, 0x484acad2, 0x484acad2, 0x484acad2, 0x484acad2, + 0x484acad2, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b67e6, 0x484b67e6, + 0x484b67e6, 0x484b67e6, 0x484b67e6, 0x484bb670, 0x484bb670, 0x484bb670, 0x484bb670, 0x484bb670, + 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c5385, 0x484c5385, 0x484c5385, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, + 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, + 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, + 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, + 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb3, + 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, + 0x3f7ffece, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7fff96, 0x3f7fff96, + 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, + 0x3f7fff03, 0x3f7fff03, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7fff73, + 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, + 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, + 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, + 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, + 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, + 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, + 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, + 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffeea, + 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, + 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, + 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, +] )) ), + +################ chunk 6656 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x484c5385, 0x484c5385, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484cf099, + 0x484cf099, 0x484cf099, 0x484cf099, 0x484cf099, 0x484d3f23, 0x484d3f23, 0x484d3f23, 0x484d3f23, + 0x484d3f23, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484ddc37, 0x484ddc37, + 0x484ddc37, 0x484ddc37, 0x484ddc37, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, + 0x484e794c, 0x484e794c, 0x484e794c, 0x484e794c, 0x484e794c, 0x484ec7d6, 0x484ec7d6, 0x484ec7d6, + 0x484ec7d6, 0x484ec7d6, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f64ea, + 0x484f64ea, 0x484f64ea, 0x484f64ea, 0x484f64ea, 0x484fb375, 0x484fb375, 0x484fb375, 0x484fb375, + 0x484fb375, 0x485001ff, 0x485001ff, 0x485001ff, 0x485001ff, 0x485001ff, 0x48505089, 0x48505089, + 0x48505089, 0x48505089, 0x48505089, 0x48509f13, 0x48509f13, 0x48509f13, 0x48509f13, 0x48509f13, + 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x48513c28, 0x48513c28, 0x48513c28, + 0x48513c28, 0x48513c28, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x4851d93c, + 0x4851d93c, 0x4851d93c, 0x4851d93c, 0x4851d93c, 0x485227c6, 0x485227c6, 0x485227c6, 0x485227c6, + 0x485227c6, 0x48527650, 0x48527650, 0x48527650, 0x48527650, 0x48527650, 0x4852c4db, 0x4852c4db, + 0x4852c4db, 0x4852c4db, 0x4852c4db, 0x48531365, 0x48531365, 0x48531365, 0x48531365, 0x48531365, + 0x485361ef, 0x485361ef, 0x485361ef, 0x485361ef, 0x485361ef, 0x4853b079, 0x4853b079, 0x4853b079, + 0x4853b079, 0x4853b079, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x48544d8e, + 0x48544d8e, 0x48544d8e, 0x48544d8e, 0x48544d8e, 0x48549c18, 0x48549c18, 0x48549c18, 0x48549c18, + 0x48549c18, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4855392c, 0x4855392c, + 0x4855392c, 0x4855392c, 0x4855392c, 0x485587b6, 0x485587b6, 0x485587b6, 0x485587b6, 0x485587b6, + 0x4855d641, 0x4855d641, 0x4855d641, 0x4855d641, 0x4855d641, 0x485624cb, 0x485624cb, 0x485624cb, + 0x485624cb, 0x485624cb, 0x48567355, 0x48567355, 0x48567355, 0x48567355, 0x48567355, 0x4856c1df, + 0x4856c1df, 0x4856c1df, 0x4856c1df, 0x4856c1df, 0x48571069, 0x48571069, 0x48571069, 0x48571069, + 0x48571069, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x4857ad7e, 0x4857ad7e, + 0x4857ad7e, 0x4857ad7e, 0x4857ad7e, 0x4857fc08, 0x4857fc08, 0x4857fc08, 0x4857fc08, 0x4857fc08, + 0x48584a92, 0x48584a92, 0x48584a92, 0x48584a92, 0x48584a92, 0x4858991c, 0x4858991c, 0x4858991c, + 0x4858991c, 0x4858991c, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x48593631, + 0x48593631, 0x48593631, 0x48593631, 0x48593631, 0x485984bb, 0x485984bb, 0x485984bb, 0x485984bb, + 0x485984bb, 0x4859d345, 0x4859d345, 0x4859d345, 0x4859d345, 0x4859d345, 0x485a21cf, 0x485a21cf, + 0x485a21cf, 0x485a21cf, 0x485a21cf, 0x485a7059, 0x485a7059, 0x485a7059, 0x485a7059, 0x485a7059, + 0x485abee4, 0x485abee4, 0x485abee4, 0x485abee4, 0x485abee4, 0x485b0d6e, 0x485b0d6e, 0x485b0d6e, + 0x485b0d6e, 0x485b0d6e, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485baa82, + 0x485baa82, 0x485baa82, 0x485baa82, 0x485baa82, 0x485bf90c, 0x485bf90c, 0x485bf90c, 0x485bf90c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, + 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, + 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, + 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, + 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, + 0x3f7ffecf, 0x3f7ffecf, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, + 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffe96, 0x3f7ffe96, + 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7ffe57, + 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, + 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, + 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, + 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, + 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, + 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, + 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffeeb, + 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, + 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, + 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, +] )) ), + +################ chunk 7168 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x485bf90c, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c9621, 0x485c9621, + 0x485c9621, 0x485c9621, 0x485c9621, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, + 0x485d3335, 0x485d3335, 0x485d3335, 0x485d3335, 0x485d3335, 0x485d81bf, 0x485d81bf, 0x485d81bf, + 0x485d81bf, 0x485d81bf, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485e1ed4, + 0x485e1ed4, 0x485e1ed4, 0x485e1ed4, 0x485e1ed4, 0x485e6d5e, 0x485e6d5e, 0x485e6d5e, 0x485e6d5e, + 0x485e6d5e, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485f0a72, 0x485f0a72, + 0x485f0a72, 0x485f0a72, 0x485f0a72, 0x485f58fc, 0x485f58fc, 0x485f58fc, 0x485f58fc, 0x485f58fc, + 0x485fa787, 0x485fa787, 0x485fa787, 0x485fa787, 0x485fa787, 0x485ff611, 0x485ff611, 0x485ff611, + 0x485ff611, 0x485ff611, 0x4860449b, 0x4860449b, 0x4860449b, 0x4860449b, 0x4860449b, 0x48609325, + 0x48609325, 0x48609325, 0x48609325, 0x48609325, 0x4860e1af, 0x4860e1af, 0x4860e1af, 0x4860e1af, + 0x4860e1af, 0x4861303a, 0x4861303a, 0x4861303a, 0x4861303a, 0x4861303a, 0x48617ec4, 0x48617ec4, + 0x48617ec4, 0x48617ec4, 0x48617ec4, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, + 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48626a62, 0x48626a62, 0x48626a62, + 0x48626a62, 0x48626a62, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x48630777, + 0x48630777, 0x48630777, 0x48630777, 0x48630777, 0x48635601, 0x48635601, 0x48635601, 0x48635601, + 0x48635601, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863f315, 0x4863f315, + 0x4863f315, 0x4863f315, 0x4863f315, 0x486441a0, 0x486441a0, 0x486441a0, 0x486441a0, 0x486441a0, + 0x4864902a, 0x4864902a, 0x4864902a, 0x4864902a, 0x4864902a, 0x4864deb4, 0x4864deb4, 0x4864deb4, + 0x4864deb4, 0x4864deb4, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48657bc8, + 0x48657bc8, 0x48657bc8, 0x48657bc8, 0x48657bc8, 0x4865ca53, 0x4865ca53, 0x4865ca53, 0x4865ca53, + 0x4865ca53, 0x486618dd, 0x486618dd, 0x486618dd, 0x486618dd, 0x486618dd, 0x48666767, 0x48666767, + 0x48666767, 0x48666767, 0x48666767, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, + 0x4867047b, 0x4867047b, 0x4867047b, 0x4867047b, 0x4867047b, 0x48675306, 0x48675306, 0x48675306, + 0x48675306, 0x48675306, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867f01a, + 0x4867f01a, 0x4867f01a, 0x4867f01a, 0x4867f01a, 0x48683ea4, 0x48683ea4, 0x48683ea4, 0x48683ea4, + 0x48683ea4, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x4868dbb8, 0x4868dbb8, + 0x4868dbb8, 0x4868dbb8, 0x4868dbb8, 0x48692a43, 0x48692a43, 0x48692a43, 0x48692a43, 0x48692a43, + 0x486978cd, 0x486978cd, 0x486978cd, 0x486978cd, 0x486978cd, 0x4869c757, 0x4869c757, 0x4869c757, + 0x4869c757, 0x4869c757, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a646b, + 0x486a646b, 0x486a646b, 0x486a646b, 0x486a646b, 0x486ab2f6, 0x486ab2f6, 0x486ab2f6, 0x486ab2f6, + 0x486ab2f6, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b500a, 0x486b500a, + 0x486b500a, 0x486b500a, 0x486b500a, 0x486b9e94, 0x486b9e94, 0x486b9e94, 0x486b9e94, 0x486b9e94, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffee9, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, + 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, + 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, + 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, + 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, + 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, + 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, + 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, + 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7fffb4, + 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, + 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, + 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, + 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, + 0x3f7ffe57, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, + 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, + 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, + 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, + 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, +] )) ), + +################ chunk 7680 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486c3ba9, 0x486c3ba9, 0x486c3ba9, + 0x486c3ba9, 0x486c3ba9, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486cd8bd, + 0x486cd8bd, 0x486cd8bd, 0x486cd8bd, 0x486cd8bd, 0x486d2747, 0x486d2747, 0x486d2747, 0x486d2747, + 0x486d2747, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486dc45c, 0x486dc45c, + 0x486dc45c, 0x486dc45c, 0x486dc45c, 0x486e12e6, 0x486e12e6, 0x486e12e6, 0x486e12e6, 0x486e12e6, + 0x486e6170, 0x486e6170, 0x486e6170, 0x486e6170, 0x486e6170, 0x486eaffa, 0x486eaffa, 0x486eaffa, + 0x486eaffa, 0x486eaffa, 0x486efe84, 0x486efe84, 0x486efe84, 0x486efe84, 0x486efe84, 0x486f4d0f, + 0x486f4d0f, 0x486f4d0f, 0x486f4d0f, 0x486f4d0f, 0x486f9b99, 0x486f9b99, 0x486f9b99, 0x486f9b99, + 0x486f9b99, 0x486fea23, 0x486fea23, 0x486fea23, 0x486fea23, 0x486fea23, 0x487038ad, 0x487038ad, + 0x487038ad, 0x487038ad, 0x487038ad, 0x48708737, 0x48708737, 0x48708737, 0x48708737, 0x48708737, + 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4871244c, 0x4871244c, 0x4871244c, + 0x4871244c, 0x4871244c, 0x487172d6, 0x487172d6, 0x487172d6, 0x487172d6, 0x487172d6, 0x4871c160, + 0x4871c160, 0x4871c160, 0x4871c160, 0x4871c160, 0x48720fea, 0x48720fea, 0x48720fea, 0x48720fea, + 0x48720fea, 0x48725e74, 0x48725e74, 0x48725e74, 0x48725e74, 0x48725e74, 0x4872acff, 0x4872acff, + 0x4872acff, 0x4872acff, 0x4872acff, 0x4872fb89, 0x4872fb89, 0x4872fb89, 0x4872fb89, 0x4872fb89, + 0x48734a13, 0x48734a13, 0x48734a13, 0x48734a13, 0x48734a13, 0x4873989d, 0x4873989d, 0x4873989d, + 0x4873989d, 0x4873989d, 0x4873e727, 0x4873e727, 0x4873e727, 0x4873e727, 0x4873e727, 0x487435b2, + 0x487435b2, 0x487435b2, 0x487435b2, 0x487435b2, 0x4874843c, 0x4874843c, 0x4874843c, 0x4874843c, + 0x4874843c, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x48752150, 0x48752150, + 0x48752150, 0x48752150, 0x48752150, 0x48756fda, 0x48756fda, 0x48756fda, 0x48756fda, 0x48756fda, + 0x4875be65, 0x4875be65, 0x4875be65, 0x4875be65, 0x4875be65, 0x48760cef, 0x48760cef, 0x48760cef, + 0x48760cef, 0x48760cef, 0x48765b79, 0x48765b79, 0x48765b79, 0x48765b79, 0x48765b79, 0x4876aa03, + 0x4876aa03, 0x4876aa03, 0x4876aa03, 0x4876aa03, 0x4876f88d, 0x4876f88d, 0x4876f88d, 0x4876f88d, + 0x4876f88d, 0x48774718, 0x48774718, 0x48774718, 0x48774718, 0x48774718, 0x487795a2, 0x487795a2, + 0x487795a2, 0x487795a2, 0x487795a2, 0x4877e42c, 0x4877e42c, 0x4877e42c, 0x4877e42c, 0x4877e42c, + 0x487832b6, 0x487832b6, 0x487832b6, 0x487832b6, 0x487832b6, 0x48788140, 0x48788140, 0x48788140, + 0x48788140, 0x48788140, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x48791e55, + 0x48791e55, 0x48791e55, 0x48791e55, 0x48791e55, 0x48796cdf, 0x48796cdf, 0x48796cdf, 0x48796cdf, + 0x48796cdf, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x487a09f3, 0x487a09f3, + 0x487a09f3, 0x487a09f3, 0x487a09f3, 0x487a587d, 0x487a587d, 0x487a587d, 0x487a587d, 0x487a587d, + 0x487aa708, 0x487aa708, 0x487aa708, 0x487aa708, 0x487aa708, 0x487af592, 0x487af592, 0x487af592, + 0x487af592, 0x487af592, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b92a6, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, + 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffe77, 0x3f7ffe77, + 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, + 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, + 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, + 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, + 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, + 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, + 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, + 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, + 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, + 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffed0, + 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb3, 0x3f7fffb3, + 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, + 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, + 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, + 0x3f7fff03, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7fff73, 0x3f7fff73, + 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, + 0x3f7fff33, 0x3f7fff33, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, + 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, + 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, + 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, +] )) ), + +################ chunk 8192 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x487b92a6, 0x487b92a6, 0x487b92a6, 0x487b92a6, 0x487be130, 0x487be130, 0x487be130, 0x487be130, + 0x487be130, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c7e45, 0x487c7e45, + 0x487c7e45, 0x487c7e45, 0x487c7e45, 0x487ccccf, 0x487ccccf, 0x487ccccf, 0x487ccccf, 0x487ccccf, + 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d69e3, 0x487d69e3, 0x487d69e3, + 0x487d69e3, 0x487d69e3, 0x487db86e, 0x487db86e, 0x487db86e, 0x487db86e, 0x487db86e, 0x487e06f8, + 0x487e06f8, 0x487e06f8, 0x487e06f8, 0x487e06f8, 0x487e5582, 0x487e5582, 0x487e5582, 0x487e5582, + 0x487e5582, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ef296, 0x487ef296, + 0x487ef296, 0x487ef296, 0x487ef296, 0x487f4121, 0x487f4121, 0x487f4121, 0x487f4121, 0x487f4121, + 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487fde35, 0x487fde35, 0x487fde35, + 0x487fde35, 0x487fde35, 0x48801660, 0x48801660, 0x48801660, 0x48801660, 0x48801660, 0x48803da5, + 0x48803da5, 0x48803da5, 0x48803da5, 0x48803da5, 0x488064ea, 0x488064ea, 0x488064ea, 0x488064ea, + 0x488064ea, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x4880b374, 0x4880b374, + 0x4880b374, 0x4880b374, 0x4880b374, 0x4880dab9, 0x4880dab9, 0x4880dab9, 0x4880dab9, 0x4880dab9, + 0x488101fe, 0x488101fe, 0x488101fe, 0x488101fe, 0x488101fe, 0x48812943, 0x48812943, 0x48812943, + 0x48812943, 0x48812943, 0x48815088, 0x48815088, 0x48815088, 0x48815088, 0x48815088, 0x488177cd, + 0x488177cd, 0x488177cd, 0x488177cd, 0x488177cd, 0x48819f13, 0x48819f13, 0x48819f13, 0x48819f13, + 0x48819f13, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881ed9d, 0x4881ed9d, + 0x4881ed9d, 0x4881ed9d, 0x4881ed9d, 0x488214e2, 0x488214e2, 0x488214e2, 0x488214e2, 0x488214e2, + 0x48823c27, 0x48823c27, 0x48823c27, 0x48823c27, 0x48823c27, 0x4882636c, 0x4882636c, 0x4882636c, + 0x4882636c, 0x4882636c, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x4882b1f6, + 0x4882b1f6, 0x4882b1f6, 0x4882b1f6, 0x4882b1f6, 0x4882d93b, 0x4882d93b, 0x4882d93b, 0x4882d93b, + 0x4882d93b, 0x48830080, 0x48830080, 0x48830080, 0x48830080, 0x48830080, 0x488327c6, 0x488327c6, + 0x488327c6, 0x488327c6, 0x488327c6, 0x48834f0b, 0x48834f0b, 0x48834f0b, 0x48834f0b, 0x48834f0b, + 0x48837650, 0x48837650, 0x48837650, 0x48837650, 0x48837650, 0x48839d95, 0x48839d95, 0x48839d95, + 0x48839d95, 0x48839d95, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883ec1f, + 0x4883ec1f, 0x4883ec1f, 0x4883ec1f, 0x4883ec1f, 0x48841364, 0x48841364, 0x48841364, 0x48841364, + 0x48841364, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x488461ee, 0x488461ee, + 0x488461ee, 0x488461ee, 0x488461ee, 0x48848933, 0x48848933, 0x48848933, 0x48848933, 0x48848933, + 0x4884b078, 0x4884b078, 0x4884b078, 0x4884b078, 0x4884b078, 0x4884d7be, 0x4884d7be, 0x4884d7be, + 0x4884d7be, 0x4884d7be, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x48852648, + 0x48852648, 0x48852648, 0x48852648, 0x48852648, 0x48854d8d, 0x48854d8d, 0x48854d8d, 0x48854d8d, + 0x48854d8d, 0x488574d2, 0x488574d2, 0x488574d2, 0x488574d2, 0x488574d2, 0x48859c17, 0x48859c17, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, + 0x3f7ffe75, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, + 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa6, + 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffee9, 0x3f7ffee9, + 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, + 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffc73, + 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, + 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, + 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ff9d7, + 0x3f7ff9d7, 0x3f7ff9d7, 0x3f7ff9d7, 0x3f7ff9d7, 0x3f7ff917, 0x3f7ff917, 0x3f7ff917, 0x3f7ff917, + 0x3f7ff917, 0x3f7ffba9, 0x3f7ffba9, 0x3f7ffba9, 0x3f7ffba9, 0x3f7ffba9, 0x3f7ffda3, 0x3f7ffda3, + 0x3f7ffda3, 0x3f7ffda3, 0x3f7ffda3, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, + 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffcfb, 0x3f7ffcfb, 0x3f7ffcfb, 0x3f7ffcfb, + 0x3f7ffcfb, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ff802, 0x3f7ff802, + 0x3f7ff802, 0x3f7ff802, 0x3f7ff802, 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffacc, + 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, + 0x3f7ffe96, 0x3f7ffe96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7ffda1, 0x3f7ffda1, + 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffba7, 0x3f7ffba7, 0x3f7ffba7, 0x3f7ffba7, 0x3f7ffba7, + 0x3f7ff914, 0x3f7ff914, 0x3f7ff914, 0x3f7ff914, 0x3f7ff914, 0x3f7ff9da, 0x3f7ff9da, 0x3f7ff9da, + 0x3f7ff9da, 0x3f7ff9da, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffe13, + 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, + 0x3f7fff4a, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7ffff0, 0x3f7ffff0, +] )) ), + +################ chunk 8704 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x48859c17, 0x48859c17, 0x48859c17, 0x4885c35c, 0x4885c35c, 0x4885c35c, 0x4885c35c, 0x4885c35c, + 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x488611e6, 0x488611e6, 0x488611e6, + 0x488611e6, 0x488611e6, 0x4886392b, 0x4886392b, 0x4886392b, 0x4886392b, 0x4886392b, 0x48866071, + 0x48866071, 0x48866071, 0x48866071, 0x48866071, 0x488687b6, 0x488687b6, 0x488687b6, 0x488687b6, + 0x488687b6, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886d640, 0x4886d640, + 0x4886d640, 0x4886d640, 0x4886d640, 0x4886fd85, 0x4886fd85, 0x4886fd85, 0x4886fd85, 0x4886fd85, + 0x488724ca, 0x488724ca, 0x488724ca, 0x488724ca, 0x488724ca, 0x48874c0f, 0x48874c0f, 0x48874c0f, + 0x48874c0f, 0x48874c0f, 0x48877354, 0x48877354, 0x48877354, 0x48877354, 0x48877354, 0x48879a99, + 0x48879a99, 0x48879a99, 0x48879a99, 0x48879a99, 0x4887c1de, 0x4887c1de, 0x4887c1de, 0x4887c1de, + 0x4887c1de, 0x4887e923, 0x4887e923, 0x4887e923, 0x4887e923, 0x4887e923, 0x48881069, 0x48881069, + 0x48881069, 0x48881069, 0x48881069, 0x488837ae, 0x488837ae, 0x488837ae, 0x488837ae, 0x488837ae, + 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48888638, 0x48888638, 0x48888638, + 0x48888638, 0x48888638, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888d4c2, + 0x4888d4c2, 0x4888d4c2, 0x4888d4c2, 0x4888d4c2, 0x4888fc07, 0x4888fc07, 0x4888fc07, 0x4888fc07, + 0x4888fc07, 0x4889234c, 0x4889234c, 0x4889234c, 0x4889234c, 0x4889234c, 0x48894a91, 0x48894a91, + 0x48894a91, 0x48894a91, 0x48894a91, 0x488971d6, 0x488971d6, 0x488971d6, 0x488971d6, 0x488971d6, + 0x4889991c, 0x4889991c, 0x4889991c, 0x4889991c, 0x4889991c, 0x4889c061, 0x4889c061, 0x4889c061, + 0x4889c061, 0x4889c061, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x488a0eeb, + 0x488a0eeb, 0x488a0eeb, 0x488a0eeb, 0x488a0eeb, 0x488a3630, 0x488a3630, 0x488a3630, 0x488a3630, + 0x488a3630, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a84ba, 0x488a84ba, + 0x488a84ba, 0x488a84ba, 0x488a84ba, 0x488aabff, 0x488aabff, 0x488aabff, 0x488aabff, 0x488aabff, + 0x488ad344, 0x488ad344, 0x488ad344, 0x488ad344, 0x488ad344, 0x488afa89, 0x488afa89, 0x488afa89, + 0x488afa89, 0x488afa89, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b4914, + 0x488b4914, 0x488b4914, 0x488b4914, 0x488b4914, 0x488b7059, 0x488b7059, 0x488b7059, 0x488b7059, + 0x488b7059, 0x488b979e, 0x488b979e, 0x488b979e, 0x488b979e, 0x488b979e, 0x488bbee3, 0x488bbee3, + 0x488bbee3, 0x488bbee3, 0x488bbee3, 0x488be628, 0x488be628, 0x488be628, 0x488be628, 0x488be628, + 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c34b2, 0x488c34b2, 0x488c34b2, + 0x488c34b2, 0x488c34b2, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c833c, + 0x488c833c, 0x488c833c, 0x488c833c, 0x488c833c, 0x488caa81, 0x488caa81, 0x488caa81, 0x488caa81, + 0x488caa81, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cf90c, 0x488cf90c, + 0x488cf90c, 0x488cf90c, 0x488cf90c, 0x488d2051, 0x488d2051, 0x488d2051, 0x488d2051, 0x488d2051, + 0x488d4796, 0x488d4796, 0x488d4796, 0x488d4796, 0x488d4796, 0x488d6edb, 0x488d6edb, 0x488d6edb, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, + 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffc71, 0x3f7ffc71, 0x3f7ffc71, + 0x3f7ffc71, 0x3f7ffc71, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ff8d4, + 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ffb74, 0x3f7ffb74, 0x3f7ffb74, 0x3f7ffb74, + 0x3f7ffb74, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffeeb, 0x3f7ffeeb, + 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffd26, + 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffb02, 0x3f7ffb02, 0x3f7ffb02, 0x3f7ffb02, + 0x3f7ffb02, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ffa91, 0x3f7ffa91, + 0x3f7ffa91, 0x3f7ffa91, 0x3f7ffa91, 0x3f7ffcd0, 0x3f7ffcd0, 0x3f7ffcd0, 0x3f7ffcd0, 0x3f7ffcd0, + 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, + 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd7, + 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, + 0x3f7fff1c, 0x3f7ffdc8, 0x3f7ffdc8, 0x3f7ffdc8, 0x3f7ffdc8, 0x3f7ffdc8, 0x3f7ffbdb, 0x3f7ffbdb, + 0x3f7ffbdb, 0x3f7ffbdb, 0x3f7ffbdb, 0x3f7ff956, 0x3f7ff956, 0x3f7ff956, 0x3f7ff956, 0x3f7ff956, + 0x3f7ff99a, 0x3f7ff99a, 0x3f7ff99a, 0x3f7ff99a, 0x3f7ff99a, 0x3f7ffc11, 0x3f7ffc11, 0x3f7ffc11, + 0x3f7ffc11, 0x3f7ffc11, 0x3f7ffdef, 0x3f7ffdef, 0x3f7ffdef, 0x3f7ffdef, 0x3f7ffdef, 0x3f7fff34, + 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, + 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, + 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, + 0x3f7ffca0, 0x3f7ffca0, 0x3f7ffca0, 0x3f7ffca0, 0x3f7ffca0, 0x3f7ffa52, 0x3f7ffa52, 0x3f7ffa52, + 0x3f7ffa52, 0x3f7ffa52, 0x3f7ff88f, 0x3f7ff88f, 0x3f7ff88f, 0x3f7ff88f, 0x3f7ff88f, 0x3f7ffb3d, + 0x3f7ffb3d, 0x3f7ffb3d, 0x3f7ffb3d, 0x3f7ffb3d, 0x3f7ffd53, 0x3f7ffd53, 0x3f7ffd53, 0x3f7ffd53, + 0x3f7ffd53, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, + 0x3f7ffece, 0x3f7ffece, 0x3f7ffd50, 0x3f7ffd50, 0x3f7ffd50, 0x3f7ffd50, 0x3f7ffd50, 0x3f7ffb3a, + 0x3f7ffb3a, 0x3f7ffb3a, 0x3f7ffb3a, 0x3f7ffb3a, 0x3f7ff88b, 0x3f7ff88b, 0x3f7ff88b, 0x3f7ff88b, + 0x3f7ff88b, 0x3f7ffa55, 0x3f7ffa55, 0x3f7ffa55, 0x3f7ffa55, 0x3f7ffa55, 0x3f7ffca2, 0x3f7ffca2, + 0x3f7ffca2, 0x3f7ffca2, 0x3f7ffca2, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, + 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, +] )) ), + +################ chunk 9216 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x488d6edb, 0x488d6edb, 0x488d9620, 0x488d9620, 0x488d9620, 0x488d9620, 0x488d9620, 0x488dbd65, + 0x488dbd65, 0x488dbd65, 0x488dbd65, 0x488dbd65, 0x488de4aa, 0x488de4aa, 0x488de4aa, 0x488de4aa, + 0x488de4aa, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e3334, 0x488e3334, + 0x488e3334, 0x488e3334, 0x488e3334, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, + 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488ea904, 0x488ea904, 0x488ea904, + 0x488ea904, 0x488ea904, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ef78e, + 0x488ef78e, 0x488ef78e, 0x488ef78e, 0x488ef78e, 0x488f1ed3, 0x488f1ed3, 0x488f1ed3, 0x488f1ed3, + 0x488f1ed3, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f6d5d, 0x488f6d5d, + 0x488f6d5d, 0x488f6d5d, 0x488f6d5d, 0x488f94a2, 0x488f94a2, 0x488f94a2, 0x488f94a2, 0x488f94a2, + 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fe32d, 0x488fe32d, 0x488fe32d, + 0x488fe32d, 0x488fe32d, 0x48900a72, 0x48900a72, 0x48900a72, 0x48900a72, 0x48900a72, 0x489031b7, + 0x489031b7, 0x489031b7, 0x489031b7, 0x489031b7, 0x489058fc, 0x489058fc, 0x489058fc, 0x489058fc, + 0x489058fc, 0x48908041, 0x48908041, 0x48908041, 0x48908041, 0x48908041, 0x4890a786, 0x4890a786, + 0x4890a786, 0x4890a786, 0x4890a786, 0x4890cecb, 0x4890cecb, 0x4890cecb, 0x4890cecb, 0x4890cecb, + 0x4890f610, 0x4890f610, 0x4890f610, 0x4890f610, 0x4890f610, 0x48911d55, 0x48911d55, 0x48911d55, + 0x48911d55, 0x48911d55, 0x4891449a, 0x4891449a, 0x4891449a, 0x4891449a, 0x4891449a, 0x48916bdf, + 0x48916bdf, 0x48916bdf, 0x48916bdf, 0x48916bdf, 0x48919325, 0x48919325, 0x48919325, 0x48919325, + 0x48919325, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891e1af, 0x4891e1af, + 0x4891e1af, 0x4891e1af, 0x4891e1af, 0x489208f4, 0x489208f4, 0x489208f4, 0x489208f4, 0x489208f4, + 0x48923039, 0x48923039, 0x48923039, 0x48923039, 0x48923039, 0x4892577e, 0x4892577e, 0x4892577e, + 0x4892577e, 0x4892577e, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x4892a608, + 0x4892a608, 0x4892a608, 0x4892a608, 0x4892a608, 0x4892cd4d, 0x4892cd4d, 0x4892cd4d, 0x4892cd4d, + 0x4892cd4d, 0x4892f492, 0x4892f492, 0x4892f492, 0x4892f492, 0x4892f492, 0x48931bd8, 0x48931bd8, + 0x48931bd8, 0x48931bd8, 0x48931bd8, 0x4893431d, 0x4893431d, 0x4893431d, 0x4893431d, 0x4893431d, + 0x48936a62, 0x48936a62, 0x48936a62, 0x48936a62, 0x48936a62, 0x489391a7, 0x489391a7, 0x489391a7, + 0x489391a7, 0x489391a7, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893e031, + 0x4893e031, 0x4893e031, 0x4893e031, 0x4893e031, 0x48940776, 0x48940776, 0x48940776, 0x48940776, + 0x48940776, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48945600, 0x48945600, + 0x48945600, 0x48945600, 0x48945600, 0x48947d45, 0x48947d45, 0x48947d45, 0x48947d45, 0x48947d45, + 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894cbd0, 0x4894cbd0, 0x4894cbd0, + 0x4894cbd0, 0x4894cbd0, 0x4894f315, 0x4894f315, 0x4894f315, 0x4894f315, 0x4894f315, 0x48951a5a, + 0x48951a5a, 0x48951a5a, 0x48951a5a, 0x48951a5a, 0x4895419f, 0x4895419f, 0x4895419f, 0x4895419f, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, + 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffded, 0x3f7ffded, 0x3f7ffded, 0x3f7ffded, + 0x3f7ffded, 0x3f7ffc0e, 0x3f7ffc0e, 0x3f7ffc0e, 0x3f7ffc0e, 0x3f7ffc0e, 0x3f7ff997, 0x3f7ff997, + 0x3f7ff997, 0x3f7ff997, 0x3f7ff997, 0x3f7ff959, 0x3f7ff959, 0x3f7ff959, 0x3f7ff959, 0x3f7ff959, + 0x3f7ffbde, 0x3f7ffbde, 0x3f7ffbde, 0x3f7ffbde, 0x3f7ffbde, 0x3f7ffdca, 0x3f7ffdca, 0x3f7ffdca, + 0x3f7ffdca, 0x3f7ffdca, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, + 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, 0x3f7ffe75, + 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffcce, 0x3f7ffcce, 0x3f7ffcce, 0x3f7ffcce, 0x3f7ffcce, + 0x3f7ffa8e, 0x3f7ffa8e, 0x3f7ffa8e, 0x3f7ffa8e, 0x3f7ffa8e, 0x3f7ff849, 0x3f7ff849, 0x3f7ff849, + 0x3f7ff849, 0x3f7ff849, 0x3f7ffb05, 0x3f7ffb05, 0x3f7ffb05, 0x3f7ffb05, 0x3f7ffb05, 0x3f7ffd29, + 0x3f7ffd29, 0x3f7ffd29, 0x3f7ffd29, 0x3f7ffd29, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, + 0x3f7ffeb3, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffd79, 0x3f7ffd79, 0x3f7ffd79, + 0x3f7ffd79, 0x3f7ffd79, 0x3f7ffb71, 0x3f7ffb71, 0x3f7ffb71, 0x3f7ffb71, 0x3f7ffb71, 0x3f7ff8d0, + 0x3f7ff8d0, 0x3f7ff8d0, 0x3f7ff8d0, 0x3f7ff8d0, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, + 0x3f7ffa18, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffe35, 0x3f7ffe35, + 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, + 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, + 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, + 0x3f7ffc40, 0x3f7ff9d6, 0x3f7ff9d6, 0x3f7ff9d6, 0x3f7ff9d6, 0x3f7ff9d6, 0x3f7ff917, 0x3f7ff917, + 0x3f7ff917, 0x3f7ff917, 0x3f7ff917, 0x3f7ffbaa, 0x3f7ffbaa, 0x3f7ffbaa, 0x3f7ffbaa, 0x3f7ffbaa, + 0x3f7ffda3, 0x3f7ffda3, 0x3f7ffda3, 0x3f7ffda3, 0x3f7ffda3, 0x3f7fff05, 0x3f7fff05, 0x3f7fff05, + 0x3f7fff05, 0x3f7fff05, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, + 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffcfb, 0x3f7ffcfb, + 0x3f7ffcfb, 0x3f7ffcfb, 0x3f7ffcfb, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, + 0x3f7ff802, 0x3f7ff802, 0x3f7ff802, 0x3f7ff802, 0x3f7ff802, 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffacc, + 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffe96, + 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, +] )) ), + +################ chunk 9728 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4895419f, 0x489568e4, 0x489568e4, 0x489568e4, 0x489568e4, 0x489568e4, 0x48959029, 0x48959029, + 0x48959029, 0x48959029, 0x48959029, 0x4895b76e, 0x4895b76e, 0x4895b76e, 0x4895b76e, 0x4895b76e, + 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x489605f8, 0x489605f8, 0x489605f8, + 0x489605f8, 0x489605f8, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48965483, + 0x48965483, 0x48965483, 0x48965483, 0x48965483, 0x48967bc8, 0x48967bc8, 0x48967bc8, 0x48967bc8, + 0x48967bc8, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896ca52, 0x4896ca52, + 0x4896ca52, 0x4896ca52, 0x4896ca52, 0x4896f197, 0x4896f197, 0x4896f197, 0x4896f197, 0x4896f197, + 0x489718dc, 0x489718dc, 0x489718dc, 0x489718dc, 0x489718dc, 0x48974021, 0x48974021, 0x48974021, + 0x48974021, 0x48974021, 0x48976766, 0x48976766, 0x48976766, 0x48976766, 0x48976766, 0x48978eab, + 0x48978eab, 0x48978eab, 0x48978eab, 0x48978eab, 0x4897b5f0, 0x4897b5f0, 0x4897b5f0, 0x4897b5f0, + 0x4897b5f0, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4898047b, 0x4898047b, + 0x4898047b, 0x4898047b, 0x4898047b, 0x48982bc0, 0x48982bc0, 0x48982bc0, 0x48982bc0, 0x48982bc0, + 0x48985305, 0x48985305, 0x48985305, 0x48985305, 0x48985305, 0x48987a4a, 0x48987a4a, 0x48987a4a, + 0x48987a4a, 0x48987a4a, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898c8d4, + 0x4898c8d4, 0x4898c8d4, 0x4898c8d4, 0x4898c8d4, 0x4898f019, 0x4898f019, 0x4898f019, 0x4898f019, + 0x4898f019, 0x4899175e, 0x4899175e, 0x4899175e, 0x4899175e, 0x4899175e, 0x48993ea3, 0x48993ea3, + 0x48993ea3, 0x48993ea3, 0x48993ea3, 0x489965e8, 0x489965e8, 0x489965e8, 0x489965e8, 0x489965e8, + 0x431d1463, 0x431d1463, 0x431d1463, 0x431d1463, 0x431d1463, 0x43ba23ad, 0x43ba23ad, 0x43ba23ad, + 0x43ba23ad, 0x43ba23ad, 0x4412de95, 0x4412de95, 0x4412de95, 0x4412de95, 0x4412de95, 0x4448ab53, + 0x4448ab53, 0x4448ab53, 0x4448ab53, 0x4448ab53, 0x447e7811, 0x447e7811, 0x447e7811, 0x447e7811, + 0x447e7811, 0x449a2267, 0x449a2267, 0x449a2267, 0x449a2267, 0x449a2267, 0x44b508c6, 0x44b508c6, + 0x44b508c6, 0x44b508c6, 0x44b508c6, 0x44cfef25, 0x44cfef25, 0x44cfef25, 0x44cfef25, 0x44cfef25, + 0x44ead584, 0x44ead584, 0x44ead584, 0x44ead584, 0x44ead584, 0x4502ddf2, 0x4502ddf2, 0x4502ddf2, + 0x4502ddf2, 0x4502ddf2, 0x45105121, 0x45105121, 0x45105121, 0x45105121, 0x45105121, 0x451dc451, + 0x451dc451, 0x451dc451, 0x451dc451, 0x451dc451, 0x452b3780, 0x452b3780, 0x452b3780, 0x452b3780, + 0x452b3780, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x45461ddf, 0x45461ddf, + 0x45461ddf, 0x45461ddf, 0x45461ddf, 0x4553910f, 0x4553910f, 0x4553910f, 0x4553910f, 0x4553910f, + 0x4561043e, 0x4561043e, 0x4561043e, 0x4561043e, 0x4561043e, 0x456e776e, 0x456e776e, 0x456e776e, + 0x456e776e, 0x456e776e, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x4584aee6, + 0x4584aee6, 0x4584aee6, 0x4584aee6, 0x4584aee6, 0x458b687e, 0x458b687e, 0x458b687e, 0x458b687e, + 0x458b687e, 0x45922216, 0x45922216, 0x45922216, 0x45922216, 0x45922216, 0x4598dbae, 0x4598dbae, + 0x4598dbae, 0x4598dbae, 0x4598dbae, 0x459f9545, 0x459f9545, 0x459f9545, 0x459f9545, 0x459f9545, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, + 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, + 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffba7, 0x3f7ffba7, 0x3f7ffba7, + 0x3f7ffba7, 0x3f7ffba7, 0x3f7ff913, 0x3f7ff913, 0x3f7ff913, 0x3f7ff913, 0x3f7ff913, 0x3f7ff9da, + 0x3f7ff9da, 0x3f7ff9da, 0x3f7ff9da, 0x3f7ff9da, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, + 0x3f7ffc43, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, 0x3f7fff4a, + 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, + 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe33, 0x3f7ffe33, 0x3f7ffe33, 0x3f7ffe33, 0x3f7ffe33, 0x3f7ffc70, + 0x3f7ffc70, 0x3f7ffc70, 0x3f7ffc70, 0x3f7ffc70, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, + 0x3f7ffa15, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ffb74, 0x3f7ffb74, + 0x3f7ffb74, 0x3f7ffb74, 0x3f7ffb74, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, + 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, + 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, + 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, + 0x3f7ffeb2, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffb02, 0x3f7ffb02, + 0x3f7ffb02, 0x3f7ffb02, 0x3f7ffb02, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x375031dc, 0x375031dc, 0x375031dc, + 0x375031dc, 0x375031dc, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x37965f50, + 0x37965f50, 0x37965f50, 0x37965f50, 0x37965f50, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x38359439, 0x38359439, 0x38359439, 0x38359439, 0x38359439, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xb836581a, 0xb836581a, 0xb836581a, 0xb836581a, 0xb836581a, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb8a47202, 0xb8a47202, 0xb8a47202, + 0xb8a47202, 0xb8a47202, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x38a41012, + 0x38a41012, 0x38a41012, 0x38a41012, 0x38a41012, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb8a3ae21, 0xb8a3ae21, 0xb8a3ae21, 0xb8a3ae21, 0xb8a3ae21, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x38a34c31, 0x38a34c31, 0x38a34c31, 0x38a34c31, 0x38a34c31, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb8a2ea40, 0xb8a2ea40, 0xb8a2ea40, + 0xb8a2ea40, 0xb8a2ea40, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb92ebbd8, + 0xb92ebbd8, 0xb92ebbd8, 0xb92ebbd8, 0xb92ebbd8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb8a2265f, 0xb8a2265f, 0xb8a2265f, 0xb8a2265f, 0xb8a2265f, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xb92f1dc9, 0xb92f1dc9, 0xb92f1dc9, 0xb92f1dc9, 0xb92f1dc9, +] )) ), + +################ chunk 10240 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45ad0875, 0x45ad0875, 0x45ad0875, + 0x45ad0875, 0x45ad0875, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45ba7ba4, + 0x45ba7ba4, 0x45ba7ba4, 0x45ba7ba4, 0x45ba7ba4, 0x45c1353c, 0x45c1353c, 0x45c1353c, 0x45c1353c, + 0x45c1353c, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45cea86c, 0x45cea86c, + 0x45cea86c, 0x45cea86c, 0x45cea86c, 0x45d56203, 0x45d56203, 0x45d56203, 0x45d56203, 0x45d56203, + 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45e2d533, 0x45e2d533, 0x45e2d533, + 0x45e2d533, 0x45e2d533, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45f04862, + 0x45f04862, 0x45f04862, 0x45f04862, 0x45f04862, 0x45f701fa, 0x45f701fa, 0x45f701fa, 0x45f701fa, + 0x45f701fa, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x46023a95, 0x46023a95, + 0x46023a95, 0x46023a95, 0x46023a95, 0x46059761, 0x46059761, 0x46059761, 0x46059761, 0x46059761, + 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x460c50f8, 0x460c50f8, 0x460c50f8, + 0x460c50f8, 0x460c50f8, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x46130a90, + 0x46130a90, 0x46130a90, 0x46130a90, 0x46130a90, 0x4616675c, 0x4616675c, 0x4616675c, 0x4616675c, + 0x4616675c, 0x4619c428, 0x4619c428, 0x4619c428, 0x4619c428, 0x4619c428, 0x461d20f4, 0x461d20f4, + 0x461d20f4, 0x461d20f4, 0x461d20f4, 0x46207dc0, 0x46207dc0, 0x46207dc0, 0x46207dc0, 0x46207dc0, + 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x46273757, 0x46273757, 0x46273757, + 0x46273757, 0x46273757, 0x462a9423, 0x462a9423, 0x462a9423, 0x462a9423, 0x462a9423, 0x462df0ef, + 0x462df0ef, 0x462df0ef, 0x462df0ef, 0x462df0ef, 0x46314dbb, 0x46314dbb, 0x46314dbb, 0x46314dbb, + 0x46314dbb, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x46380753, 0x46380753, + 0x46380753, 0x46380753, 0x46380753, 0x463b641f, 0x463b641f, 0x463b641f, 0x463b641f, 0x463b641f, + 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x46421db6, 0x46421db6, 0x46421db6, + 0x46421db6, 0x46421db6, 0x46457a82, 0x46457a82, 0x46457a82, 0x46457a82, 0x46457a82, 0x4648d74e, + 0x4648d74e, 0x4648d74e, 0x4648d74e, 0x4648d74e, 0x464c341a, 0x464c341a, 0x464c341a, 0x464c341a, + 0x464c341a, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x4652edb2, 0x4652edb2, + 0x4652edb2, 0x4652edb2, 0x4652edb2, 0x46564a7e, 0x46564a7e, 0x46564a7e, 0x46564a7e, 0x46564a7e, + 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x465d0415, 0x465d0415, 0x465d0415, + 0x465d0415, 0x465d0415, 0x466060e1, 0x466060e1, 0x466060e1, 0x466060e1, 0x466060e1, 0x4663bdad, + 0x4663bdad, 0x4663bdad, 0x4663bdad, 0x4663bdad, 0x46671a79, 0x46671a79, 0x46671a79, 0x46671a79, + 0x46671a79, 0x466a7745, 0x466a7745, 0x466a7745, 0x466a7745, 0x466a7745, 0x466dd411, 0x466dd411, + 0x466dd411, 0x466dd411, 0x466dd411, 0x467130dd, 0x467130dd, 0x467130dd, 0x467130dd, 0x467130dd, + 0x46748da9, 0x46748da9, 0x46748da9, 0x46748da9, 0x46748da9, 0x4677ea74, 0x4677ea74, 0x4677ea74, + 0x4677ea74, 0x4677ea74, 0x467b4740, 0x467b4740, 0x467b4740, 0x467b4740, 0x467b4740, 0x467ea40c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb8a1627e, 0xb8a1627e, 0xb8a1627e, + 0xb8a1627e, 0xb8a1627e, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb92f7fb9, + 0xb92f7fb9, 0xb92f7fb9, 0xb92f7fb9, 0xb92f7fb9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb8a09e9d, 0xb8a09e9d, 0xb8a09e9d, 0xb8a09e9d, 0xb8a09e9d, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xb92fe1aa, 0xb92fe1aa, 0xb92fe1aa, 0xb92fe1aa, 0xb92fe1aa, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb89fdabc, 0xb89fdabc, 0xb89fdabc, + 0xb89fdabc, 0xb89fdabc, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb930439a, + 0xb930439a, 0xb930439a, 0xb930439a, 0xb930439a, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb89f16db, 0xb89f16db, 0xb89f16db, 0xb89f16db, 0xb89f16db, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a7ad3a, 0x39a7ad3a, 0x39a7ad3a, 0x39a7ad3a, 0x39a7ad3a, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d86b41, 0x39d86b41, 0x39d86b41, + 0x39d86b41, 0x39d86b41, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb931077b, + 0xb931077b, 0xb931077b, 0xb931077b, 0xb931077b, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb89d8f19, 0xb89d8f19, 0xb89d8f19, 0xb89d8f19, 0xb89d8f19, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a74b4a, 0x39a74b4a, 0x39a74b4a, 0x39a74b4a, 0x39a74b4a, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d8cd32, 0x39d8cd32, 0x39d8cd32, + 0x39d8cd32, 0x39d8cd32, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb931cb5c, + 0xb931cb5c, 0xb931cb5c, 0xb931cb5c, 0xb931cb5c, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb89c0757, 0xb89c0757, 0xb89c0757, 0xb89c0757, 0xb89c0757, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a6e959, 0x39a6e959, 0x39a6e959, 0x39a6e959, 0x39a6e959, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d92f22, 0x39d92f22, 0x39d92f22, + 0x39d92f22, 0x39d92f22, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9328f3d, + 0xb9328f3d, 0xb9328f3d, 0xb9328f3d, 0xb9328f3d, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb89a7f95, 0xb89a7f95, 0xb89a7f95, 0xb89a7f95, 0xb89a7f95, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a68769, 0x39a68769, 0x39a68769, 0x39a68769, 0x39a68769, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d99113, 0x39d99113, 0x39d99113, + 0x39d99113, 0x39d99113, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb933531e, + 0xb933531e, 0xb933531e, 0xb933531e, 0xb933531e, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb898f7d2, 0xb898f7d2, 0xb898f7d2, 0xb898f7d2, 0xb898f7d2, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a62578, 0x39a62578, 0x39a62578, 0x39a62578, 0x39a62578, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d9f303, 0x39d9f303, 0x39d9f303, + 0x39d9f303, 0x39d9f303, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9341700, +] )) ), + +################ chunk 10752 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x467ea40c, 0x467ea40c, 0x467ea40c, 0x467ea40c, 0x4681006c, 0x4681006c, 0x4681006c, 0x4681006c, + 0x4681006c, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x46845d38, 0x46845d38, + 0x46845d38, 0x46845d38, 0x46845d38, 0x46860b9e, 0x46860b9e, 0x46860b9e, 0x46860b9e, 0x46860b9e, + 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4689686a, 0x4689686a, 0x4689686a, + 0x4689686a, 0x4689686a, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468cc536, + 0x468cc536, 0x468cc536, 0x468cc536, 0x468cc536, 0x468e739c, 0x468e739c, 0x468e739c, 0x468e739c, + 0x468e739c, 0x46902201, 0x46902201, 0x46902201, 0x46902201, 0x46902201, 0x4691d067, 0x4691d067, + 0x4691d067, 0x4691d067, 0x4691d067, 0x46937ecd, 0x46937ecd, 0x46937ecd, 0x46937ecd, 0x46937ecd, + 0x46952d33, 0x46952d33, 0x46952d33, 0x46952d33, 0x46952d33, 0x4696db99, 0x4696db99, 0x4696db99, + 0x4696db99, 0x4696db99, 0x469889ff, 0x469889ff, 0x469889ff, 0x469889ff, 0x469889ff, 0x469a3865, + 0x469a3865, 0x469a3865, 0x469a3865, 0x469a3865, 0x469be6cb, 0x469be6cb, 0x469be6cb, 0x469be6cb, + 0x469be6cb, 0x469d9531, 0x469d9531, 0x469d9531, 0x469d9531, 0x469d9531, 0x469f4397, 0x469f4397, + 0x469f4397, 0x469f4397, 0x469f4397, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, + 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a44ec9, 0x46a44ec9, 0x46a44ec9, + 0x46a44ec9, 0x46a44ec9, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a7ab95, + 0x46a7ab95, 0x46a7ab95, 0x46a7ab95, 0x46a7ab95, 0x46a959fb, 0x46a959fb, 0x46a959fb, 0x46a959fb, + 0x46a959fb, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46acb6c6, 0x46acb6c6, + 0x46acb6c6, 0x46acb6c6, 0x46acb6c6, 0x46ae652c, 0x46ae652c, 0x46ae652c, 0x46ae652c, 0x46ae652c, + 0x46b01392, 0x46b01392, 0x46b01392, 0x46b01392, 0x46b01392, 0x46b1c1f8, 0x46b1c1f8, 0x46b1c1f8, + 0x46b1c1f8, 0x46b1c1f8, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b51ec4, + 0x46b51ec4, 0x46b51ec4, 0x46b51ec4, 0x46b51ec4, 0x46b6cd2a, 0x46b6cd2a, 0x46b6cd2a, 0x46b6cd2a, + 0x46b6cd2a, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46ba29f6, 0x46ba29f6, + 0x46ba29f6, 0x46ba29f6, 0x46ba29f6, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, + 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bf3528, 0x46bf3528, 0x46bf3528, + 0x46bf3528, 0x46bf3528, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c291f4, + 0x46c291f4, 0x46c291f4, 0x46c291f4, 0x46c291f4, 0x46c4405a, 0x46c4405a, 0x46c4405a, 0x46c4405a, + 0x46c4405a, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c79d25, 0x46c79d25, + 0x46c79d25, 0x46c79d25, 0x46c79d25, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, + 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46cca857, 0x46cca857, 0x46cca857, + 0x46cca857, 0x46cca857, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46d00523, + 0x46d00523, 0x46d00523, 0x46d00523, 0x46d00523, 0x46d1b389, 0x46d1b389, 0x46d1b389, 0x46d1b389, + 0x46d1b389, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d51055, 0x46d51055, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xb9341700, 0xb9341700, 0xb9341700, 0xb9341700, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb8977010, 0xb8977010, 0xb8977010, 0xb8977010, 0xb8977010, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a5c388, 0x39a5c388, 0x39a5c388, 0x39a5c388, 0x39a5c388, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba12d585, 0xba12d585, 0xba12d585, + 0xba12d585, 0xba12d585, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a52c946, + 0x3a52c946, 0x3a52c946, 0x3a52c946, 0x3a52c946, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3a6d42f4, 0x3a6d42f4, 0x3a6d42f4, 0x3a6d42f4, 0x3a6d42f4, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2d4f33, 0xba2d4f33, 0xba2d4f33, 0xba2d4f33, 0xba2d4f33, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39dab6e4, 0x39dab6e4, 0x39dab6e4, + 0x39dab6e4, 0x39dab6e4, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9359ec2, + 0xb9359ec2, 0xb9359ec2, 0xb9359ec2, 0xb9359ec2, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb894608c, 0xb894608c, 0xb894608c, 0xb894608c, 0xb894608c, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a4ffa7, 0x39a4ffa7, 0x39a4ffa7, 0x39a4ffa7, 0x39a4ffa7, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba127395, 0xba127395, 0xba127395, + 0xba127395, 0xba127395, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a526756, + 0x3a526756, 0x3a526756, 0x3a526756, 0x3a526756, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3a6da4e5, 0x3a6da4e5, 0x3a6da4e5, 0x3a6da4e5, 0x3a6da4e5, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2db124, 0xba2db124, 0xba2db124, 0xba2db124, 0xba2db124, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39db7ac5, 0x39db7ac5, 0x39db7ac5, + 0x39db7ac5, 0x39db7ac5, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9372684, + 0xb9372684, 0xb9372684, 0xb9372684, 0xb9372684, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb8915108, 0xb8915108, 0xb8915108, 0xb8915108, 0xb8915108, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a43bc6, 0x39a43bc6, 0x39a43bc6, 0x39a43bc6, 0x39a43bc6, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba1211a4, 0xba1211a4, 0xba1211a4, + 0xba1211a4, 0xba1211a4, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a520565, + 0x3a520565, 0x3a520565, 0x3a520565, 0x3a520565, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3a6e06d5, 0x3a6e06d5, 0x3a6e06d5, 0x3a6e06d5, 0x3a6e06d5, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2e1315, 0xba2e1315, 0xba2e1315, 0xba2e1315, 0xba2e1315, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39dc3ea6, 0x39dc3ea6, 0x39dc3ea6, + 0x39dc3ea6, 0x39dc3ea6, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb938ae46, + 0xb938ae46, 0xb938ae46, 0xb938ae46, 0xb938ae46, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb88e4184, 0xb88e4184, 0xb88e4184, 0xb88e4184, 0xb88e4184, 0xbf800000, 0xbf800000, +] )) ), + +################ chunk 11264 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x46d51055, 0x46d51055, 0x46d51055, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, + 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46da1b87, 0x46da1b87, 0x46da1b87, + 0x46da1b87, 0x46da1b87, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dd7853, + 0x46dd7853, 0x46dd7853, 0x46dd7853, 0x46dd7853, 0x46df26b9, 0x46df26b9, 0x46df26b9, 0x46df26b9, + 0x46df26b9, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e28384, 0x46e28384, + 0x46e28384, 0x46e28384, 0x46e28384, 0x46e431ea, 0x46e431ea, 0x46e431ea, 0x46e431ea, 0x46e431ea, + 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e78eb6, 0x46e78eb6, 0x46e78eb6, + 0x46e78eb6, 0x46e78eb6, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46eaeb82, + 0x46eaeb82, 0x46eaeb82, 0x46eaeb82, 0x46eaeb82, 0x46ec99e8, 0x46ec99e8, 0x46ec99e8, 0x46ec99e8, + 0x46ec99e8, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46eff6b4, 0x46eff6b4, + 0x46eff6b4, 0x46eff6b4, 0x46eff6b4, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, + 0x46f35380, 0x46f35380, 0x46f35380, 0x46f35380, 0x46f35380, 0x46f501e6, 0x46f501e6, 0x46f501e6, + 0x46f501e6, 0x46f501e6, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f85eb2, + 0x46f85eb2, 0x46f85eb2, 0x46f85eb2, 0x46f85eb2, 0x46fa0d18, 0x46fa0d18, 0x46fa0d18, 0x46fa0d18, + 0x46fa0d18, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fd69e3, 0x46fd69e3, + 0x46fd69e3, 0x46fd69e3, 0x46fd69e3, 0x46ff1849, 0x46ff1849, 0x46ff1849, 0x46ff1849, 0x46ff1849, + 0x47006358, 0x47006358, 0x47006358, 0x47006358, 0x47006358, 0x47013a8b, 0x47013a8b, 0x47013a8b, + 0x47013a8b, 0x47013a8b, 0x470211be, 0x470211be, 0x470211be, 0x470211be, 0x470211be, 0x4702e8f1, + 0x4702e8f1, 0x4702e8f1, 0x4702e8f1, 0x4702e8f1, 0x4703c024, 0x4703c024, 0x4703c024, 0x4703c024, + 0x4703c024, 0x47049756, 0x47049756, 0x47049756, 0x47049756, 0x47049756, 0x47056e89, 0x47056e89, + 0x47056e89, 0x47056e89, 0x47056e89, 0x470645bc, 0x470645bc, 0x470645bc, 0x470645bc, 0x470645bc, + 0x47071cef, 0x47071cef, 0x47071cef, 0x47071cef, 0x47071cef, 0x4707f422, 0x4707f422, 0x4707f422, + 0x4707f422, 0x4707f422, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4709a288, + 0x4709a288, 0x4709a288, 0x4709a288, 0x4709a288, 0x470a79bb, 0x470a79bb, 0x470a79bb, 0x470a79bb, + 0x470a79bb, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470c2821, 0x470c2821, + 0x470c2821, 0x470c2821, 0x470c2821, 0x470cff54, 0x470cff54, 0x470cff54, 0x470cff54, 0x470cff54, + 0x470dd687, 0x470dd687, 0x470dd687, 0x470dd687, 0x470dd687, 0x470eadba, 0x470eadba, 0x470eadba, + 0x470eadba, 0x470eadba, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x47105c20, + 0x47105c20, 0x47105c20, 0x47105c20, 0x47105c20, 0x47113353, 0x47113353, 0x47113353, 0x47113353, + 0x47113353, 0x47120a86, 0x47120a86, 0x47120a86, 0x47120a86, 0x47120a86, 0x4712e1b9, 0x4712e1b9, + 0x4712e1b9, 0x4712e1b9, 0x4712e1b9, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, + 0x4714901f, 0x4714901f, 0x4714901f, 0x4714901f, 0x4714901f, 0x47156752, 0x47156752, 0x47156752, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a377e5, 0x39a377e5, 0x39a377e5, 0x39a377e5, 0x39a377e5, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba11afb4, 0xba11afb4, 0xba11afb4, + 0xba11afb4, 0xba11afb4, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a51a375, + 0x3a51a375, 0x3a51a375, 0x3a51a375, 0x3a51a375, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3a6e68c6, 0x3a6e68c6, 0x3a6e68c6, 0x3a6e68c6, 0x3a6e68c6, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2e7505, 0xba2e7505, 0xba2e7505, 0xba2e7505, 0xba2e7505, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39dd0287, 0x39dd0287, 0x39dd0287, + 0x39dd0287, 0x39dd0287, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb93a3608, + 0xb93a3608, 0xb93a3608, 0xb93a3608, 0xb93a3608, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb88b31ff, 0xb88b31ff, 0xb88b31ff, 0xb88b31ff, 0xb88b31ff, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a2b404, 0x39a2b404, 0x39a2b404, 0x39a2b404, 0x39a2b404, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba114dc3, 0xba114dc3, 0xba114dc3, + 0xba114dc3, 0xba114dc3, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a514184, + 0x3a514184, 0x3a514184, 0x3a514184, 0x3a514184, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3a6ecab6, 0x3a6ecab6, 0x3a6ecab6, 0x3a6ecab6, 0x3a6ecab6, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2ed6f6, 0xba2ed6f6, 0xba2ed6f6, 0xba2ed6f6, 0xba2ed6f6, + 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0xbac88e61, 0xbac88e61, 0xbac88e61, + 0xbac88e61, 0xbac88e61, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae8883f, + 0x3ae8883f, 0x3ae8883f, 0x3ae8883f, 0x3ae8883f, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, + 0x3f7fffe2, 0x3af77dcf, 0x3af77dcf, 0x3af77dcf, 0x3af77dcf, 0x3af77dcf, 0xbf7fffe6, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbad783f1, 0xbad783f1, 0xbad783f1, 0xbad783f1, 0xbad783f1, + 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3ab78a12, 0x3ab78a12, 0x3ab78a12, + 0x3ab78a12, 0x3ab78a12, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba979033, + 0xba979033, 0xba979033, 0xba979033, 0xba979033, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0x3a6f2ca7, 0x3a6f2ca7, 0x3a6f2ca7, 0x3a6f2ca7, 0x3a6f2ca7, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2f38e6, 0xba2f38e6, 0xba2f38e6, 0xba2f38e6, 0xba2f38e6, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39de8a4a, 0x39de8a4a, 0x39de8a4a, + 0x39de8a4a, 0x39de8a4a, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb93d458c, + 0xb93d458c, 0xb93d458c, 0xb93d458c, 0xb93d458c, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb88512f7, 0xb88512f7, 0xb88512f7, 0xb88512f7, 0xb88512f7, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x39a12c41, 0x39a12c41, 0x39a12c41, 0x39a12c41, 0x39a12c41, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba1089e2, 0xba1089e2, 0xba1089e2, +] )) ), + +################ chunk 11776 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47156752, 0x47156752, 0x47163e85, 0x47163e85, 0x47163e85, 0x47163e85, 0x47163e85, 0x471715b8, + 0x471715b8, 0x471715b8, 0x471715b8, 0x471715b8, 0x4717eceb, 0x4717eceb, 0x4717eceb, 0x4717eceb, + 0x4717eceb, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x47199b51, 0x47199b51, + 0x47199b51, 0x47199b51, 0x47199b51, 0x471a7284, 0x471a7284, 0x471a7284, 0x471a7284, 0x471a7284, + 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471c20ea, 0x471c20ea, 0x471c20ea, + 0x471c20ea, 0x471c20ea, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471dcf50, + 0x471dcf50, 0x471dcf50, 0x471dcf50, 0x471dcf50, 0x471ea683, 0x471ea683, 0x471ea683, 0x471ea683, + 0x471ea683, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x472054e8, 0x472054e8, + 0x472054e8, 0x472054e8, 0x472054e8, 0x47212c1b, 0x47212c1b, 0x47212c1b, 0x47212c1b, 0x47212c1b, + 0x4722034e, 0x4722034e, 0x4722034e, 0x4722034e, 0x4722034e, 0x4722da81, 0x4722da81, 0x4722da81, + 0x4722da81, 0x4722da81, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x472488e7, + 0x472488e7, 0x472488e7, 0x472488e7, 0x472488e7, 0x4725601a, 0x4725601a, 0x4725601a, 0x4725601a, + 0x4725601a, 0x4726374d, 0x4726374d, 0x4726374d, 0x4726374d, 0x4726374d, 0x47270e80, 0x47270e80, + 0x47270e80, 0x47270e80, 0x47270e80, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, + 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x47299419, 0x47299419, 0x47299419, + 0x47299419, 0x47299419, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472b427f, + 0x472b427f, 0x472b427f, 0x472b427f, 0x472b427f, 0x472c19b2, 0x472c19b2, 0x472c19b2, 0x472c19b2, + 0x472c19b2, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472dc818, 0x472dc818, + 0x472dc818, 0x472dc818, 0x472dc818, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, + 0x472f767e, 0x472f767e, 0x472f767e, 0x472f767e, 0x472f767e, 0x47304db1, 0x47304db1, 0x47304db1, + 0x47304db1, 0x47304db1, 0x473124e4, 0x473124e4, 0x473124e4, 0x473124e4, 0x473124e4, 0x4731fc17, + 0x4731fc17, 0x4731fc17, 0x4731fc17, 0x4731fc17, 0x4732d34a, 0x4732d34a, 0x4732d34a, 0x4732d34a, + 0x4732d34a, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x473481b0, 0x473481b0, + 0x473481b0, 0x473481b0, 0x473481b0, 0x473558e3, 0x473558e3, 0x473558e3, 0x473558e3, 0x473558e3, + 0x47363016, 0x47363016, 0x47363016, 0x47363016, 0x47363016, 0x47370749, 0x47370749, 0x47370749, + 0x47370749, 0x47370749, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4738b5af, + 0x4738b5af, 0x4738b5af, 0x4738b5af, 0x4738b5af, 0x47398ce2, 0x47398ce2, 0x47398ce2, 0x47398ce2, + 0x47398ce2, 0x473a6414, 0x473a6414, 0x473a6414, 0x473a6414, 0x473a6414, 0x473b3b47, 0x473b3b47, + 0x473b3b47, 0x473b3b47, 0x473b3b47, 0x473c127a, 0x473c127a, 0x473c127a, 0x473c127a, 0x473c127a, + 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473dc0e0, 0x473dc0e0, 0x473dc0e0, + 0x473dc0e0, 0x473dc0e0, 0x473e9813, 0x473e9813, 0x473e9813, 0x473e9813, 0x473e9813, 0x473f6f46, + 0x473f6f46, 0x473f6f46, 0x473f6f46, 0x473f6f46, 0x47404679, 0x47404679, 0x47404679, 0x47404679, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xba1089e2, 0xba1089e2, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a507da3, + 0x3a507da3, 0x3a507da3, 0x3a507da3, 0x3a507da3, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0xba8838b2, 0xba8838b2, 0xba8838b2, 0xba8838b2, 0xba8838b2, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0x3aa83291, 0x3aa83291, 0x3aa83291, 0x3aa83291, 0x3aa83291, + 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0xbac82c70, 0xbac82c70, 0xbac82c70, + 0xbac82c70, 0xbac82c70, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae8264e, + 0x3ae8264e, 0x3ae8264e, 0x3ae8264e, 0x3ae8264e, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, + 0x3f7fffe2, 0x3af7dfbf, 0x3af7dfbf, 0x3af7dfbf, 0x3af7dfbf, 0x3af7dfbf, 0xbf7fffe6, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbad7e5e1, 0xbad7e5e1, 0xbad7e5e1, 0xbad7e5e1, 0xbad7e5e1, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3ab7ec03, 0x3ab7ec03, 0x3ab7ec03, + 0x3ab7ec03, 0x3ab7ec03, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba97f224, + 0xba97f224, 0xba97f224, 0xba97f224, 0xba97f224, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0x3a6ff088, 0x3a6ff088, 0x3a6ff088, 0x3a6ff088, 0x3a6ff088, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2ffcc7, 0xba2ffcc7, 0xba2ffcc7, 0xba2ffcc7, 0xba2ffcc7, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39e0120c, 0x39e0120c, 0x39e0120c, + 0x39e0120c, 0x39e0120c, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9405510, + 0xb9405510, 0xb9405510, 0xb9405510, 0xb9405510, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb87de7dd, 0xb87de7dd, 0xb87de7dd, 0xb87de7dd, 0xb87de7dd, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x399fa47f, 0x399fa47f, 0x399fa47f, 0x399fa47f, 0x399fa47f, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba0fc601, 0xba0fc601, 0xba0fc601, + 0xba0fc601, 0xba0fc601, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a4fb9c2, + 0x3a4fb9c2, 0x3a4fb9c2, 0x3a4fb9c2, 0x3a4fb9c2, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0xba87d6c1, 0xba87d6c1, 0xba87d6c1, 0xba87d6c1, 0xba87d6c1, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0x3aa7d0a1, 0x3aa7d0a1, 0x3aa7d0a1, 0x3aa7d0a1, 0x3aa7d0a1, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0xbac7ca80, 0xbac7ca80, 0xbac7ca80, + 0xbac7ca80, 0xbac7ca80, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae7c45e, + 0x3ae7c45e, 0x3ae7c45e, 0x3ae7c45e, 0x3ae7c45e, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, + 0x3f7fffe2, 0x3af841b0, 0x3af841b0, 0x3af841b0, 0x3af841b0, 0x3af841b0, 0xbf7fffe6, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbad847d2, 0xbad847d2, 0xbad847d2, 0xbad847d2, 0xbad847d2, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3ab84df3, 0x3ab84df3, 0x3ab84df3, + 0x3ab84df3, 0x3ab84df3, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba985414, + 0xba985414, 0xba985414, 0xba985414, 0xba985414, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, +] )) ), + +################ chunk 12288 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47404679, 0x47411dac, 0x47411dac, 0x47411dac, 0x47411dac, 0x47411dac, 0x4741f4df, 0x4741f4df, + 0x4741f4df, 0x4741f4df, 0x4741f4df, 0x4742cc12, 0x4742cc12, 0x4742cc12, 0x4742cc12, 0x4742cc12, + 0x4743a345, 0x4743a345, 0x4743a345, 0x4743a345, 0x4743a345, 0x47447a78, 0x47447a78, 0x47447a78, + 0x47447a78, 0x47447a78, 0x474551ab, 0x474551ab, 0x474551ab, 0x474551ab, 0x474551ab, 0x474628de, + 0x474628de, 0x474628de, 0x474628de, 0x474628de, 0x47470011, 0x47470011, 0x47470011, 0x47470011, + 0x47470011, 0x4747d744, 0x4747d744, 0x4747d744, 0x4747d744, 0x4747d744, 0x4748ae77, 0x4748ae77, + 0x4748ae77, 0x4748ae77, 0x4748ae77, 0x474985aa, 0x474985aa, 0x474985aa, 0x474985aa, 0x474985aa, + 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474b3410, 0x474b3410, 0x474b3410, + 0x474b3410, 0x474b3410, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474ce276, + 0x474ce276, 0x474ce276, 0x474ce276, 0x474ce276, 0x474db9a9, 0x474db9a9, 0x474db9a9, 0x474db9a9, + 0x474db9a9, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474f680f, 0x474f680f, + 0x474f680f, 0x474f680f, 0x474f680f, 0x47503f42, 0x47503f42, 0x47503f42, 0x47503f42, 0x47503f42, + 0x47511675, 0x47511675, 0x47511675, 0x47511675, 0x47511675, 0x4751eda8, 0x4751eda8, 0x4751eda8, + 0x4751eda8, 0x4751eda8, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x47539c0e, + 0x47539c0e, 0x47539c0e, 0x47539c0e, 0x47539c0e, 0x47547341, 0x47547341, 0x47547341, 0x47547341, + 0x47547341, 0x47554a73, 0x47554a73, 0x47554a73, 0x47554a73, 0x47554a73, 0x475621a6, 0x475621a6, + 0x475621a6, 0x475621a6, 0x475621a6, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, + 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4758a73f, 0x4758a73f, 0x4758a73f, + 0x4758a73f, 0x4758a73f, 0x47597e72, 0x47597e72, 0x47597e72, 0x47597e72, 0x47597e72, 0x475a55a5, + 0x475a55a5, 0x475a55a5, 0x475a55a5, 0x475a55a5, 0x475b2cd8, 0x475b2cd8, 0x475b2cd8, 0x475b2cd8, + 0x475b2cd8, 0x475c040b, 0x475c040b, 0x475c040b, 0x475c040b, 0x475c040b, 0x475cdb3e, 0x475cdb3e, + 0x475cdb3e, 0x475cdb3e, 0x475cdb3e, 0x475db271, 0x475db271, 0x475db271, 0x475db271, 0x475db271, + 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475f60d7, 0x475f60d7, 0x475f60d7, + 0x475f60d7, 0x475f60d7, 0x4760380a, 0x4760380a, 0x4760380a, 0x4760380a, 0x4760380a, 0x47610f3d, + 0x47610f3d, 0x47610f3d, 0x47610f3d, 0x47610f3d, 0x4761e670, 0x4761e670, 0x4761e670, 0x4761e670, + 0x4761e670, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x476394d6, 0x476394d6, + 0x476394d6, 0x476394d6, 0x476394d6, 0x47646c09, 0x47646c09, 0x47646c09, 0x47646c09, 0x47646c09, + 0x4765433c, 0x4765433c, 0x4765433c, 0x4765433c, 0x4765433c, 0x47661a6f, 0x47661a6f, 0x47661a6f, + 0x47661a6f, 0x47661a6f, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4767c8d5, + 0x4767c8d5, 0x4767c8d5, 0x4767c8d5, 0x4767c8d5, 0x4768a008, 0x4768a008, 0x4768a008, 0x4768a008, + 0x4768a008, 0x4769773b, 0x4769773b, 0x4769773b, 0x4769773b, 0x4769773b, 0x476a4e6e, 0x476a4e6e, + 0x476a4e6e, 0x476a4e6e, 0x476a4e6e, 0x476b25a1, 0x476b25a1, 0x476b25a1, 0x476b25a1, 0x476b25a1, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffff7, 0x3a70b469, 0x3a70b469, 0x3a70b469, 0x3a70b469, 0x3a70b469, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba30c0a8, 0xba30c0a8, 0xba30c0a8, 0xba30c0a8, 0xba30c0a8, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39e199ce, 0x39e199ce, 0x39e199ce, + 0x39e199ce, 0x39e199ce, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9436495, + 0xb9436495, 0xb9436495, 0xb9436495, 0xb9436495, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb871a9cc, 0xb871a9cc, 0xb871a9cc, 0xb871a9cc, 0xb871a9cc, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x399e1cbd, 0x399e1cbd, 0x399e1cbd, 0x399e1cbd, 0x399e1cbd, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba0f0220, 0xba0f0220, 0xba0f0220, + 0xba0f0220, 0xba0f0220, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a4ef5e1, + 0x3a4ef5e1, 0x3a4ef5e1, 0x3a4ef5e1, 0x3a4ef5e1, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0xba8774d1, 0xba8774d1, 0xba8774d1, 0xba8774d1, 0xba8774d1, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0x3aa76eb0, 0x3aa76eb0, 0x3aa76eb0, 0x3aa76eb0, 0x3aa76eb0, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0xbac7688f, 0xbac7688f, 0xbac7688f, + 0xbac7688f, 0xbac7688f, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae7626d, + 0x3ae7626d, 0x3ae7626d, 0x3ae7626d, 0x3ae7626d, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, + 0x3f7fffe2, 0x3af8a3a0, 0x3af8a3a0, 0x3af8a3a0, 0x3af8a3a0, 0x3af8a3a0, 0xbf7fffe6, 0xbf7fffe6, + 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbad8a9c2, 0xbad8a9c2, 0xbad8a9c2, 0xbad8a9c2, 0xbad8a9c2, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3ab8afe4, 0x3ab8afe4, 0x3ab8afe4, + 0x3ab8afe4, 0x3ab8afe4, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba98b605, + 0xba98b605, 0xba98b605, 0xba98b605, 0xba98b605, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0x3a71784a, 0x3a71784a, 0x3a71784a, 0x3a71784a, 0x3a71784a, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba318489, 0xba318489, 0xba318489, 0xba318489, 0xba318489, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39e32190, 0x39e32190, 0x39e32190, + 0x39e32190, 0x39e32190, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9467419, + 0xb9467419, 0xb9467419, 0xb9467419, 0xb9467419, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb8656bbb, 0xb8656bbb, 0xb8656bbb, 0xb8656bbb, 0xb8656bbb, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x399c94fb, 0x399c94fb, 0x399c94fb, 0x399c94fb, 0x399c94fb, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0xba0e3e3f, 0xba0e3e3f, 0xba0e3e3f, + 0xba0e3e3f, 0xba0e3e3f, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a4e3200, + 0x3a4e3200, 0x3a4e3200, 0x3a4e3200, 0x3a4e3200, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0xba8712e0, 0xba8712e0, 0xba8712e0, 0xba8712e0, 0xba8712e0, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0x3aa70cc0, 0x3aa70cc0, 0x3aa70cc0, 0x3aa70cc0, 0x3aa70cc0, +] )) ), + +################ chunk 12800 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476cd407, 0x476cd407, 0x476cd407, + 0x476cd407, 0x476cd407, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476e826d, + 0x476e826d, 0x476e826d, 0x476e826d, 0x476e826d, 0x476f59a0, 0x476f59a0, 0x476f59a0, 0x476f59a0, + 0x476f59a0, 0x477030d2, 0x477030d2, 0x477030d2, 0x477030d2, 0x477030d2, 0x47710805, 0x47710805, + 0x47710805, 0x47710805, 0x47710805, 0x4771df38, 0x4771df38, 0x4771df38, 0x4771df38, 0x4771df38, + 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x47738d9e, 0x47738d9e, 0x47738d9e, + 0x47738d9e, 0x47738d9e, 0x477464d1, 0x477464d1, 0x477464d1, 0x477464d1, 0x477464d1, 0x47753c04, + 0x47753c04, 0x47753c04, 0x47753c04, 0x47753c04, 0x47761337, 0x47761337, 0x47761337, 0x47761337, + 0x47761337, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4777c19d, 0x4777c19d, + 0x4777c19d, 0x4777c19d, 0x4777c19d, 0x477898d0, 0x477898d0, 0x477898d0, 0x477898d0, 0x477898d0, + 0x47797003, 0x47797003, 0x47797003, 0x47797003, 0x47797003, 0x477a4736, 0x477a4736, 0x477a4736, + 0x477a4736, 0x477a4736, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477bf59c, + 0x477bf59c, 0x477bf59c, 0x477bf59c, 0x477bf59c, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, + 0x477ccccf, 0x477da402, 0x477da402, 0x477da402, 0x477da402, 0x477da402, 0x477e7b35, 0x477e7b35, + 0x477e7b35, 0x477e7b35, 0x477e7b35, 0x477f5268, 0x477f5268, 0x477f5268, 0x477f5268, 0x477f5268, + 0x478014cd, 0x478014cd, 0x478014cd, 0x478014cd, 0x478014cd, 0x47808067, 0x47808067, 0x47808067, + 0x47808067, 0x47808067, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4781579a, + 0x4781579a, 0x4781579a, 0x4781579a, 0x4781579a, 0x4781c333, 0x4781c333, 0x4781c333, 0x4781c333, + 0x4781c333, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47829a66, 0x47829a66, + 0x47829a66, 0x47829a66, 0x47829a66, 0x47830600, 0x47830600, 0x47830600, 0x47830600, 0x47830600, + 0x47837199, 0x47837199, 0x47837199, 0x47837199, 0x47837199, 0x4783dd33, 0x4783dd33, 0x4783dd33, + 0x4783dd33, 0x4783dd33, 0x478448cc, 0x478448cc, 0x478448cc, 0x478448cc, 0x478448cc, 0x4784b466, + 0x4784b466, 0x4784b466, 0x4784b466, 0x4784b466, 0x47851fff, 0x47851fff, 0x47851fff, 0x47851fff, + 0x47851fff, 0x47858b99, 0x47858b99, 0x47858b99, 0x47858b99, 0x47858b99, 0x4785f732, 0x4785f732, + 0x4785f732, 0x4785f732, 0x4785f732, 0x478662cc, 0x478662cc, 0x478662cc, 0x478662cc, 0x478662cc, + 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x478739ff, 0x478739ff, 0x478739ff, + 0x478739ff, 0x478739ff, 0x4787a598, 0x4787a598, 0x4787a598, 0x4787a598, 0x4787a598, 0x47881132, + 0x47881132, 0x47881132, 0x47881132, 0x47881132, 0x47887ccb, 0x47887ccb, 0x47887ccb, 0x47887ccb, + 0x47887ccb, 0x4788e865, 0x4788e865, 0x4788e865, 0x4788e865, 0x4788e865, 0x478953fe, 0x478953fe, + 0x478953fe, 0x478953fe, 0x478953fe, 0x4789bf98, 0x4789bf98, 0x4789bf98, 0x4789bf98, 0x4789bf98, + 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a96cb, 0x478a96cb, 0x478a96cb, + 0x478a96cb, 0x478a96cb, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b6dfe, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0xbac7069f, 0xbac7069f, 0xbac7069f, + 0xbac7069f, 0xbac7069f, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae7007d, + 0x3ae7007d, 0x3ae7007d, 0x3ae7007d, 0x3ae7007d, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, + 0x3f7fffe2, 0x3af90591, 0x3af90591, 0x3af90591, 0x3af90591, 0x3af90591, 0xbf7fffe5, 0xbf7fffe5, + 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0xbad90bb3, 0xbad90bb3, 0xbad90bb3, 0xbad90bb3, 0xbad90bb3, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3ab911d4, 0x3ab911d4, 0x3ab911d4, + 0x3ab911d4, 0x3ab911d4, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba9917f5, + 0xba9917f5, 0xba9917f5, 0xba9917f5, 0xba9917f5, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0x3a723c2b, 0x3a723c2b, 0x3a723c2b, 0x3a723c2b, 0x3a723c2b, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba32486a, 0xba32486a, 0xba32486a, 0xba32486a, 0xba32486a, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39e4a952, 0x39e4a952, 0x39e4a952, + 0x39e4a952, 0x39e4a952, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb949839d, + 0xb949839d, 0xb949839d, 0xb949839d, 0xb949839d, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xb8592daa, 0xb8592daa, 0xb8592daa, 0xb8592daa, 0xb8592daa, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x399b0d39, 0x399b0d39, 0x399b0d39, 0x399b0d39, 0x399b0d39, + 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0xba0d7a5e, 0xba0d7a5e, 0xba0d7a5e, + 0xba0d7a5e, 0xba0d7a5e, 0xbf7fffa8, 0xbf7fffa8, 0xbf7fffa8, 0xbf7fffa8, 0xbf7fffa8, 0x3a4d6e1f, + 0x3a4d6e1f, 0x3a4d6e1f, 0x3a4d6e1f, 0x3a4d6e1f, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0xba86b0f0, 0xba86b0f0, 0xba86b0f0, 0xba86b0f0, 0xba86b0f0, 0xbf7fffc0, 0xbf7fffc0, + 0xbf7fffc0, 0xbf7fffc0, 0xbf7fffc0, 0x3aa6aacf, 0x3aa6aacf, 0x3aa6aacf, 0x3aa6aacf, 0x3aa6aacf, + 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0xbac6a4ae, 0xbac6a4ae, 0xbac6a4ae, + 0xbac6a4ae, 0xbac6a4ae, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0x3ae69e8c, + 0x3ae69e8c, 0x3ae69e8c, 0x3ae69e8c, 0x3ae69e8c, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, + 0x3f7fffde, 0xbb034c35, 0xbb034c35, 0xbb034c35, 0xbb034c35, 0xbb034c35, 0xbf7fffe5, 0xbf7fffe5, + 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b134923, 0x3b134923, 0x3b134923, 0x3b134923, 0x3b134923, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb234610, 0xbb234610, 0xbb234610, + 0xbb234610, 0xbb234610, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0x3b3342fd, + 0x3b3342fd, 0x3b3342fd, 0x3b3342fd, 0x3b3342fd, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0xbb433fea, 0xbb433fea, 0xbb433fea, 0xbb433fea, 0xbb433fea, 0xbf7ffffb, 0xbf7ffffb, + 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3b533cd5, 0x3b533cd5, 0x3b533cd5, 0x3b533cd5, 0x3b533cd5, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb6339c0, 0xbb6339c0, 0xbb6339c0, + 0xbb6339c0, 0xbb6339c0, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b7336a9, +] )) ), + +################ chunk 13312 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x478b6dfe, 0x478b6dfe, 0x478b6dfe, 0x478b6dfe, 0x478bd997, 0x478bd997, 0x478bd997, 0x478bd997, + 0x478bd997, 0x478c4530, 0x478c4530, 0x478c4530, 0x478c4530, 0x478c4530, 0x478cb0ca, 0x478cb0ca, + 0x478cb0ca, 0x478cb0ca, 0x478cb0ca, 0x478d1c63, 0x478d1c63, 0x478d1c63, 0x478d1c63, 0x478d1c63, + 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478df396, 0x478df396, 0x478df396, + 0x478df396, 0x478df396, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478ecac9, + 0x478ecac9, 0x478ecac9, 0x478ecac9, 0x478ecac9, 0x478f3663, 0x478f3663, 0x478f3663, 0x478f3663, + 0x478f3663, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x47900d96, 0x47900d96, + 0x47900d96, 0x47900d96, 0x47900d96, 0x4790792f, 0x4790792f, 0x4790792f, 0x4790792f, 0x4790792f, + 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x47915062, 0x47915062, 0x47915062, + 0x47915062, 0x47915062, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x47922795, + 0x47922795, 0x47922795, 0x47922795, 0x47922795, 0x4792932f, 0x4792932f, 0x4792932f, 0x4792932f, + 0x4792932f, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x47936a62, 0x47936a62, + 0x47936a62, 0x47936a62, 0x47936a62, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, + 0x47944195, 0x47944195, 0x47944195, 0x47944195, 0x47944195, 0x4794ad2e, 0x4794ad2e, 0x4794ad2e, + 0x4794ad2e, 0x4794ad2e, 0x479518c8, 0x479518c8, 0x479518c8, 0x479518c8, 0x479518c8, 0x47958461, + 0x47958461, 0x47958461, 0x47958461, 0x47958461, 0x4795effb, 0x4795effb, 0x4795effb, 0x4795effb, + 0x4795effb, 0x47965b94, 0x47965b94, 0x47965b94, 0x47965b94, 0x47965b94, 0x4796c72e, 0x4796c72e, + 0x4796c72e, 0x4796c72e, 0x4796c72e, 0x479732c7, 0x479732c7, 0x479732c7, 0x479732c7, 0x479732c7, + 0x47979e61, 0x47979e61, 0x47979e61, 0x47979e61, 0x47979e61, 0x479809fa, 0x479809fa, 0x479809fa, + 0x479809fa, 0x479809fa, 0x47987594, 0x47987594, 0x47987594, 0x47987594, 0x47987594, 0x4798e12d, + 0x4798e12d, 0x4798e12d, 0x4798e12d, 0x4798e12d, 0x47994cc7, 0x47994cc7, 0x47994cc7, 0x47994cc7, + 0x47994cc7, 0x4799b860, 0x4799b860, 0x4799b860, 0x4799b860, 0x4799b860, 0x479a23f9, 0x479a23f9, + 0x479a23f9, 0x479a23f9, 0x479a23f9, 0x479a8f93, 0x479a8f93, 0x479a8f93, 0x479a8f93, 0x479a8f93, + 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479b66c6, 0x479b66c6, 0x479b66c6, + 0x479b66c6, 0x479b66c6, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479c3df9, + 0x479c3df9, 0x479c3df9, 0x479c3df9, 0x479c3df9, 0x479ca992, 0x479ca992, 0x479ca992, 0x479ca992, + 0x479ca992, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d80c5, 0x479d80c5, + 0x479d80c5, 0x479d80c5, 0x479d80c5, 0x479dec5f, 0x479dec5f, 0x479dec5f, 0x479dec5f, 0x479dec5f, + 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479ec392, 0x479ec392, 0x479ec392, + 0x479ec392, 0x479ec392, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f9ac5, + 0x479f9ac5, 0x479f9ac5, 0x479f9ac5, 0x479f9ac5, 0x47a0065e, 0x47a0065e, 0x47a0065e, 0x47a0065e, + 0x47a0065e, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a0dd91, 0x47a0dd91, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3b7336a9, 0x3b7336a9, 0x3b7336a9, 0x3b7336a9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3b7ccc19, 0x3b7ccc19, 0x3b7ccc19, 0x3b7ccc19, 0x3b7ccc19, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6ccf2f, 0xbb6ccf2f, 0xbb6ccf2f, 0xbb6ccf2f, 0xbb6ccf2f, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5cd245, 0x3b5cd245, 0x3b5cd245, + 0x3b5cd245, 0x3b5cd245, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbb4cd55a, + 0xbb4cd55a, 0xbb4cd55a, 0xbb4cd55a, 0xbb4cd55a, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3b3cd86f, 0x3b3cd86f, 0x3b3cd86f, 0x3b3cd86f, 0x3b3cd86f, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2cdb82, 0xbb2cdb82, 0xbb2cdb82, 0xbb2cdb82, 0xbb2cdb82, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1cde95, 0x3b1cde95, 0x3b1cde95, + 0x3b1cde95, 0x3b1cde95, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0ce1a7, + 0xbb0ce1a7, 0xbb0ce1a7, 0xbb0ce1a7, 0xbb0ce1a7, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, + 0x3f7fffe2, 0x3af9c972, 0x3af9c972, 0x3af9c972, 0x3af9c972, 0x3af9c972, 0xbf7fffda, 0xbf7fffda, + 0xbf7fffda, 0xbf7fffda, 0xbf7fffda, 0xbad9cf94, 0xbad9cf94, 0xbad9cf94, 0xbad9cf94, 0xbad9cf94, + 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3ab9d5b5, 0x3ab9d5b5, 0x3ab9d5b5, + 0x3ab9d5b5, 0x3ab9d5b5, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xba99dbd6, + 0xba99dbd6, 0xba99dbd6, 0xba99dbd6, 0xba99dbd6, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, + 0x3f7fffbc, 0x3a73c3ed, 0x3a73c3ed, 0x3a73c3ed, 0x3a73c3ed, 0x3a73c3ed, 0xbf7fffaf, 0xbf7fffaf, + 0xbf7fffaf, 0xbf7fffaf, 0xbf7fffaf, 0xba33d02c, 0xba33d02c, 0xba33d02c, 0xba33d02c, 0xba33d02c, + 0x3f7fffa2, 0x3f7fffa2, 0x3f7fffa2, 0x3f7fffa2, 0x3f7fffa2, 0x39e7b8d6, 0x39e7b8d6, 0x39e7b8d6, + 0x39e7b8d6, 0x39e7b8d6, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xb94fa2a6, + 0xb94fa2a6, 0xb94fa2a6, 0xb94fa2a6, 0xb94fa2a6, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, + 0x3f7fff85, 0xb840b188, 0xb840b188, 0xb840b188, 0xb840b188, 0xb840b188, 0xbf7fff8b, 0xbf7fff8b, + 0xbf7fff8b, 0xbf7fff8b, 0xbf7fff8b, 0x3997fdb5, 0x3997fdb5, 0x3997fdb5, 0x3997fdb5, 0x3997fdb5, + 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0xba0bf29c, 0xba0bf29c, 0xba0bf29c, + 0xba0bf29c, 0xba0bf29c, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0x3a4be65d, + 0x3a4be65d, 0x3a4be65d, 0x3a4be65d, 0x3a4be65d, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0xba85ed0f, 0xba85ed0f, 0xba85ed0f, 0xba85ed0f, 0xba85ed0f, 0xbf7fffc0, 0xbf7fffc0, + 0xbf7fffc0, 0xbf7fffc0, 0xbf7fffc0, 0x3aa5e6ee, 0x3aa5e6ee, 0x3aa5e6ee, 0x3aa5e6ee, 0x3aa5e6ee, + 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0xbac5e0cd, 0xbac5e0cd, 0xbac5e0cd, + 0xbac5e0cd, 0xbac5e0cd, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0x3ae5daab, + 0x3ae5daab, 0x3ae5daab, 0x3ae5daab, 0x3ae5daab, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, + 0x3f7fffdd, 0xbb02ea44, 0xbb02ea44, 0xbb02ea44, 0xbb02ea44, 0xbb02ea44, 0xbf7fffe5, 0xbf7fffe5, +] )) ), + +################ chunk 13824 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47a0dd91, 0x47a0dd91, 0x47a0dd91, 0x47a1492b, 0x47a1492b, 0x47a1492b, 0x47a1492b, 0x47a1492b, + 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a2205e, 0x47a2205e, 0x47a2205e, + 0x47a2205e, 0x47a2205e, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a2f791, + 0x47a2f791, 0x47a2f791, 0x47a2f791, 0x47a2f791, 0x47a3632a, 0x47a3632a, 0x47a3632a, 0x47a3632a, + 0x47a3632a, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a43a5d, 0x47a43a5d, + 0x47a43a5d, 0x47a43a5d, 0x47a43a5d, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, + 0x47a51190, 0x47a51190, 0x47a51190, 0x47a51190, 0x47a51190, 0x47a57d2a, 0x47a57d2a, 0x47a57d2a, + 0x47a57d2a, 0x47a57d2a, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a6545d, + 0x47a6545d, 0x47a6545d, 0x47a6545d, 0x47a6545d, 0x47a6bff6, 0x47a6bff6, 0x47a6bff6, 0x47a6bff6, + 0x47a6bff6, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a79729, 0x47a79729, + 0x47a79729, 0x47a79729, 0x47a79729, 0x47a802c2, 0x47a802c2, 0x47a802c2, 0x47a802c2, 0x47a802c2, + 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a8d9f5, 0x47a8d9f5, 0x47a8d9f5, + 0x47a8d9f5, 0x47a8d9f5, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9b128, + 0x47a9b128, 0x47a9b128, 0x47a9b128, 0x47a9b128, 0x47aa1cc2, 0x47aa1cc2, 0x47aa1cc2, 0x47aa1cc2, + 0x47aa1cc2, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aaf3f5, 0x47aaf3f5, + 0x47aaf3f5, 0x47aaf3f5, 0x47aaf3f5, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, + 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47ac36c1, 0x47ac36c1, 0x47ac36c1, + 0x47ac36c1, 0x47ac36c1, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47ad0df4, + 0x47ad0df4, 0x47ad0df4, 0x47ad0df4, 0x47ad0df4, 0x47ad798e, 0x47ad798e, 0x47ad798e, 0x47ad798e, + 0x47ad798e, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ae50c1, 0x47ae50c1, + 0x47ae50c1, 0x47ae50c1, 0x47ae50c1, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, + 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af938d, 0x47af938d, 0x47af938d, + 0x47af938d, 0x47af938d, 0x47afff27, 0x47afff27, 0x47afff27, 0x47afff27, 0x47afff27, 0x47b06ac0, + 0x47b06ac0, 0x47b06ac0, 0x47b06ac0, 0x47b06ac0, 0x47b0d65a, 0x47b0d65a, 0x47b0d65a, 0x47b0d65a, + 0x47b0d65a, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b1ad8d, 0x47b1ad8d, + 0x47b1ad8d, 0x47b1ad8d, 0x47b1ad8d, 0x47b21926, 0x47b21926, 0x47b21926, 0x47b21926, 0x47b21926, + 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b2f059, 0x47b2f059, 0x47b2f059, + 0x47b2f059, 0x47b2f059, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b3c78c, + 0x47b3c78c, 0x47b3c78c, 0x47b3c78c, 0x47b3c78c, 0x47b43326, 0x47b43326, 0x47b43326, 0x47b43326, + 0x47b43326, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b50a58, 0x47b50a58, + 0x47b50a58, 0x47b50a58, 0x47b50a58, 0x47b575f2, 0x47b575f2, 0x47b575f2, 0x47b575f2, 0x47b575f2, + 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b64d25, 0x47b64d25, 0x47b64d25, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b12e732, 0x3b12e732, 0x3b12e732, 0x3b12e732, 0x3b12e732, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb22e420, 0xbb22e420, 0xbb22e420, + 0xbb22e420, 0xbb22e420, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0x3b32e10d, + 0x3b32e10d, 0x3b32e10d, 0x3b32e10d, 0x3b32e10d, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0xbb42ddf9, 0xbb42ddf9, 0xbb42ddf9, 0xbb42ddf9, 0xbb42ddf9, 0xbf7ffffa, 0xbf7ffffa, + 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b52dae5, 0x3b52dae5, 0x3b52dae5, 0x3b52dae5, 0x3b52dae5, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb62d7cf, 0xbb62d7cf, 0xbb62d7cf, + 0xbb62d7cf, 0xbb62d7cf, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b72d4b9, + 0x3b72d4b9, 0x3b72d4b9, 0x3b72d4b9, 0x3b72d4b9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3b7d2e09, 0x3b7d2e09, 0x3b7d2e09, 0x3b7d2e09, 0x3b7d2e09, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6d3120, 0xbb6d3120, 0xbb6d3120, 0xbb6d3120, 0xbb6d3120, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5d3436, 0x3b5d3436, 0x3b5d3436, + 0x3b5d3436, 0x3b5d3436, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbb4d374b, + 0xbb4d374b, 0xbb4d374b, 0xbb4d374b, 0xbb4d374b, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3b3d3a5f, 0x3b3d3a5f, 0x3b3d3a5f, 0x3b3d3a5f, 0x3b3d3a5f, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2d3d73, 0xbb2d3d73, 0xbb2d3d73, 0xbb2d3d73, 0xbb2d3d73, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1d4085, 0x3b1d4085, 0x3b1d4085, + 0x3b1d4085, 0x3b1d4085, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0d4398, + 0xbb0d4398, 0xbb0d4398, 0xbb0d4398, 0xbb0d4398, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, + 0x3f7fffe3, 0x3afa8d53, 0x3afa8d53, 0x3afa8d53, 0x3afa8d53, 0x3afa8d53, 0xbf7fffda, 0xbf7fffda, + 0xbf7fffda, 0xbf7fffda, 0xbf7fffda, 0xbada9375, 0xbada9375, 0xbada9375, 0xbada9375, 0xbada9375, + 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3aba9996, 0x3aba9996, 0x3aba9996, + 0x3aba9996, 0x3aba9996, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xba9a9fb7, + 0xba9a9fb7, 0xba9a9fb7, 0xba9a9fb7, 0xba9a9fb7, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, + 0x3f7fffbc, 0x3a754baf, 0x3a754baf, 0x3a754baf, 0x3a754baf, 0x3a754baf, 0xbf7fffb0, 0xbf7fffb0, + 0xbf7fffb0, 0xbf7fffb0, 0xbf7fffb0, 0xba3557ee, 0xba3557ee, 0xba3557ee, 0xba3557ee, 0xba3557ee, + 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x39eac85b, 0x39eac85b, 0x39eac85b, + 0x39eac85b, 0x39eac85b, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xb955c1ae, + 0xb955c1ae, 0xb955c1ae, 0xb955c1ae, 0xb955c1ae, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, + 0x3f7fff85, 0xb8283566, 0xb8283566, 0xb8283566, 0xb8283566, 0xb8283566, 0xbf7fff8a, 0xbf7fff8a, + 0xbf7fff8a, 0xbf7fff8a, 0xbf7fff8a, 0x3994ee30, 0x3994ee30, 0x3994ee30, 0x3994ee30, 0x3994ee30, + 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0xba0a6ada, 0xba0a6ada, 0xba0a6ada, +] )) ), + +################ chunk 14336 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47b64d25, 0x47b64d25, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b72458, + 0x47b72458, 0x47b72458, 0x47b72458, 0x47b72458, 0x47b78ff1, 0x47b78ff1, 0x47b78ff1, 0x47b78ff1, + 0x47b78ff1, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b86724, 0x47b86724, + 0x47b86724, 0x47b86724, 0x47b86724, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, + 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b9a9f1, 0x47b9a9f1, 0x47b9a9f1, + 0x47b9a9f1, 0x47b9a9f1, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba8124, + 0x47ba8124, 0x47ba8124, 0x47ba8124, 0x47ba8124, 0x47baecbd, 0x47baecbd, 0x47baecbd, 0x47baecbd, + 0x47baecbd, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bbc3f0, 0x47bbc3f0, + 0x47bbc3f0, 0x47bbc3f0, 0x47bbc3f0, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, + 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bd06bd, 0x47bd06bd, 0x47bd06bd, + 0x47bd06bd, 0x47bd06bd, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bdddf0, + 0x47bdddf0, 0x47bdddf0, 0x47bdddf0, 0x47bdddf0, 0x47be4989, 0x47be4989, 0x47be4989, 0x47be4989, + 0x47be4989, 0x47beb523, 0x47beb523, 0x47beb523, 0x47beb523, 0x47beb523, 0x47bf20bc, 0x47bf20bc, + 0x47bf20bc, 0x47bf20bc, 0x47bf20bc, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, + 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47c06389, 0x47c06389, 0x47c06389, + 0x47c06389, 0x47c06389, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c13abc, + 0x47c13abc, 0x47c13abc, 0x47c13abc, 0x47c13abc, 0x47c1a655, 0x47c1a655, 0x47c1a655, 0x47c1a655, + 0x47c1a655, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c27d88, 0x47c27d88, + 0x47c27d88, 0x47c27d88, 0x47c27d88, 0x47c2e921, 0x47c2e921, 0x47c2e921, 0x47c2e921, 0x47c2e921, + 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c3c054, 0x47c3c054, 0x47c3c054, + 0x47c3c054, 0x47c3c054, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c49787, + 0x47c49787, 0x47c49787, 0x47c49787, 0x47c49787, 0x47c50321, 0x47c50321, 0x47c50321, 0x47c50321, + 0x47c50321, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c5da54, 0x47c5da54, + 0x47c5da54, 0x47c5da54, 0x47c5da54, 0x47c645ed, 0x47c645ed, 0x47c645ed, 0x47c645ed, 0x47c645ed, + 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c71d20, 0x47c71d20, 0x47c71d20, + 0x47c71d20, 0x47c71d20, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c7f453, + 0x47c7f453, 0x47c7f453, 0x47c7f453, 0x47c7f453, 0x47c85fed, 0x47c85fed, 0x47c85fed, 0x47c85fed, + 0x47c85fed, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c93720, 0x47c93720, + 0x47c93720, 0x47c93720, 0x47c93720, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, + 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca79ec, 0x47ca79ec, 0x47ca79ec, + 0x47ca79ec, 0x47ca79ec, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cb511f, + 0x47cb511f, 0x47cb511f, 0x47cb511f, 0x47cb511f, 0x47cbbcb9, 0x47cbbcb9, 0x47cbbcb9, 0x47cbbcb9, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xba0a6ada, 0xba0a6ada, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0x3a4a5e9b, + 0x3a4a5e9b, 0x3a4a5e9b, 0x3a4a5e9b, 0x3a4a5e9b, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0xba85292e, 0xba85292e, 0xba85292e, 0xba85292e, 0xba85292e, 0xbf7fffc0, 0xbf7fffc0, + 0xbf7fffc0, 0xbf7fffc0, 0xbf7fffc0, 0x3aa5230d, 0x3aa5230d, 0x3aa5230d, 0x3aa5230d, 0x3aa5230d, + 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0xbac51cec, 0xbac51cec, 0xbac51cec, + 0xbac51cec, 0xbac51cec, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0x3ae516ca, + 0x3ae516ca, 0x3ae516ca, 0x3ae516ca, 0x3ae516ca, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, + 0x3f7fffdd, 0xbb028854, 0xbb028854, 0xbb028854, 0xbb028854, 0xbb028854, 0xbf7fffe5, 0xbf7fffe5, + 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b128542, 0x3b128542, 0x3b128542, 0x3b128542, 0x3b128542, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb228230, 0xbb228230, 0xbb228230, + 0xbb228230, 0xbb228230, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0x3b327f1c, + 0x3b327f1c, 0x3b327f1c, 0x3b327f1c, 0x3b327f1c, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, + 0x3f7ffff7, 0xbb427c09, 0xbb427c09, 0xbb427c09, 0xbb427c09, 0xbb427c09, 0xbf7ffffa, 0xbf7ffffa, + 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b5278f4, 0x3b5278f4, 0x3b5278f4, 0x3b5278f4, 0x3b5278f4, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb6275df, 0xbb6275df, 0xbb6275df, + 0xbb6275df, 0xbb6275df, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b7272c9, + 0x3b7272c9, 0x3b7272c9, 0x3b7272c9, 0x3b7272c9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3b7d8ff9, 0x3b7d8ff9, 0x3b7d8ff9, 0x3b7d8ff9, 0x3b7d8ff9, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6d9310, 0xbb6d9310, 0xbb6d9310, 0xbb6d9310, 0xbb6d9310, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5d9626, 0x3b5d9626, 0x3b5d9626, + 0x3b5d9626, 0x3b5d9626, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbb4d993b, + 0xbb4d993b, 0xbb4d993b, 0xbb4d993b, 0xbb4d993b, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3b3d9c4f, 0x3b3d9c4f, 0x3b3d9c4f, 0x3b3d9c4f, 0x3b3d9c4f, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2d9f63, 0xbb2d9f63, 0xbb2d9f63, 0xbb2d9f63, 0xbb2d9f63, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1da276, 0x3b1da276, 0x3b1da276, + 0x3b1da276, 0x3b1da276, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0da588, + 0xbb0da588, 0xbb0da588, 0xbb0da588, 0xbb0da588, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, + 0x3f7fffe3, 0x3afb5134, 0x3afb5134, 0x3afb5134, 0x3afb5134, 0x3afb5134, 0xbf7fffdb, 0xbf7fffdb, + 0xbf7fffdb, 0xbf7fffdb, 0xbf7fffdb, 0xbadb5756, 0xbadb5756, 0xbadb5756, 0xbadb5756, 0xbadb5756, + 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3abb5d78, 0x3abb5d78, 0x3abb5d78, + 0x3abb5d78, 0x3abb5d78, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xba9b6398, + 0xba9b6398, 0xba9b6398, 0xba9b6398, 0xba9b6398, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, +] )) ), + +################ chunk 14848 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47cbbcb9, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc93ec, 0x47cc93ec, + 0x47cc93ec, 0x47cc93ec, 0x47cc93ec, 0x47ccff85, 0x47ccff85, 0x47ccff85, 0x47ccff85, 0x47ccff85, + 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cdd6b8, 0x47cdd6b8, 0x47cdd6b8, + 0x47cdd6b8, 0x47cdd6b8, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ceadeb, + 0x47ceadeb, 0x47ceadeb, 0x47ceadeb, 0x47ceadeb, 0x47cf1985, 0x47cf1985, 0x47cf1985, 0x47cf1985, + 0x47cf1985, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cff0b7, 0x47cff0b7, + 0x47cff0b7, 0x47cff0b7, 0x47cff0b7, 0x47d05c51, 0x47d05c51, 0x47d05c51, 0x47d05c51, 0x47d05c51, + 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d13384, 0x47d13384, 0x47d13384, + 0x47d13384, 0x47d13384, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d20ab7, + 0x47d20ab7, 0x47d20ab7, 0x47d20ab7, 0x47d20ab7, 0x47d27650, 0x47d27650, 0x47d27650, 0x47d27650, + 0x47d27650, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d34d83, 0x47d34d83, + 0x47d34d83, 0x47d34d83, 0x47d34d83, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, + 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d49050, 0x47d49050, 0x47d49050, + 0x47d49050, 0x47d49050, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d56783, + 0x47d56783, 0x47d56783, 0x47d56783, 0x47d56783, 0x47d5d31c, 0x47d5d31c, 0x47d5d31c, 0x47d5d31c, + 0x47d5d31c, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d6aa4f, 0x47d6aa4f, + 0x47d6aa4f, 0x47d6aa4f, 0x47d6aa4f, 0x47d715e9, 0x47d715e9, 0x47d715e9, 0x47d715e9, 0x47d715e9, + 0x47d78182, 0x47d78182, 0x47d78182, 0x47d78182, 0x47d78182, 0x47d7ed1c, 0x47d7ed1c, 0x47d7ed1c, + 0x47d7ed1c, 0x47d7ed1c, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d8c44f, + 0x47d8c44f, 0x47d8c44f, 0x47d8c44f, 0x47d8c44f, 0x47d92fe8, 0x47d92fe8, 0x47d92fe8, 0x47d92fe8, + 0x47d92fe8, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47da071b, 0x47da071b, + 0x47da071b, 0x47da071b, 0x47da071b, 0x47da72b5, 0x47da72b5, 0x47da72b5, 0x47da72b5, 0x47da72b5, + 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47db49e8, 0x47db49e8, 0x47db49e8, + 0x47db49e8, 0x47db49e8, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dc211b, + 0x47dc211b, 0x47dc211b, 0x47dc211b, 0x47dc211b, 0x47dc8cb4, 0x47dc8cb4, 0x47dc8cb4, 0x47dc8cb4, + 0x47dc8cb4, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dd63e7, 0x47dd63e7, + 0x47dd63e7, 0x47dd63e7, 0x47dd63e7, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, + 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47dea6b3, 0x47dea6b3, 0x47dea6b3, + 0x47dea6b3, 0x47dea6b3, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df7de6, + 0x47df7de6, 0x47df7de6, 0x47df7de6, 0x47df7de6, 0x47dfe980, 0x47dfe980, 0x47dfe980, 0x47dfe980, + 0x47dfe980, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e0c0b3, 0x47e0c0b3, + 0x47e0c0b3, 0x47e0c0b3, 0x47e0c0b3, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fffbc, 0x3a76d371, 0x3a76d371, 0x3a76d371, 0x3a76d371, 0x3a76d371, 0xbf7fffb0, 0xbf7fffb0, + 0xbf7fffb0, 0xbf7fffb0, 0xbf7fffb0, 0xba36dfb1, 0xba36dfb1, 0xba36dfb1, 0xba36dfb1, 0xba36dfb1, + 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x39edd7df, 0x39edd7df, 0x39edd7df, + 0x39edd7df, 0x39edd7df, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xb95be0b7, + 0xb95be0b7, 0xb95be0b7, 0xb95be0b7, 0xb95be0b7, 0x3f7fff86, 0x3f7fff86, 0x3f7fff86, 0x3f7fff86, + 0x3f7fff86, 0xb80fb944, 0xb80fb944, 0xb80fb944, 0xb80fb944, 0xb80fb944, 0xbf7fff8a, 0xbf7fff8a, + 0xbf7fff8a, 0xbf7fff8a, 0xbf7fff8a, 0x3991deac, 0x3991deac, 0x3991deac, 0x3991deac, 0x3991deac, + 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0xba08e318, 0xba08e318, 0xba08e318, + 0xba08e318, 0xba08e318, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0x3a48d6d9, + 0x3a48d6d9, 0x3a48d6d9, 0x3a48d6d9, 0x3a48d6d9, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, + 0x3f7fffb4, 0xba84654d, 0xba84654d, 0xba84654d, 0xba84654d, 0xba84654d, 0xbf7fffbf, 0xbf7fffbf, + 0xbf7fffbf, 0xbf7fffbf, 0xbf7fffbf, 0x3aa45f2c, 0x3aa45f2c, 0x3aa45f2c, 0x3aa45f2c, 0x3aa45f2c, + 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0xbac4590b, 0xbac4590b, 0xbac4590b, + 0xbac4590b, 0xbac4590b, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0x3ae452e9, + 0x3ae452e9, 0x3ae452e9, 0x3ae452e9, 0x3ae452e9, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, + 0x3f7fffdd, 0xbb022663, 0xbb022663, 0xbb022663, 0xbb022663, 0xbb022663, 0xbf7fffe5, 0xbf7fffe5, + 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b122351, 0x3b122351, 0x3b122351, 0x3b122351, 0x3b122351, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb22203f, 0xbb22203f, 0xbb22203f, + 0xbb22203f, 0xbb22203f, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0x3b321d2c, + 0x3b321d2c, 0x3b321d2c, 0x3b321d2c, 0x3b321d2c, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0xbb421a18, 0xbb421a18, 0xbb421a18, 0xbb421a18, 0xbb421a18, 0xbf7ffffa, 0xbf7ffffa, + 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b521704, 0x3b521704, 0x3b521704, 0x3b521704, 0x3b521704, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb6213ee, 0xbb6213ee, 0xbb6213ee, + 0xbb6213ee, 0xbb6213ee, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b7210d8, + 0x3b7210d8, 0x3b7210d8, 0x3b7210d8, 0x3b7210d8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3b7df1ea, 0x3b7df1ea, 0x3b7df1ea, 0x3b7df1ea, 0x3b7df1ea, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6df500, 0xbb6df500, 0xbb6df500, 0xbb6df500, 0xbb6df500, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5df816, 0x3b5df816, 0x3b5df816, + 0x3b5df816, 0x3b5df816, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbb4dfb2c, + 0xbb4dfb2c, 0xbb4dfb2c, 0xbb4dfb2c, 0xbb4dfb2c, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3b3dfe40, 0x3b3dfe40, 0x3b3dfe40, 0x3b3dfe40, 0x3b3dfe40, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2e0153, 0xbb2e0153, 0xbb2e0153, 0xbb2e0153, 0xbb2e0153, +] )) ), + +################ chunk 15360 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e2037f, 0x47e2037f, 0x47e2037f, + 0x47e2037f, 0x47e2037f, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e2dab2, + 0x47e2dab2, 0x47e2dab2, 0x47e2dab2, 0x47e2dab2, 0x47e3464c, 0x47e3464c, 0x47e3464c, 0x47e3464c, + 0x47e3464c, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e41d7f, 0x47e41d7f, + 0x47e41d7f, 0x47e41d7f, 0x47e41d7f, 0x47e48918, 0x47e48918, 0x47e48918, 0x47e48918, 0x47e48918, + 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e5604b, 0x47e5604b, 0x47e5604b, + 0x47e5604b, 0x47e5604b, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e6377e, + 0x47e6377e, 0x47e6377e, 0x47e6377e, 0x47e6377e, 0x47e6a318, 0x47e6a318, 0x47e6a318, 0x47e6a318, + 0x47e6a318, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e77a4b, 0x47e77a4b, + 0x47e77a4b, 0x47e77a4b, 0x47e77a4b, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, + 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8bd17, 0x47e8bd17, 0x47e8bd17, + 0x47e8bd17, 0x47e8bd17, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e9944a, + 0x47e9944a, 0x47e9944a, 0x47e9944a, 0x47e9944a, 0x47e9ffe4, 0x47e9ffe4, 0x47e9ffe4, 0x47e9ffe4, + 0x47e9ffe4, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ead716, 0x47ead716, + 0x47ead716, 0x47ead716, 0x47ead716, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, + 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ec19e3, 0x47ec19e3, 0x47ec19e3, + 0x47ec19e3, 0x47ec19e3, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ecf116, + 0x47ecf116, 0x47ecf116, 0x47ecf116, 0x47ecf116, 0x47ed5caf, 0x47ed5caf, 0x47ed5caf, 0x47ed5caf, + 0x47ed5caf, 0x47edc849, 0x47edc849, 0x47edc849, 0x47edc849, 0x47edc849, 0x47ee33e2, 0x47ee33e2, + 0x47ee33e2, 0x47ee33e2, 0x47ee33e2, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, + 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef76af, 0x47ef76af, 0x47ef76af, + 0x47ef76af, 0x47ef76af, 0x47efe248, 0x47efe248, 0x47efe248, 0x47efe248, 0x47efe248, 0x47f04de2, + 0x47f04de2, 0x47f04de2, 0x47f04de2, 0x47f04de2, 0x47f0b97b, 0x47f0b97b, 0x47f0b97b, 0x47f0b97b, + 0x47f0b97b, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f190ae, 0x47f190ae, + 0x47f190ae, 0x47f190ae, 0x47f190ae, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, + 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f2d37b, 0x47f2d37b, 0x47f2d37b, + 0x47f2d37b, 0x47f2d37b, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f3aaae, + 0x47f3aaae, 0x47f3aaae, 0x47f3aaae, 0x47f3aaae, 0x47f41647, 0x47f41647, 0x47f41647, 0x47f41647, + 0x47f41647, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f4ed7a, 0x47f4ed7a, + 0x47f4ed7a, 0x47f4ed7a, 0x47f4ed7a, 0x47f55914, 0x47f55914, 0x47f55914, 0x47f55914, 0x47f55914, + 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f63047, 0x47f63047, 0x47f63047, + 0x47f63047, 0x47f63047, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f7077a, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1e0466, 0x3b1e0466, 0x3b1e0466, + 0x3b1e0466, 0x3b1e0466, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0e0779, + 0xbb0e0779, 0xbb0e0779, 0xbb0e0779, 0xbb0e0779, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, + 0x3f7fffe3, 0x3afc1514, 0x3afc1514, 0x3afc1514, 0x3afc1514, 0x3afc1514, 0xbf7fffdb, 0xbf7fffdb, + 0xbf7fffdb, 0xbf7fffdb, 0xbf7fffdb, 0xbadc1b37, 0xbadc1b37, 0xbadc1b37, 0xbadc1b37, 0xbadc1b37, + 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3abc2159, 0x3abc2159, 0x3abc2159, + 0x3abc2159, 0x3abc2159, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xba9c2779, + 0xba9c2779, 0xba9c2779, 0xba9c2779, 0xba9c2779, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, + 0x3f7fffbc, 0x3a785b33, 0x3a785b33, 0x3a785b33, 0x3a785b33, 0x3a785b33, 0xbf7fffb0, 0xbf7fffb0, + 0xbf7fffb0, 0xbf7fffb0, 0xbf7fffb0, 0xba386773, 0xba386773, 0xba386773, 0xba386773, 0xba386773, + 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x39f0e763, 0x39f0e763, 0x39f0e763, + 0x39f0e763, 0x39f0e763, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xb961ffbf, + 0xb961ffbf, 0xb961ffbf, 0xb961ffbf, 0xb961ffbf, 0x3f7fff86, 0x3f7fff86, 0x3f7fff86, 0x3f7fff86, + 0x3f7fff86, 0xb7ee7a43, 0xb7ee7a43, 0xb7ee7a43, 0xb7ee7a43, 0xb7ee7a43, 0xbf7fff8a, 0xbf7fff8a, + 0xbf7fff8a, 0xbf7fff8a, 0xbf7fff8a, 0x398ecf28, 0x398ecf28, 0x398ecf28, 0x398ecf28, 0x398ecf28, + 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0xba075b56, 0xba075b56, 0xba075b56, + 0xba075b56, 0xba075b56, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0x3a474f17, + 0x3a474f17, 0x3a474f17, 0x3a474f17, 0x3a474f17, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, + 0x3f7fffb3, 0xba83a16b, 0xba83a16b, 0xba83a16b, 0xba83a16b, 0xba83a16b, 0xbf7fffbf, 0xbf7fffbf, + 0xbf7fffbf, 0xbf7fffbf, 0xbf7fffbf, 0x3aa39b4b, 0x3aa39b4b, 0x3aa39b4b, 0x3aa39b4b, 0x3aa39b4b, + 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0xbac3952a, 0xbac3952a, 0xbac3952a, + 0xbac3952a, 0xbac3952a, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0x3ae38f08, + 0x3ae38f08, 0x3ae38f08, 0x3ae38f08, 0x3ae38f08, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, + 0x3f7fffdd, 0xbb01c473, 0xbb01c473, 0xbb01c473, 0xbb01c473, 0xbb01c473, 0xbf7fffe5, 0xbf7fffe5, + 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b11c161, 0x3b11c161, 0x3b11c161, 0x3b11c161, 0x3b11c161, + 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb21be4f, 0xbb21be4f, 0xbb21be4f, + 0xbb21be4f, 0xbb21be4f, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0x3b31bb3c, + 0x3b31bb3c, 0x3b31bb3c, 0x3b31bb3c, 0x3b31bb3c, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0xbb41b828, 0xbb41b828, 0xbb41b828, 0xbb41b828, 0xbb41b828, 0xbf7ffffa, 0xbf7ffffa, + 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b51b513, 0x3b51b513, 0x3b51b513, 0x3b51b513, 0x3b51b513, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb61b1fe, 0xbb61b1fe, 0xbb61b1fe, + 0xbb61b1fe, 0xbb61b1fe, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b71aee8, +] )) ), + +################ chunk 15872 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x47f7077a, 0x47f7077a, 0x47f7077a, 0x47f7077a, 0x47f77313, 0x47f77313, 0x47f77313, 0x47f77313, + 0x47f77313, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f84a46, 0x47f84a46, + 0x47f84a46, 0x47f84a46, 0x47f84a46, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, + 0x47f92179, 0x47f92179, 0x47f92179, 0x47f92179, 0x47f92179, 0x47f98d12, 0x47f98d12, 0x47f98d12, + 0x47f98d12, 0x47f98d12, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47fa6445, + 0x47fa6445, 0x47fa6445, 0x47fa6445, 0x47fa6445, 0x47facfdf, 0x47facfdf, 0x47facfdf, 0x47facfdf, + 0x47facfdf, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fba712, 0x47fba712, + 0x47fba712, 0x47fba712, 0x47fba712, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, + 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fce9de, 0x47fce9de, 0x47fce9de, + 0x47fce9de, 0x47fce9de, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fdc111, + 0x47fdc111, 0x47fdc111, 0x47fdc111, 0x47fdc111, 0x47fe2cab, 0x47fe2cab, 0x47fe2cab, 0x47fe2cab, + 0x47fe2cab, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47ff03de, 0x47ff03de, + 0x47ff03de, 0x47ff03de, 0x47ff03de, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, + 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x48002355, 0x48002355, 0x48002355, + 0x48002355, 0x48002355, 0x48005922, 0x48005922, 0x48005922, 0x48005922, 0x48005922, 0x48008eef, + 0x48008eef, 0x48008eef, 0x48008eef, 0x48008eef, 0x4800c4bb, 0x4800c4bb, 0x4800c4bb, 0x4800c4bb, + 0x4800c4bb, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x48013055, 0x48013055, + 0x48013055, 0x48013055, 0x48013055, 0x48016622, 0x48016622, 0x48016622, 0x48016622, 0x48016622, + 0x48019bee, 0x48019bee, 0x48019bee, 0x48019bee, 0x48019bee, 0x4801d1bb, 0x4801d1bb, 0x4801d1bb, + 0x4801d1bb, 0x4801d1bb, 0x48020788, 0x48020788, 0x48020788, 0x48020788, 0x48020788, 0x48023d55, + 0x48023d55, 0x48023d55, 0x48023d55, 0x48023d55, 0x48027321, 0x48027321, 0x48027321, 0x48027321, + 0x48027321, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802debb, 0x4802debb, + 0x4802debb, 0x4802debb, 0x4802debb, 0x48031487, 0x48031487, 0x48031487, 0x48031487, 0x48031487, + 0x48034a54, 0x48034a54, 0x48034a54, 0x48034a54, 0x48034a54, 0x48038021, 0x48038021, 0x48038021, + 0x48038021, 0x48038021, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803ebba, + 0x4803ebba, 0x4803ebba, 0x4803ebba, 0x4803ebba, 0x48042187, 0x48042187, 0x48042187, 0x48042187, + 0x48042187, 0x48045754, 0x48045754, 0x48045754, 0x48045754, 0x48045754, 0x48048d21, 0x48048d21, + 0x48048d21, 0x48048d21, 0x48048d21, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, + 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x48052e87, 0x48052e87, 0x48052e87, + 0x48052e87, 0x48052e87, 0x48056454, 0x48056454, 0x48056454, 0x48056454, 0x48056454, 0x48059a20, + 0x48059a20, 0x48059a20, 0x48059a20, 0x48059a20, 0x4805cfed, 0x4805cfed, 0x4805cfed, 0x4805cfed, + 0x4805cfed, 0x480605ba, 0x480605ba, 0x480605ba, 0x480605ba, 0x480605ba, 0x48063b87, 0x48063b87, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3b71aee8, 0x3b71aee8, 0x3b71aee8, 0x3b71aee8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3b7e53da, 0x3b7e53da, 0x3b7e53da, 0x3b7e53da, 0x3b7e53da, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6e56f1, 0xbb6e56f1, 0xbb6e56f1, 0xbb6e56f1, 0xbb6e56f1, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5e5a07, 0x3b5e5a07, 0x3b5e5a07, + 0x3b5e5a07, 0x3b5e5a07, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbb4e5d1c, + 0xbb4e5d1c, 0xbb4e5d1c, 0xbb4e5d1c, 0xbb4e5d1c, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0x3b3e6030, 0x3b3e6030, 0x3b3e6030, 0x3b3e6030, 0x3b3e6030, 0xbf7ffff5, 0xbf7ffff5, + 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2e6344, 0xbb2e6344, 0xbb2e6344, 0xbb2e6344, 0xbb2e6344, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1e6657, 0x3b1e6657, 0x3b1e6657, + 0x3b1e6657, 0x3b1e6657, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0e6969, + 0xbb0e6969, 0xbb0e6969, 0xbb0e6969, 0xbb0e6969, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, + 0x3f7fffe3, 0x3afcd8f5, 0x3afcd8f5, 0x3afcd8f5, 0x3afcd8f5, 0x3afcd8f5, 0xbf7fffdb, 0xbf7fffdb, + 0xbf7fffdb, 0xbf7fffdb, 0xbf7fffdb, 0xbadcdf18, 0xbadcdf18, 0xbadcdf18, 0xbadcdf18, 0xbadcdf18, + 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3abce53a, 0x3abce53a, 0x3abce53a, + 0x3abce53a, 0x3abce53a, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0x3bd8c4c1, + 0x3bd8c4c1, 0x3bd8c4c1, 0x3bd8c4c1, 0x3bd8c4c1, 0x3f7fff30, 0x3f7fff30, 0x3f7fff30, 0x3f7fff30, + 0x3f7fff30, 0x3a79e2f5, 0x3a79e2f5, 0x3a79e2f5, 0x3a79e2f5, 0x3a79e2f5, 0xbf7fffb1, 0xbf7fffb1, + 0xbf7fffb1, 0xbf7fffb1, 0xbf7fffb1, 0x3be8c199, 0x3be8c199, 0x3be8c199, 0x3be8c199, 0x3be8c199, + 0x3f7fff57, 0x3f7fff57, 0x3f7fff57, 0x3f7fff57, 0x3f7fff57, 0x39f3f6e7, 0x39f3f6e7, 0x39f3f6e7, + 0x39f3f6e7, 0x39f3f6e7, 0xbf7fff96, 0xbf7fff96, 0xbf7fff96, 0xbf7fff96, 0xbf7fff96, 0x3bf8be6d, + 0x3bf8be6d, 0x3bf8be6d, 0x3bf8be6d, 0x3bf8be6d, 0x3f7fff79, 0x3f7fff79, 0x3f7fff79, 0x3f7fff79, + 0x3f7fff79, 0xb7bd81ff, 0xb7bd81ff, 0xb7bd81ff, 0xb7bd81ff, 0xb7bd81ff, 0xbf7fff76, 0xbf7fff76, + 0xbf7fff76, 0xbf7fff76, 0xbf7fff76, 0xbbf7436c, 0xbbf7436c, 0xbbf7436c, 0xbbf7436c, 0xbbf7436c, + 0x3f7fff98, 0x3f7fff98, 0x3f7fff98, 0x3f7fff98, 0x3f7fff98, 0xba05d393, 0xba05d393, 0xba05d393, + 0xba05d393, 0xba05d393, 0xbf7fff53, 0xbf7fff53, 0xbf7fff53, 0xbf7fff53, 0xbf7fff53, 0xbbe74697, + 0xbbe74697, 0xbbe74697, 0xbbe74697, 0xbbe74697, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, + 0x3f7fffb3, 0xba82dd8a, 0xba82dd8a, 0xba82dd8a, 0xba82dd8a, 0xba82dd8a, 0xbf7fff2c, 0xbf7fff2c, + 0xbf7fff2c, 0xbf7fff2c, 0xbf7fff2c, 0xbbd749bf, 0xbbd749bf, 0xbbd749bf, 0xbbd749bf, 0xbbd749bf, + 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0xbac2d149, 0xbac2d149, 0xbac2d149, + 0xbac2d149, 0xbac2d149, 0xbf7fff01, 0xbf7fff01, 0xbf7fff01, 0xbf7fff01, 0xbf7fff01, 0xbbc74ce4, + 0xbbc74ce4, 0xbbc74ce4, 0xbbc74ce4, 0xbbc74ce4, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, + 0x3f7fffdd, 0xbb016282, 0xbb016282, 0xbb016282, 0xbb016282, 0xbb016282, 0xbf7ffed2, 0xbf7ffed2, +] )) ), + +################ chunk 16384 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x48063b87, 0x48063b87, 0x48063b87, 0x48067153, 0x48067153, 0x48067153, 0x48067153, 0x48067153, + 0x4806a720, 0x4806a720, 0x4806a720, 0x4806a720, 0x4806a720, 0x4806dced, 0x4806dced, 0x4806dced, + 0x4806dced, 0x4806dced, 0x480712ba, 0x480712ba, 0x480712ba, 0x480712ba, 0x480712ba, 0x48074886, + 0x48074886, 0x48074886, 0x48074886, 0x48074886, 0x48077e53, 0x48077e53, 0x48077e53, 0x48077e53, + 0x48077e53, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807e9ed, 0x4807e9ed, + 0x4807e9ed, 0x4807e9ed, 0x4807e9ed, 0x48081fb9, 0x48081fb9, 0x48081fb9, 0x48081fb9, 0x48081fb9, + 0x48085586, 0x48085586, 0x48085586, 0x48085586, 0x48085586, 0x48088b53, 0x48088b53, 0x48088b53, + 0x48088b53, 0x48088b53, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808f6ec, + 0x4808f6ec, 0x4808f6ec, 0x4808f6ec, 0x4808f6ec, 0x48092cb9, 0x48092cb9, 0x48092cb9, 0x48092cb9, + 0x48092cb9, 0x48096286, 0x48096286, 0x48096286, 0x48096286, 0x48096286, 0x48099852, 0x48099852, + 0x48099852, 0x48099852, 0x48099852, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, + 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a39b9, 0x480a39b9, 0x480a39b9, + 0x480a39b9, 0x480a39b9, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480aa552, + 0x480aa552, 0x480aa552, 0x480aa552, 0x480aa552, 0x480adb1f, 0x480adb1f, 0x480adb1f, 0x480adb1f, + 0x480adb1f, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b46b8, 0x480b46b8, + 0x480b46b8, 0x480b46b8, 0x480b46b8, 0x480b7c85, 0x480b7c85, 0x480b7c85, 0x480b7c85, 0x480b7c85, + 0x480bb252, 0x480bb252, 0x480bb252, 0x480bb252, 0x480bb252, 0x480be81f, 0x480be81f, 0x480be81f, + 0x480be81f, 0x480be81f, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c53b8, + 0x480c53b8, 0x480c53b8, 0x480c53b8, 0x480c53b8, 0x480c8985, 0x480c8985, 0x480c8985, 0x480c8985, + 0x480c8985, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cf51e, 0x480cf51e, + 0x480cf51e, 0x480cf51e, 0x480cf51e, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, + 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d9685, 0x480d9685, 0x480d9685, + 0x480d9685, 0x480d9685, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480e021e, + 0x480e021e, 0x480e021e, 0x480e021e, 0x480e021e, 0x480e37eb, 0x480e37eb, 0x480e37eb, 0x480e37eb, + 0x480e37eb, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480ea384, 0x480ea384, + 0x480ea384, 0x480ea384, 0x480ea384, 0x480ed951, 0x480ed951, 0x480ed951, 0x480ed951, 0x480ed951, + 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f44eb, 0x480f44eb, 0x480f44eb, + 0x480f44eb, 0x480f44eb, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480fb084, + 0x480fb084, 0x480fb084, 0x480fb084, 0x480fb084, 0x480fe651, 0x480fe651, 0x480fe651, 0x480fe651, + 0x480fe651, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x481051ea, 0x481051ea, + 0x481051ea, 0x481051ea, 0x481051ea, 0x481087b7, 0x481087b7, 0x481087b7, 0x481087b7, 0x481087b7, + 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810f350, 0x4810f350, 0x4810f350, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0xbf7ffed2, 0xbf7ffed2, 0xbf7ffed2, 0xbbb75005, 0xbbb75005, 0xbbb75005, 0xbbb75005, 0xbbb75005, + 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0xbb215c5e, 0xbb215c5e, 0xbb215c5e, + 0xbb215c5e, 0xbb215c5e, 0xbf7ffe9f, 0xbf7ffe9f, 0xbf7ffe9f, 0xbf7ffe9f, 0xbf7ffe9f, 0xbba75324, + 0xbba75324, 0xbba75324, 0xbba75324, 0xbba75324, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, + 0x3f7ffff6, 0xbb415637, 0xbb415637, 0xbb415637, 0xbb415637, 0xbb415637, 0xbf7ffe68, 0xbf7ffe68, + 0xbf7ffe68, 0xbf7ffe68, 0xbf7ffe68, 0xbb975640, 0xbb975640, 0xbb975640, 0xbb975640, 0xbb975640, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb61500e, 0xbb61500e, 0xbb61500e, + 0xbb61500e, 0xbb61500e, 0xbf7ffe2c, 0xbf7ffe2c, 0xbf7ffe2c, 0xbf7ffe2c, 0xbf7ffe2c, 0xbb875959, + 0xbb875959, 0xbb875959, 0xbb875959, 0xbb875959, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0xbb80a4f0, 0xbb80a4f0, 0xbb80a4f0, 0xbb80a4f0, 0xbb80a4f0, 0xbf7ffe12, 0xbf7ffe12, + 0xbf7ffe12, 0xbf7ffe12, 0xbf7ffe12, 0xbb6eb8e1, 0xbb6eb8e1, 0xbb6eb8e1, 0xbb6eb8e1, 0xbb6eb8e1, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0xbb90a1d8, 0xbb90a1d8, 0xbb90a1d8, + 0xbb90a1d8, 0xbb90a1d8, 0xbf7ffe4f, 0xbf7ffe4f, 0xbf7ffe4f, 0xbf7ffe4f, 0xbf7ffe4f, 0xbb4ebf0c, + 0xbb4ebf0c, 0xbb4ebf0c, 0xbb4ebf0c, 0xbb4ebf0c, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f7ffffa, 0xbba09ebd, 0xbba09ebd, 0xbba09ebd, 0xbba09ebd, 0xbba09ebd, 0xbf7ffe88, 0xbf7ffe88, + 0xbf7ffe88, 0xbf7ffe88, 0xbf7ffe88, 0xbb2ec534, 0xbb2ec534, 0xbb2ec534, 0xbb2ec534, 0xbb2ec534, + 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0xbbb09b9f, 0xbbb09b9f, 0xbbb09b9f, + 0xbbb09b9f, 0xbbb09b9f, 0xbf7ffebd, 0xbf7ffebd, 0xbf7ffebd, 0xbf7ffebd, 0xbf7ffebd, 0xbb0ecb59, + 0xbb0ecb59, 0xbb0ecb59, 0xbb0ecb59, 0xbb0ecb59, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, + 0x3f7fffe3, 0xbbc0987f, 0xbbc0987f, 0xbbc0987f, 0xbbc0987f, 0xbbc0987f, 0xbf7ffeee, 0xbf7ffeee, + 0xbf7ffeee, 0xbf7ffeee, 0xbf7ffeee, 0xbadda2f9, 0xbadda2f9, 0xbadda2f9, 0xbadda2f9, 0xbadda2f9, + 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0xbbd0955c, 0xbbd0955c, 0xbbd0955c, + 0xbbd0955c, 0xbbd0955c, 0xbf7fff1a, 0xbf7fff1a, 0xbf7fff1a, 0xbf7fff1a, 0xbf7fff1a, 0xba9daf3b, + 0xba9daf3b, 0xba9daf3b, 0xba9daf3b, 0xba9daf3b, 0x3f7fffbd, 0x3f7fffbd, 0x3f7fffbd, 0x3f7fffbd, + 0x3f7fffbd, 0xbbe09236, 0xbbe09236, 0xbbe09236, 0xbbe09236, 0xbbe09236, 0xbf7fff43, 0xbf7fff43, + 0xbf7fff43, 0xbf7fff43, 0xbf7fff43, 0xba3b76f7, 0xba3b76f7, 0xba3b76f7, 0xba3b76f7, 0xba3b76f7, + 0x3f7fffa4, 0x3f7fffa4, 0x3f7fffa4, 0x3f7fffa4, 0x3f7fffa4, 0xbbf08f0c, 0xbbf08f0c, 0xbbf08f0c, + 0xbbf08f0c, 0xbbf08f0c, 0xbf7fff68, 0xbf7fff68, 0xbf7fff68, 0xbf7fff68, 0xbf7fff68, 0xb96e3dd0, + 0xb96e3dd0, 0xb96e3dd0, 0xb96e3dd0, 0xb96e3dd0, 0x3f7fff87, 0x3f7fff87, 0x3f7fff87, 0x3f7fff87, + 0x3f7fff87, 0x3bff72cd, 0x3bff72cd, 0x3bff72cd, 0x3bff72cd, 0x3bff72cd, 0xbf7fff89, 0xbf7fff89, + 0xbf7fff89, 0xbf7fff89, 0xbf7fff89, 0x3988b01f, 0x3988b01f, 0x3988b01f, 0x3988b01f, 0x3988b01f, + 0x3f7fff66, 0x3f7fff66, 0x3f7fff66, 0x3f7fff66, 0x3f7fff66, 0x3bef75fa, 0x3bef75fa, 0x3bef75fa, +] )) ), + +################ chunk 16896 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4810f350, 0x4810f350, 0x4811291d, 0x4811291d, 0x4811291d, 0x4811291d, 0x4811291d, 0x48115eea, + 0x48115eea, 0x48115eea, 0x48115eea, 0x48115eea, 0x481194b7, 0x481194b7, 0x481194b7, 0x481194b7, + 0x481194b7, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x48120050, 0x48120050, + 0x48120050, 0x48120050, 0x48120050, 0x4812361d, 0x4812361d, 0x4812361d, 0x4812361d, 0x4812361d, + 0x48126bea, 0x48126bea, 0x48126bea, 0x48126bea, 0x48126bea, 0x4812a1b6, 0x4812a1b6, 0x4812a1b6, + 0x4812a1b6, 0x4812a1b6, 0x4812d783, 0x4812d783, 0x4812d783, 0x4812d783, 0x4812d783, 0x48130d50, + 0x48130d50, 0x48130d50, 0x48130d50, 0x48130d50, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, + 0x4813431d, 0x481378e9, 0x481378e9, 0x481378e9, 0x481378e9, 0x481378e9, 0x4813aeb6, 0x4813aeb6, + 0x4813aeb6, 0x4813aeb6, 0x4813aeb6, 0x4813e483, 0x4813e483, 0x4813e483, 0x4813e483, 0x4813e483, + 0x48141a50, 0x48141a50, 0x48141a50, 0x48141a50, 0x48141a50, 0x4814501c, 0x4814501c, 0x4814501c, + 0x4814501c, 0x4814501c, 0x481485e9, 0x481485e9, 0x481485e9, 0x481485e9, 0x481485e9, 0x4814bbb6, + 0x4814bbb6, 0x4814bbb6, 0x4814bbb6, 0x4814bbb6, 0x4814f183, 0x4814f183, 0x4814f183, 0x4814f183, + 0x4814f183, 0x4815274f, 0x4815274f, 0x4815274f, 0x4815274f, 0x4815274f, 0x48155d1c, 0x48155d1c, + 0x48155d1c, 0x48155d1c, 0x48155d1c, 0x481592e9, 0x481592e9, 0x481592e9, 0x481592e9, 0x481592e9, + 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815fe82, 0x4815fe82, 0x4815fe82, + 0x4815fe82, 0x4815fe82, 0x4816344f, 0x4816344f, 0x4816344f, 0x4816344f, 0x4816344f, 0x48166a1c, + 0x48166a1c, 0x48166a1c, 0x48166a1c, 0x48166a1c, 0x48169fe9, 0x48169fe9, 0x48169fe9, 0x48169fe9, + 0x48169fe9, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x48170b82, 0x48170b82, + 0x48170b82, 0x48170b82, 0x48170b82, 0x4817414f, 0x4817414f, 0x4817414f, 0x4817414f, 0x4817414f, + 0x4817771b, 0x4817771b, 0x4817771b, 0x4817771b, 0x4817771b, 0x4817ace8, 0x4817ace8, 0x4817ace8, + 0x4817ace8, 0x4817ace8, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x48181882, + 0x48181882, 0x48181882, 0x48181882, 0x48181882, 0x48184e4e, 0x48184e4e, 0x48184e4e, 0x48184e4e, + 0x48184e4e, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818b9e8, 0x4818b9e8, + 0x4818b9e8, 0x4818b9e8, 0x4818b9e8, 0x4818efb5, 0x4818efb5, 0x4818efb5, 0x4818efb5, 0x4818efb5, + 0x48192581, 0x48192581, 0x48192581, 0x48192581, 0x48192581, 0x48195b4e, 0x48195b4e, 0x48195b4e, + 0x48195b4e, 0x48195b4e, 0x44800000, 0x44802000, 0x447fc000, 0x44801000, 0x447fe000, 0x45000000, + 0x45001000, 0x44ffe000, 0x45000800, 0x44fff000, 0x45800000, 0x45800800, 0x457ff000, 0x45800400, + 0x457ff800, 0x46000000, 0x46000400, 0x45fff800, 0x46000200, 0x45fffc00, 0x46800000, 0x46800200, + 0x467ffc00, 0x46800100, 0x467ffe00, 0x47000000, 0x47000100, 0x46fffe00, 0x47000080, 0x46ffff00, + 0x47800000, 0x47800080, 0x477fff00, 0x47800040, 0x477fff80, 0x48000000, 0x48000040, 0x47ffff80, + 0x48000020, 0x47ffffc0, 0x48800000, 0x48800020, 0x487fffc0, 0x48800010, 0x487fffe0, 0x49000000, + 0x49000010, 0x48ffffe0, 0x49000008, 0x48fffff0, 0x49800000, 0x49800008, 0x497ffff0, 0x49800004, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3bef75fa, 0x3bef75fa, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0x3a443f92, + 0x3a443f92, 0x3a443f92, 0x3a443f92, 0x3a443f92, 0x3f7fff41, 0x3f7fff41, 0x3f7fff41, 0x3f7fff41, + 0x3f7fff41, 0x3bdf7924, 0x3bdf7924, 0x3bdf7924, 0x3bdf7924, 0x3bdf7924, 0xbf7fffbf, 0xbf7fffbf, + 0xbf7fffbf, 0xbf7fffbf, 0xbf7fffbf, 0x3aa21389, 0x3aa21389, 0x3aa21389, 0x3aa21389, 0x3aa21389, + 0x3f7fff17, 0x3f7fff17, 0x3f7fff17, 0x3f7fff17, 0x3f7fff17, 0x3bcf7c4a, 0x3bcf7c4a, 0x3bcf7c4a, + 0x3bcf7c4a, 0x3bcf7c4a, 0xbf7fffd3, 0xbf7fffd3, 0xbf7fffd3, 0xbf7fffd3, 0xbf7fffd3, 0x3ae20746, + 0x3ae20746, 0x3ae20746, 0x3ae20746, 0x3ae20746, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, + 0x3f7ffeea, 0x3bbf7f6d, 0x3bbf7f6d, 0x3bbf7f6d, 0x3bbf7f6d, 0x3bbf7f6d, 0xbf7fffe4, 0xbf7fffe4, + 0xbf7fffe4, 0xbf7fffe4, 0xbf7fffe4, 0x3b10fd80, 0x3b10fd80, 0x3b10fd80, 0x3b10fd80, 0x3b10fd80, + 0x3f7ffeb9, 0x3f7ffeb9, 0x3f7ffeb9, 0x3f7ffeb9, 0x3f7ffeb9, 0x3baf828d, 0x3baf828d, 0x3baf828d, + 0x3baf828d, 0x3baf828d, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0x3b30f75b, + 0x3b30f75b, 0x3b30f75b, 0x3b30f75b, 0x3b30f75b, 0x3f7ffe84, 0x3f7ffe84, 0x3f7ffe84, 0x3f7ffe84, + 0x3f7ffe84, 0x3b9f85aa, 0x3b9f85aa, 0x3b9f85aa, 0x3b9f85aa, 0x3b9f85aa, 0xbf7ffffa, 0xbf7ffffa, + 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b50f133, 0x3b50f133, 0x3b50f133, 0x3b50f133, 0x3b50f133, + 0x3f7ffe4b, 0x3f7ffe4b, 0x3f7ffe4b, 0x3f7ffe4b, 0x3f7ffe4b, 0x3b8f88c5, 0x3b8f88c5, 0x3b8f88c5, + 0x3b8f88c5, 0x3b8f88c5, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b70eb07, + 0x3b70eb07, 0x3b70eb07, 0x3b70eb07, 0x3b70eb07, 0x3f7ffe0e, 0x3f7ffe0e, 0x3f7ffe0e, 0x3f7ffe0e, + 0x3f7ffe0e, 0x3b7f17bb, 0x3b7f17bb, 0x3b7f17bb, 0x3b7f17bb, 0x3b7f17bb, 0xbf800000, 0xbf800000, + 0xbf800000, 0xbf800000, 0xbf800000, 0x3b88726c, 0x3b88726c, 0x3b88726c, 0x3b88726c, 0x3b88726c, + 0x3f7ffe31, 0x3f7ffe31, 0x3f7ffe31, 0x3f7ffe31, 0x3f7ffe31, 0x3b5f1de8, 0x3b5f1de8, 0x3b5f1de8, + 0x3b5f1de8, 0x3b5f1de8, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0x3b986f52, + 0x3b986f52, 0x3b986f52, 0x3b986f52, 0x3b986f52, 0x3f7ffe6b, 0x3f7ffe6b, 0x3f7ffe6b, 0x3f7ffe6b, + 0x3f7ffe6b, 0x3b3f2411, 0x3b3f2411, 0x3b3f2411, 0x3b3f2411, 0x3b3f2411, 0xbf7ffff6, 0xbf7ffff6, + 0xbf7ffff6, 0xbf7ffff6, 0xbf7ffff6, 0x3ba86c36, 0x3ba86c36, 0x3ba86c36, 0x3ba86c36, 0x3ba86c36, + 0x3f7ffea2, 0x3f7ffea2, 0x3f7ffea2, 0x3f7ffea2, 0x3f7ffea2, 0x3b1f2a38, 0x3b1f2a38, 0x3b1f2a38, + 0x3b1f2a38, 0x3b1f2a38, 0x3f7cc335, 0x3f2ab809, 0x3eccd5bd, 0x3f7146fa, 0x3f4a5cdb, 0x3f7321ca, + 0x3f46cd6d, 0x3e7fb55b, 0x3f7bca72, 0x3f2ef22c, 0x3f4dd254, 0x3f6f4d37, 0xbd871e6c, 0x3f7d9b8c, + 0x3ed7495d, 0x3e95ea1f, 0x3f7679a2, 0xbf2579d9, 0x3f372298, 0xbe4e4a80, 0xbf541ad1, 0x3cc09e69, + 0xbf6b3881, 0xbeead545, 0xbf7edcc1, 0x3ebef1b5, 0xbf144ab6, 0x3f7b759c, 0xbdf0c04d, 0x3f45a9c6, + 0xbf38ca2a, 0xbf78ecb7, 0x3e44f5d5, 0xbf771b81, 0xbe9a753e, 0x3d2c676b, 0x3f5d0c2d, 0xbf51675e, + 0x3f041491, 0xbee25604, 0xbf7f17ca, 0xbeef6b22, 0xbf1bf202, 0xbf558adb, 0xbf6a3014, 0x3f7c60cc, + 0x3ec8816c, 0x3f2c77db, 0x3f48e90f, 0x3f720e0d, 0x3f719d6d, 0x3e6d67d9, 0x3f49bd23, 0x3f2b7984, +] )) ), + +################ chunk 17408 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x497ffff8, 0x4a000000, 0x4a000004, 0x49fffff8, 0x4a000002, 0x49fffffc, 0x4a800000, 0x4a800002, + 0x4a7ffffc, 0x4a800001, 0x4a7ffffe, 0x4b000000, 0x4b000001, 0x4afffffe, 0x4b000000, 0x4affffff, + 0x4b800000, 0x4b800000, 0x4b7fffff, 0x4b800000, 0x4b800000, 0x4c000000, 0x4c000000, 0x4c000000, + 0x4c000000, 0x4c000000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4d000000, + 0x4d000000, 0x4d000000, 0x4d000000, 0x4d000000, 0x4d800000, 0x4d800000, 0x4d800000, 0x4d800000, + 0x4d800000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e800000, 0x4e800000, + 0x4e800000, 0x4e800000, 0x4e800000, 0x4f000000, 0x4f000000, 0x4f000000, 0x4f000000, 0x4f000000, + 0x4f800000, 0x4f800000, 0x4f800000, 0x4f800000, 0x4f800000, 0x50000000, 0x50000000, 0x50000000, + 0x50000000, 0x50000000, 0x50800000, 0x50800000, 0x50800000, 0x50800000, 0x50800000, 0x51000000, + 0x51000000, 0x51000000, 0x51000000, 0x51000000, 0x51800000, 0x51800000, 0x51800000, 0x51800000, + 0x51800000, 0x52000000, 0x52000000, 0x52000000, 0x52000000, 0x52000000, 0x52800000, 0x52800000, + 0x52800000, 0x52800000, 0x52800000, 0x53000000, 0x53000000, 0x53000000, 0x53000000, 0x53000000, + 0x53800000, 0x53800000, 0x53800000, 0x53800000, 0x53800000, 0x54000000, 0x54000000, 0x54000000, + 0x54000000, 0x54000000, 0x54800000, 0x54800000, 0x54800000, 0x54800000, 0x54800000, 0x55000000, + 0x55000000, 0x55000000, 0x55000000, 0x55000000, 0x55800000, 0x55800000, 0x55800000, 0x55800000, + 0x55800000, 0x56000000, 0x56000000, 0x56000000, 0x56000000, 0x56000000, 0x56800000, 0x56800000, + 0x56800000, 0x56800000, 0x56800000, 0x57000000, 0x57000000, 0x57000000, 0x57000000, 0x57000000, + 0x57800000, 0x57800000, 0x57800000, 0x57800000, 0x57800000, 0x58000000, 0x58000000, 0x58000000, + 0x58000000, 0x58000000, 0x58800000, 0x58800000, 0x58800000, 0x58800000, 0x58800000, 0x447a0000, + 0x44898000, 0x44610000, 0x447a4000, 0x4479c000, 0x461c4000, 0x462be000, 0x460ca000, 0x461c4400, + 0x461c3c00, 0x47c35000, 0x47d6d800, 0x47afc800, 0x47c35080, 0x47c34f80, 0x49742400, 0x49864700, + 0x495bba00, 0x49742410, 0x497423f0, 0x4b189680, 0x4b27d8c0, 0x4b095440, 0x4b189681, 0x4b18967f, + 0x4cbebc20, 0x4cd1cef0, 0x4caba950, 0x4cbebc20, 0x4cbebc20, 0x4e6e6b28, 0x4e832156, 0x4e5693a4, + 0x4e6e6b28, 0x4e6e6b28, 0x501502f9, 0x5023e9ac, 0x50061c46, 0x501502f9, 0x501502f9, 0x51ba43b7, + 0x51cce416, 0x51a7a358, 0x51ba43b7, 0x51ba43b7, 0x5368d4a5, 0x53800e8e, 0x53518c2e, 0x5368d4a5, + 0x5368d4a5, 0x551184e7, 0x55201231, 0x5502f79d, 0x551184e7, 0x551184e7, 0x56b5e621, 0x56c816be, + 0x56a3b584, 0x56b5e621, 0x56b5e621, 0x58635fa9, 0x587a1c6d, 0x584ca2e5, 0x58635fa9, 0x58635fa9, + 0x5a0e1bca, 0x5a1c51c4, 0x59ffcb9e, 0x5a0e1bca, 0x5a0e1bca, 0x5bb1a2bc, 0x5bc36635, 0x5b9fdf43, + 0x5bb1a2bc, 0x5bb1a2bc, 0x5d5e0b6b, 0x5d743fc3, 0x5d47d714, 0x5d5e0b6b, 0x5d5e0b6b, 0x44fa0000, + 0x469c4000, 0x453b8000, 0x46ea6000, 0x459c4000, 0x47435000, 0x45fa0000, 0x479c4000, 0x464b2000, + 0x47fde800, 0x46a41000, 0x484d1400, 0x4704d000, 0x48a60400, 0x4756d800, 0x49064700, 0x47add400, + 0x49594900, 0x480ca000, 0x49afc800, 0x48638a00, 0x4a0e3640, 0x48b81500, 0x4a661a40, 0x4914ed00, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7c9976, 0x3f481391, 0xbdd246fe, 0x3f727cf9, 0x3ec608e0, 0x3f7c265c, 0x3e62f4a2, 0xbf336723, + 0x3f70b717, 0xbe8bc65d, 0x3f29793c, 0xbf66d965, 0xbf59d77f, 0xbdfceb5f, 0xbf66d965, 0xbf1589c3, + 0x3f2056b4, 0x3f2056b4, 0xbea29962, 0x3f2056b4, 0x3f2056b4, 0xbe5c9c0d, 0xbe5c9c0d, 0xbe5c9c0d, + 0xbe5c9c0d, 0xbe5c9c0d, 0xbf683c6d, 0xbf683c6d, 0xbf683c6d, 0xbf683c6d, 0xbf683c6d, 0x3f255b29, + 0x3f255b29, 0x3f255b29, 0x3f255b29, 0x3f255b29, 0xbe298aea, 0xbe298aea, 0xbe298aea, 0xbe298aea, + 0xbe298aea, 0xbf71f6e9, 0xbf71f6e9, 0xbf71f6e9, 0xbf71f6e9, 0xbf71f6e9, 0x3f4965a3, 0x3f4965a3, + 0x3f4965a3, 0x3f4965a3, 0x3f4965a3, 0x3e738617, 0x3e738617, 0x3e738617, 0x3e738617, 0x3e738617, + 0xbf630b05, 0xbf630b05, 0xbf630b05, 0xbf630b05, 0xbf630b05, 0x3f12b918, 0x3f12b918, 0x3f12b918, + 0x3f12b918, 0x3f12b918, 0xbeafa16c, 0xbeafa16c, 0xbeafa16c, 0xbeafa16c, 0xbeafa16c, 0xbf43c0f5, + 0xbf43c0f5, 0xbf43c0f5, 0xbf43c0f5, 0xbf43c0f5, 0x3e2d7c30, 0x3e2d7c30, 0x3e2d7c30, 0x3e2d7c30, + 0x3e2d7c30, 0xbf714ddd, 0xbf714ddd, 0xbf714ddd, 0xbf714ddd, 0xbf714ddd, 0x3f46e765, 0x3f46e765, + 0x3f46e765, 0x3f46e765, 0x3f46e765, 0x3e54560d, 0x3e54560d, 0x3e54560d, 0x3e54560d, 0x3e54560d, + 0xbf69fc2c, 0xbf69fc2c, 0xbf69fc2c, 0xbf69fc2c, 0xbf69fc2c, 0x3f2bba00, 0x3f2bba00, 0x3f2bba00, + 0x3f2bba00, 0x3f2bba00, 0xbdccdfcd, 0xbdccdfcd, 0xbdccdfcd, 0xbdccdfcd, 0xbdccdfcd, 0xbf7ae054, + 0xbf7ae054, 0xbf7ae054, 0xbf7ae054, 0xbf7ae054, 0x3f6bb5d3, 0x3f6bb5d3, 0x3f6bb5d3, 0x3f6bb5d3, + 0x3f6bb5d3, 0x3f320ea5, 0x3f320ea5, 0x3f320ea5, 0x3f320ea5, 0x3f320ea5, 0xbd04f439, 0xbd04f439, + 0xbd04f439, 0xbd04f439, 0xbd04f439, 0xbf7f75e6, 0xbf7f75e6, 0xbf7f75e6, 0xbf7f75e6, 0xbf7f75e6, + 0x3f7dd82f, 0x3f7dd82f, 0x3f7dd82f, 0x3f7dd82f, 0x3f7dd82f, 0x3f776a06, 0x3f776a06, 0x3f776a06, + 0x3f776a06, 0x3f776a06, 0x3f5e3b89, 0x3f5e3b89, 0x3f5e3b89, 0x3f5e3b89, 0x3f5e3b89, 0x3f0ff813, + 0x3f6755d6, 0x3d87ac5a, 0xbec8ac6a, 0x3f7fe90e, 0xbf73c074, 0xbe90c6b4, 0xbf49c612, 0xbe83bb01, + 0xbf4588b7, 0xbf7fd61c, 0x3f766492, 0x3f70cc91, 0xbf11ee0b, 0xbf028731, 0x3f6fcefd, 0xbf6c73c5, + 0xbf72dbb9, 0x3f4cf6a9, 0x3e58b2e7, 0xbf6842df, 0xbf33e40c, 0xbf7f4067, 0xbf581590, 0xbe0b97de, + 0xbeba0d9c, 0xbd7e6746, 0x3f38b364, 0xbeba0d9c, 0xbeba0d9c, 0x3f567fc6, 0xbf502115, 0x3e50f35d, + 0x3f567fc6, 0x3f567fc6, 0x3f5f84c5, 0xbf7ffbb7, 0xbf08cd09, 0x3f5f84c5, 0x3f5f84c5, 0x3d7bcaec, + 0x3ecccf4b, 0xbe91adb3, 0x3d7bcaec, 0x3d7bcaec, 0x3f7ff1d1, 0x3f7a1d5e, 0x3f77a0c4, 0x3f7ff1d1, + 0x3f7ff1d1, 0x3e7d7d10, 0xbecbb4d6, 0x3f4a0824, 0x3e7d7d10, 0x3e7d7d10, 0x3e8227f6, 0xbf7c4b5b, + 0x3f7106dd, 0x3e8227f6, 0x3e8227f6, 0x3dd7c630, 0x3f7f16bb, 0xbf74e752, 0x3dd7c630, 0x3dd7c630, + 0x3f5e34db, 0xbe10aaab, 0xbefc7e1d, 0x3f5e34db, 0x3f5e34db, 0xbf525898, 0xbe1c5bca, 0xbf7aa99b, + 0xbf525898, 0xbf525898, 0x3f79ea33, 0x3eed92ef, 0x3f7e0366, 0x3f79ea33, 0x3f79ea33, 0xbebc23a8, + 0x3f502ddb, 0xbf79c64f, 0xbf18af9b, 0x3e1e6165, 0xbc927353, 0x3d8670f4, 0xbf4ab84c, 0x3f7ef91d, + 0x3f1fef22, 0xbcc3d401, 0xbf78b80e, 0xbde7f668, 0xbed819fd, 0xbf7d963b, 0x3e4815a7, 0x3e7e4125, + 0x3f4e7e68, 0xbec1ddfc, 0x3f3cbf1b, 0x3f4d7356, 0x3f7e788c, 0xbf5b2664, 0x3f28be92, 0xbf7ed1f5, +] )) ), + +################ chunk 17920 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4aba2840, 0x4970f780, 0x4b169ab0, 0x49c2f240, 0x4b73aed0, 0x4a1db700, 0x4bc524c0, 0x4a7f3020, + 0x4c1f7e14, 0x4ace7390, 0x4c81083a, 0x4b2705d0, 0x4cd0c744, 0x47c54400, 0x49769500, 0x4b1a1d20, + 0x439ea683, 0x431ea683, 0x47c92c00, 0x497b7700, 0x4b1d2a60, 0x43a1cac2, 0x4321cac2, 0x47d0fc00, + 0x49829d80, 0x4b2344e0, 0x43a81341, 0x43281341, 0x47d4e400, 0x49850e80, 0x4b265220, 0x43ab3780, + 0x432b3780, 0x47dcb400, 0x4989f080, 0x4b2c6ca0, 0x43b17fff, 0x43317fff, 0x47f80c00, 0x499b0780, + 0x4b41c960, 0x43c77dbb, 0x43477dbb, 0x47ffdc00, 0x499fe980, 0x4b47e3e0, 0x43cdc63a, 0x434dc63a, + 0x4805ca00, 0x49a73c80, 0x4b510ba0, 0x43d732f8, 0x435732f8, 0x4807be00, 0x49a9ad80, 0x4b5418e0, + 0x43da5737, 0x435a5737, 0x48118200, 0x49b5e280, 0x4b635b20, 0x43ea0c75, 0x436a0c75, 0x48137600, + 0x49b85380, 0x4b666860, 0x43ed30b4, 0x436d30b4, 0x48195200, 0x49bfa680, 0x4b6f9020, 0x43f69d72, + 0x43769d72, 0x481f2e00, 0x49c6f980, 0x4b78b7e0, 0x44000518, 0x43800518, 0x48231600, 0x49cbdb80, + 0x4b7ed260, 0x44032958, 0x43832958, 0x4828f200, 0x49d32e80, 0x4b83fd10, 0x4407dfb7, 0x4387dfb7, + 0x482ece00, 0x49da8180, 0x4b8890f0, 0x440c9616, 0x438c9616, 0x4830c200, 0x49dcf280, 0x4b8a1790, + 0x440e2836, 0x438e2836, 0x483a8600, 0x49e92780, 0x4b91b8b0, 0x441602d4, 0x439602d4, 0x483c7a00, + 0x49eb9880, 0x4b933f50, 0x441794f4, 0x439794f4, 0x48406200, 0x49f07a80, 0x4b964c90, 0x441ab933, + 0x439ab933, 0x48425600, 0x49f2eb80, 0x4b97d330, 0x441c4b53, 0x439c4b53, 0x484e0e00, 0x4a00c8c0, + 0x4ba0faf0, 0x4425b811, 0x43a5b811, 0x4859c600, 0x4a081bc0, 0x4baa22b0, 0x442f24cf, 0x43af24cf, + 0x485dae00, 0x4a0a8cc0, 0x4bad2ff0, 0x4432490f, 0x43b2490f, 0x485fa200, 0x4a0bc540, 0x4baeb690, + 0x4433db2f, 0x43b3db2f, 0x48638a00, 0x4a0e3640, 0x4bb1c3d0, 0x4436ff6e, 0x43b6ff6e, 0x48696600, + 0x4a11dfc0, 0x4bb657b0, 0x443bb5cd, 0x43bbb5cd, 0x486b5a00, 0x4a131840, 0x4bb7de50, 0x443d47ed, + 0x43bd47ed, 0x48751e00, 0x4a1932c0, 0x4bbf7f70, 0x4445228b, 0x43c5228b, 0x487afa00, 0x4a1cdc40, + 0x4bc41350, 0x4449d8ea, 0x43c9d8ea, 0x48806b00, 0x4a2085c0, 0x4bc8a730, 0x444e8f4a, 0x43ce8f4a, + 0x48835900, 0x4a242f40, 0x4bcd3b10, 0x445345a9, 0x43d345a9, 0x48845300, 0x4a2567c0, 0x4bcec1b0, + 0x4454d7c8, 0x43d4d7c8, 0x48874100, 0x4a291140, 0x4bd35590, 0x44598e28, 0x43d98e28, 0x48893500, + 0x4a2b8240, 0x4bd662d0, 0x445cb267, 0x43dcb267, 0x488a2f00, 0x4a2cbac0, 0x4bd7e970, 0x445e4487, + 0x43de4487, 0x488f1100, 0x4a32d540, 0x4bdf8a90, 0x44661f25, 0x43e61f25, 0x4895e700, 0x4a3b60c0, + 0x4bea38f0, 0x44711e03, 0x43f11e03, 0x4897db00, 0x4a3dd1c0, 0x4bed4630, 0x44744243, 0x43f44243, + 0x4898d500, 0x4a3f0a40, 0x4beeccd0, 0x4475d462, 0x43f5d462, 0x489ac900, 0x4a417b40, 0x4bf1da10, + 0x4478f8a2, 0x43f8f8a2, 0x48a19f00, 0x4a4a06c0, 0x4bfc8870, 0x4481fbc0, 0x4401fbc0, 0x48a48d00, + 0x4a4db040, 0x4c008e28, 0x448456ef, 0x440456ef, 0x48a96f00, 0x4a53cac0, 0x4c045eb8, 0x4488443f, + 0x4408443f, 0x48aa6900, 0x4a550340, 0x4c052208, 0x44890d4f, 0x44090d4f, 0x48ac5d00, 0x4a577440, + 0x4c06a8a8, 0x448a9f6e, 0x440a9f6e, 0x48af4b00, 0x4a5b1dc0, 0x4c08f298, 0x448cfa9e, 0x440cfa9e, + 0x48b33300, 0x4a5fffc0, 0x4c0bffd8, 0x44901edd, 0x44101edd, 0x45800000, 0x45800000, 0x45800000, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f12b9fa, 0x3f66d451, 0xbe742800, 0xbf70618f, 0xbf6eb6aa, 0xbf32ac11, 0xbe03911c, 0x3ed16cf8, + 0x3ef4c2c8, 0x3ebc6e0e, 0x3f4f4410, 0x3f7fbf18, 0x3f670ed9, 0xbf1771c2, 0xbf7fb7b0, 0x3f644398, + 0xbf800000, 0xb6f82347, 0x3f779be9, 0xbf56f246, 0x3f5b6654, 0xbf800000, 0x358c48ee, 0xbf612c5a, + 0x3e791904, 0x3f465b85, 0xbf800000, 0x3671e04a, 0x3f44032a, 0x3f43277c, 0x3f3a4982, 0xbf800000, + 0x363841cd, 0xbf7fa107, 0x3f5bc79e, 0x3f1f5b2d, 0xbf800000, 0x34485f9f, 0xbee075f7, 0x3e317dfc, + 0x3e2e9430, 0xbf800000, 0x359916d0, 0xbe96afe7, 0x3f7cf5e5, 0x3ce7ca1c, 0xbf800000, 0x3678473b, + 0x3e122bb2, 0xbe0d5375, 0xbe3d9bfc, 0xbf800000, 0x33c3e110, 0xbf791475, 0xbf304b3d, 0xbe82835a, + 0xbf800000, 0xb6d82090, 0x3f5b1844, 0x3f298b9d, 0xbf13c487, 0xbf800000, 0xb6fe8a38, 0xbf4ba8a3, + 0x3f7980f0, 0xbf2253aa, 0xbf800000, 0x35a5e4b3, 0xbeeb7de7, 0xbd88ff18, 0xbf48bfd0, 0xbf800000, + 0x362b73ea, 0xbd1347b8, 0xbf6f9f0d, 0xbf65f79f, 0xbf800000, 0xb6d4ed17, 0x3f35953f, 0x3cff6ff6, + 0xbf73a6c4, 0xbf800000, 0x37407869, 0x3eade70f, 0x3f72b064, 0xbf7ec9dc, 0xbf800000, 0xb700ded8, + 0xbdc31fa2, 0xbf140900, 0xbf7e3e51, 0xbf800000, 0x36828a8f, 0x3f75f834, 0xbf71ef29, 0xbf7b7458, + 0xbf800000, 0xb756bcc2, 0xbf5483fa, 0x3f6ec9ad, 0xbf5abdbd, 0xbf800000, 0xb677b769, 0x3f52d6f1, + 0x3f77e3e5, 0xbf50addd, 0xbf800000, 0xb6af1340, 0xbf7d2545, 0x3d9baade, 0xbf39696b, 0xbf800000, + 0x36fb0ed6, 0x3f0079de, 0xbf04bbc7, 0xbf2c534b, 0xbf800000, 0x35bf8079, 0xbeb37f1b, 0x3f679566, + 0xbe9be2f6, 0xbf800000, 0xb6ce8625, 0xbf724c04, 0xbf7d4f38, 0x3df48f26, 0xbf800000, 0xb7667635, + 0x3ef0c49e, 0xbe3ab3ce, 0x3e84f919, 0xbf800000, 0x3688f180, 0xbf7e5bd3, 0x3ed91181, 0x3ea7f612, + 0xbf800000, 0xb759f03b, 0x3f4d7356, 0x3f7e788c, 0x3eeb2ff1, 0xbf800000, 0xb49be5ea, 0x3f7b08c0, + 0xbec85a45, 0x3f234f1d, 0xbf800000, 0xb66ae986, 0xbf0ae99b, 0xbf5a921c, 0x3f30fa5f, 0xbf800000, + 0xb6b57a32, 0x3f45fbcb, 0x3f55aaa1, 0x3f66860e, 0xbf800000, 0xb739ed83, 0x3edb16be, 0x3e92b65e, + 0x3f78f0ea, 0xbf800000, 0x37798714, 0x395a86ef, 0xbf7fffdc, 0x3f7ff1c5, 0xbf800000, 0x3746df5b, + 0xbedae55c, 0x3e94c173, 0x3f7b366b, 0xbf800000, 0xb70745ca, 0x3f7f7389, 0x3f4b0b97, 0x3f770cae, + 0xbf800000, 0xb76342bc, 0x3f5fbd82, 0x3eb562fd, 0x3f6319ae, 0xbf800000, 0xb75d23b3, 0xbf785956, + 0xbf455781, 0x3f4ff076, 0xbf800000, 0xb5012a80, 0x3f15080f, 0xbf7f621c, 0x3f44bd0a, 0xbf800000, + 0x371d8a22, 0xbf4d83a1, 0x3f7e95cb, 0x3efdeef1, 0xbf800000, 0x36ee40f4, 0xbf694cc6, 0xbee79afd, + 0x3c9659b8, 0xbf800000, 0xb6c1b843, 0x3ec48604, 0x3f32bfa0, 0xbdfeaa7b, 0xbf800000, 0x374a12d3, + 0xbf7ff5c5, 0x3f7c0392, 0xbe479b3b, 0xbf800000, 0x372075b2, 0x3f3dedcc, 0x3ef7c7f3, 0xbeaa5d2a, + 0xbf800000, 0xb70a7943, 0xbe66ad83, 0x3f25327f, 0xbf3e982b, 0xbf800000, 0x3720bd9b, 0x3e5a36ed, + 0x3f0b94b4, 0xbf5e9c60, 0xbf800000, 0x37cf6dfb, 0x3dc3f929, 0xbf1329d1, 0xbf7cc66f, 0xbf800000, + 0x37a63cb7, 0x3f63fefc, 0x3c0f29dc, 0xbf7f05f6, 0xbf800000, 0xb7f0f874, 0xbeadb3ac, 0x3f7306c9, + 0xbf7f9a91, 0xbf800000, 0x37732023, 0xbf3581fc, 0x3cdd4e96, 0xbf76b67d, 0xbf800000, 0x374d464c, + 0x3f2839a0, 0xbf21c123, 0xbf596868, 0xbf800000, 0xb75cdbca, 0x3f4dd254, 0x3f4dd254, 0x3f4dd254, +] )) ), + +################ chunk 18432 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x45800000, 0x46000000, 0x46000000, 0x46000000, 0x46000000, 0x46800000, 0x46800000, 0x46800000, + 0x46800000, 0x47000000, 0x47000000, 0x47000000, 0x47000000, 0x47800000, 0x47800000, 0x47800000, + 0x47800000, 0x48000000, 0x48000000, 0x48000000, 0x48000000, 0x48800000, 0x48800000, 0x48800000, + 0x48800000, 0x49000000, 0x49000000, 0x49000000, 0x49000000, 0x49800000, 0x49800000, 0x49800000, + 0x49800000, 0x4a25e927, 0x4bcf6371, 0x4d819e27, 0x49aca22c, 0x4b57cab8, 0x4c843514, 0x4bafac5d, + 0x4544597b, 0x4546aa6a, 0x45c4597b, 0x45c6aa6a, 0x4613431d, 0x4614ffd0, 0x4644597b, 0x4646aa6a, + 0x46756fda, 0x46785505, 0x4693431d, 0x4694ffd0, 0x46abce4c, 0x46add51d, 0x46c4597b, 0x46c6aa6a, + 0x46dce4ab, 0x46df7fb8, 0x46f56fda, 0x46f85505, 0x4706fd85, 0x47089529, 0x4713431d, 0x4714ffd0, + 0x471f88b4, 0x47216a76, 0x472bce4c, 0x472dd51d, 0x473813e4, 0x473a3fc4, 0x4744597b, 0x4746aa6a, + 0x47509f13, 0x47531511, 0x475ce4ab, 0x475f7fb8, 0x47692a43, 0x476bea5e, 0x47756fda, 0x47785505, + 0x4780dab9, 0x47825fd6, 0x4786fd85, 0x47889529, 0x478d2051, 0x478eca7c, 0x4793431d, 0x4794ffd0, + 0x479965e8, 0x479b3523, 0x479f88b4, 0x47a16a76, 0x47a5ab80, 0x47a79fca, 0x47abce4c, 0x47add51d, + 0x47b1f118, 0x47b40a70, 0x47b813e4, 0x47ba3fc4, 0x47be36b0, 0x47c07517, 0x47c4597b, 0x47c6aa6a, + 0x47ca7c47, 0x47ccdfbe, 0x47d09f13, 0x47d31511, 0x47d6c1df, 0x47d94a64, 0x47dce4ab, 0x47df7fb8, + 0x47e30777, 0x47e5b50b, 0x47e92a43, 0x47ebea5e, 0x47ef4d0e, 0x47f21fb2, 0x47f56fda, 0x47f85505, + 0x47fb92a6, 0x47fe8a58, 0x4800dab9, 0x48025fd6, 0x4803ec1f, 0x48057a7f, 0x4806fd85, 0x48089529, + 0x480a0eeb, 0x480bafd3, 0x480d2051, 0x480eca7c, 0x481031b7, 0x4811e526, 0x4813431d, 0x4814ffd0, + 0x48165482, 0x48181a79, 0x481965e8, 0x481b3523, 0x481c774e, 0x481e4fcd, 0x481f88b4, 0x48216a76, + 0x48229a1a, 0x48248520, 0x4825ab80, 0x48279fca, 0x4828bce6, 0x482aba73, 0x482bce4c, 0x482dd51d, + 0x482edfb2, 0x4830efc7, 0x4831f118, 0x48340a70, 0x4835027e, 0x4837251a, 0x483813e4, 0x483a3fc4, + 0x483b254a, 0x483d5a6d, 0x483e36b0, 0x48407517, 0x48414815, 0x48438fc1, 0x4844597b, 0x4846aa6a, + 0x48476ae1, 0x4849c514, 0x484a7c47, 0x484cdfbe, 0x484d8dad, 0x484ffa67, 0x48509f13, 0x48531511, + 0x4853b079, 0x48562fbb, 0x4856c1df, 0x48594a64, 0x4859d345, 0x485c650e, 0x485ce4ab, 0x485f7fb8, + 0x485ff611, 0x48629a61, 0x48630777, 0x4865b50b, 0x486618dd, 0x4868cfb5, 0x48692a43, 0x486bea5e, + 0x486c3ba8, 0x486f0508, 0x486f4d0e, 0x48721fb2, 0x48725e74, 0x48753a5b, 0x48756fda, 0x48785505, + 0x48788140, 0x487b6fae, 0x487b92a6, 0x487e8a58, 0x487ea40c, 0x4880d281, 0x4880dab9, 0x48825fd6, + 0x4882636c, 0x4883ed2b, 0x4883ec1f, 0x48857a7f, 0x488574d2, 0x488707d4, 0x4886fd85, 0x48889529, + 0x48888638, 0x488a227e, 0x488a0eeb, 0x488bafd3, 0x488b979e, 0x488d3d28, 0x488d2051, 0x488eca7c, + 0x488ea904, 0x489057d1, 0x489031b7, 0x4891e526, 0x4891ba6a, 0x4893727b, 0x4893431d, 0x4894ffd0, + 0x4894cbcf, 0x48968d25, 0x48965482, 0x48981a79, 0x4897dd35, 0x4899a7ce, 0x489965e8, 0x489b3523, + 0x489aee9b, 0x489cc278, 0x489c774e, 0x489e4fcd, 0x489e0001, 0x489fdd22, 0x489f88b4, 0x48a16a76, + 0x48a11167, 0x48a2f7cb, 0x48a29a1a, 0x48a48520, 0x48a422cd, 0x48a61275, 0x48a5ab80, 0x48a79fca, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f4dd254, 0x3e95ea1f, 0x3e95ea1f, 0x3e95ea1f, 0x3e95ea1f, 0xbf541ad1, 0xbf541ad1, 0xbf541ad1, + 0xbf541ad1, 0x3ebef1b5, 0x3ebef1b5, 0x3ebef1b5, 0x3ebef1b5, 0xbf38ca2a, 0xbf38ca2a, 0xbf38ca2a, + 0xbf38ca2a, 0x3d2c676b, 0x3d2c676b, 0x3d2c676b, 0x3d2c676b, 0xbf7f17ca, 0xbf7f17ca, 0xbf7f17ca, + 0xbf7f17ca, 0x3f7c60cc, 0x3f7c60cc, 0x3f7c60cc, 0x3f7c60cc, 0x3f719d6d, 0x3f719d6d, 0x3f719d6d, + 0x3f719d6d, 0x3f7d625f, 0x3f18e481, 0xbf669efe, 0x3f683d76, 0x3f16d598, 0xbed1517f, 0x3f11bd88, + 0x3f800000, 0x3f4d336e, 0x3f7fffff, 0x3e91eda3, 0x3f7fffff, 0xbeb0398e, 0x3f7ffffe, 0xbf566878, + 0x3f7fffff, 0xbf7f80a6, 0x3f7ffffc, 0xbf435868, 0x3f800000, 0xbe662110, 0x3f7ffff8, 0x3ece4b50, + 0x3f800000, 0x3f5e9579, 0x3f7ffffb, 0x3f7e0316, 0x3f7fffff, 0x3f387b8d, 0x3f7fffef, 0x3e287e6a, + 0x3f7ffff0, 0xbeeb8958, 0x3f7fffff, 0xbf662412, 0x3f7ffffa, 0xbf7b94ac, 0x3f7fffdf, 0xbf2ce15b, + 0x3f7ffff9, 0xbdd07819, 0x3f800000, 0x3f030f2b, 0x3f7ffff2, 0x3f6cc678, 0x3f7fffed, 0x3f781440, + 0x3f7fffff, 0x3f215cc8, 0x3f7ffffc, 0x3d1e3acf, 0x3f7fffe5, 0xbf118993, 0x3f7fffbb, 0xbf72233b, + 0x3f7fff84, 0xbf739538, 0x3f7fffc1, 0xbf13a547, 0x3f7fffe9, 0x3caa3c12, 0x3f7ffffd, 0x3f1dc9ad, + 0x3f7ffffe, 0x3f772c65, 0x3f7fffe9, 0x3f6e79be, 0x3f7fffc1, 0x3f06f718, 0x3f7fff7b, 0xbdb4067e, + 0x3f7fffba, 0xbf297b30, 0x3f7fffe5, 0xbf7ab1e5, 0x3f7ffffc, 0xbf67aec7, 0x3f7fffff, 0xbef39de6, + 0x3f7fffed, 0x3e166e45, 0x3f7fffc7, 0x3f35fd0f, 0x3f7fff72, 0x3f7d54da, 0x3f7fffb4, 0x3f60ce7d, + 0x3f7fffe1, 0x3ed4cfc6, 0x3f7ffffa, 0xbe52515b, 0x3f7fffff, 0xbf41ac66, 0x3f7ffff0, 0xbf7f3c67, + 0x3f7fffcd, 0xbf59230c, 0x3f7fff96, 0xbeb50b78, 0x3f7fff4a, 0x3e8a960a, 0x3f7ffeea, 0x3f4a0d40, + 0x3f7ffd7a, 0x3f7ffcb2, 0x3f7ffe11, 0x3f4f893f, 0x3f7ffe94, 0x3e9c1907, 0x3f7fff03, 0xbeab6316, + 0x3f7fff5e, 0xbf542809, 0x3f7fffa5, 0xbf7fc766, 0x3f7fffd7, 0xbf44ff5e, 0x3f7ffff6, 0xbe75f81c, + 0x3f800000, 0x3ec40c27, 0x3f7ffff6, 0x3f5d4d65, 0x3f7fffd8, 0x3f7e7c81, 0x3f7fffa5, 0x3f3c4d2f, + 0x3f7fff5f, 0x3e32a1a0, 0x3f7fff04, 0xbee36190, 0x3f7ffd51, 0xbf63a579, 0x3f7ffded, 0xbf7c0b37, + 0x3f7ffe75, 0xbf303968, 0x3f7ffeea, 0xbdfcc1f0, 0x3f7fff49, 0x3f00d7f8, 0x3f7fff95, 0x3f6affde, + 0x3f7fffcd, 0x3f79653e, 0x3f7ffff0, 0x3f2359c5, 0x3f7fffff, 0x3d674aaa, 0x3f7ffffa, 0xbf0c156e, + 0x3f7fffe1, 0xbf714a69, 0x3f7fffb4, 0xbf74f353, 0x3f7fff73, 0xbf18f704, 0x3f7fff1d, 0x3c2fe867, + 0x3f7ffd26, 0x3f1a29b0, 0x3f7ffdc8, 0x3f7561a5, 0x3f7ffe55, 0x3f6f660b, 0x3f7ffece, 0x3f0ad401, + 0x3f7fff33, 0xbd9f85ff, 0x3f7fff84, 0xbf278b9c, 0x3f7fffc1, 0xbf79baa7, 0x3f7fffe9, 0xbf6a66ce, + 0x3f7ffffd, 0xbeff1866, 0x3f7ffffe, 0x3e142b34, 0x3f7fffea, 0x3f342bb6, 0x3f7fffc1, 0x3f7cf2c6, + 0x3f7fff85, 0x3f62f526, 0x3f7fff34, 0x3ee0b1bc, 0x3f7ffed0, 0xbe38867c, 0x3f7ffe57, 0xbf3ffb64, + 0x3f7ffdca, 0xbf7f0648, 0x3f7ffd29, 0xbf5a7cf3, 0x3f7ffc73, 0xbec14725, 0x3f7ffbaa, 0x3e7bc74b, + 0x3f7ff49b, 0x3f45f348, 0x3f7ff5e8, 0x3f7ff2c6, 0x3f7ff721, 0x3f510800, 0x3f7ff845, 0x3ea0fcf7, + 0x3f7ff956, 0xbe9ef26c, 0x3f7ffa52, 0xbf5068bf, 0x3f7ffb3a, 0xbf7ff7b9, 0x3f7ffc0e, 0xbf46a13d, + 0x3f7ffcce, 0xbe7ff11d, 0x3f7ffd79, 0x3ebf4954, 0x3f7ffe11, 0x3f59ed1f, 0x3f7ffe94, 0x3f7f1db1, +] )) ), + +################ chunk 18944 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x48a73433, 0x48a92d1e, 0x48a8bce6, 0x48aaba73, 0x48aa4599, 0x48ac47c8, 0x48abce4c, 0x48add51d, + 0x48ad56ff, 0x48af6272, 0x48aedfb2, 0x48b0efc7, 0x48b06865, 0x48b27d1b, 0x48b1f118, 0x48b40a70, + 0x48b379cb, 0x48b597c5, 0x48b5027e, 0x48b7251a, 0x48b68b31, 0x48b8b26f, 0x48b813e4, 0x48ba3fc4, + 0x48b99c97, 0x48bbcd18, 0x48bb254a, 0x48bd5a6d, 0x48bcadfd, 0x48bee7c2, 0x48be36b0, 0x48c07517, + 0x48bfbf62, 0x48c2026c, 0x48c14815, 0x48c38fc1, 0x48c2d0c8, 0x48c51d15, 0x48c4597b, 0x48c6aa6a, + 0x48c5e22e, 0x48c837bf, 0x48c76ae1, 0x48c9c514, 0x48c8f394, 0x48cb5269, 0x48ca7c47, 0x48ccdfbe, + 0x48cc04fa, 0x48ce6d12, 0x48cd8dad, 0x48cffa67, 0x48cf1660, 0x48d187bc, 0x48d09f13, 0x48d31511, + 0x48d227c6, 0x48d4a266, 0x48d3b079, 0x48d62fbb, 0x48d5392c, 0x48d7bd0f, 0x48d6c1df, 0x48d94a64, + 0x48d84a92, 0x48dad7b9, 0x48d9d345, 0x48dc650e, 0x48db5bf8, 0x48ddf263, 0x48dce4ab, 0x48df7fb8, + 0x48de6d5e, 0x48e10d0c, 0x48dff611, 0x48e29a61, 0x48e17ec4, 0x48e427b6, 0x48e30777, 0x48e5b50b, + 0x48e4902a, 0x48e74260, 0x48e618dd, 0x48e8cfb5, 0x48e7a190, 0x48ea5d09, 0x48e92a43, 0x48ebea5e, + 0x48eab2f5, 0x48ed77b3, 0x48ec3ba8, 0x48ef0508, 0x48edc45b, 0x48f0925d, 0x48ef4d0e, 0x48f21fb2, + 0x48f0d5c1, 0x48f3ad06, 0x48f25e74, 0x48f53a5b, 0x48f3e727, 0x48f6c7b0, 0x48f56fda, 0x48f85505, + 0x48f6f88d, 0x48f9e25a, 0x48f88140, 0x48fb6fae, 0x48fa09f3, 0x48fcfd03, 0x48fb92a6, 0x48fe8a58, + 0x48fd1b59, 0x49000bd6, 0x48fea40c, 0x4900d281, 0x4900165f, 0x4901992b, 0x4900dab9, 0x49025fd6, + 0x49019f12, 0x49032680, 0x4902636c, 0x4903ed2b, 0x490327c5, 0x4904b3d5, 0x4903ec1f, 0x49057a7f, + 0x4904b078, 0x4906412a, 0x490574d2, 0x490707d4, 0x4906392b, 0x4907ce7f, 0x4906fd85, 0x49089529, + 0x4907c1de, 0x49095bd3, 0x49088638, 0x490a227e, 0x49094a91, 0x490ae928, 0x490a0eeb, 0x490bafd3, + 0x490ad344, 0x490c767d, 0x490b979e, 0x490d3d28, 0x490c5bf7, 0x490e03d2, 0x490d2051, 0x490eca7c, + 0x490de4aa, 0x490f9127, 0x490ea904, 0x491057d1, 0x490f6d5d, 0x49111e7c, 0x491031b7, 0x4911e526, + 0x4910f610, 0x4912abd0, 0x4911ba6a, 0x4913727b, 0x49127ec3, 0x49143925, 0x4913431d, 0x4914ffd0, + 0x49140776, 0x4915c67a, 0x4914cbcf, 0x49168d25, 0x49159029, 0x491753cf, 0x49165482, 0x49181a79, + 0x491718dc, 0x4918e124, 0x4917dd35, 0x4919a7ce, 0x4918a18f, 0x491a6e79, 0x491965e8, 0x491b3523, + 0x491a2a42, 0x491bfbcd, 0x491aee9b, 0x491cc278, 0x491bb2f5, 0x491d8922, 0x491c774e, 0x491e4fcd, + 0x491d3ba8, 0x491f1677, 0x491e0001, 0x491fdd22, 0x491ec45b, 0x4920a3cc, 0x491f88b4, 0x49216a76, + 0x49204d0e, 0x49223121, 0x49211167, 0x4922f7cb, 0x4921d5c1, 0x4923be76, 0x49229a1a, 0x49248520, + 0x49235e74, 0x49254bca, 0x492422cd, 0x49261275, 0x4924e727, 0x4926d91f, 0x4925ab80, 0x49279fca, + 0x49266fda, 0x49286674, 0x49273433, 0x49292d1e, 0x4927f88d, 0x4929f3c9, 0x4928bce6, 0x492aba73, + 0x49298140, 0x492b811e, 0x492a4599, 0x492c47c8, 0x492b09f2, 0x492d0e73, 0x492bce4c, 0x492dd51d, + 0x492c92a5, 0x492e9bc7, 0x492d56ff, 0x492f6272, 0x492e1b58, 0x4930291c, 0x492edfb2, 0x4930efc7, + 0x492fa40b, 0x4931b671, 0x49306865, 0x49327d1b, 0x49312cbe, 0x493343c6, 0x4931f118, 0x49340a70, + 0x4932b571, 0x4934d11b, 0x493379cb, 0x493597c5, 0x49343e24, 0x49365e70, 0x4935027e, 0x4937251a, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fff03, 0x3f3b54b5, 0x3f7fff5e, 0x3e3cc038, 0x3f7fffa5, 0xbedec2f3, 0x3f7fffd7, 0xbf627565, + 0x3f7ffff6, 0xbf7d1c8b, 0x3f800000, 0xbf34eeb2, 0x3f7ffff6, 0xbdf169f4, 0x3f7fffd8, 0x3efd3ae1, + 0x3f7fffa6, 0x3f69f7b4, 0x3f7fff5f, 0x3f79f698, 0x3f7fff05, 0x3f285b2f, 0x3f7ffe96, 0x3da81746, + 0x3f7ffe13, 0xbf0d46f0, 0x3f7ffd7c, 0xbf706b5b, 0x3f7ffcd1, 0xbf75af7c, 0x3f7ffc11, 0xbf1b04eb, + 0x3f7ff3ec, 0xbc74a98d, 0x3f7ff543, 0x3f14ddc0, 0x3f7ff686, 0x3f75c8e4, 0x3f7ff7b5, 0x3f704c29, + 0x3f7ff8cf, 0x3f0cfb53, 0x3f7ff9d6, 0xbd562087, 0x3f7ffac8, 0xbf2285a2, 0x3f7ffba6, 0xbf78338d, + 0x3f7ffc70, 0xbf69d2dd, 0x3f7ffd26, 0xbefc9d48, 0x3f7ffdc7, 0x3df439de, 0x3f7ffe55, 0x3f2f7182, + 0x3f7ffece, 0x3f7bda7b, 0x3f7fff33, 0x3f65ec36, 0x3f7fff84, 0x3ede1fb1, 0x3f7fffc0, 0xbe3e247a, + 0x3f7fffe9, 0xbf3b926e, 0x3f7ffffd, 0xbf7e5e10, 0x3f7ffffe, 0xbf5dd729, 0x3f7fffea, 0xbecd6236, + 0x3f7fffc2, 0x3e80a807, 0x3f7fff85, 0x3f46da5d, 0x3f7fff35, 0x3f7fbb65, 0x3f7ffed0, 0x3f54c17b, + 0x3f7ffe57, 0x3ead690b, 0x3f7ffdca, 0xbe9266f3, 0x3f7ffd29, 0xbf513c44, 0x3f7ffc74, 0xbf7ff0e4, + 0x3f7ff338, 0xbf4ab5af, 0x3f7ff499, 0xbe8ca746, 0x3f7ff5e6, 0x3eb30885, 0x3f7ff71f, 0x3f566815, + 0x3f7ff844, 0x3f7efe50, 0x3f7ff955, 0x3f3fbf64, 0x3f7ffa51, 0x3e568596, 0x3f7ffb39, 0xbed2dafc, + 0x3f7ffc0d, 0xbf5f51d7, 0x3f7ffccd, 0xbf7ce4c2, 0x3f7ffd79, 0xbf33eb48, 0x3f7ffe10, 0xbe12c478, + 0x3f7ffe93, 0x3effb57f, 0x3f7fff03, 0x3f673942, 0x3f7fd65c, 0x3f79a6a8, 0x3f7fffa4, 0x3f2d4032, + 0x3f7fdb53, 0x3d9cb322, 0x3f7ffff6, 0xbf00e731, 0x3f7fdff9, 0xbf6e1532, 0x3f7ffff6, 0xbf7547c1, + 0x3f7fe44f, 0xbf203284, 0x3f7fffa6, 0xbc194075, 0x3f7fe854, 0x3f0f78b3, 0x3f7fff05, 0x3f73ddb7, + 0x3f7fec09, 0x3f6fcd1c, 0x3f7ffe14, 0x3f126b84, 0x3f7fef6c, 0xbd6cf25b, 0x3f7ffcd1, 0xbf1d643e, + 0x3f7ff27f, 0xbf788c21, 0x3f7ffb3f, 0xbf6f5fcd, 0x3f7ff542, 0xbf03fb23, 0x3f7ff95b, 0x3dff915c, + 0x3f7ff7b4, 0x3f2a99b6, 0x3f7ff727, 0x3f7c1b06, 0x3f7ff9d5, 0x3f68bc7d, 0x3f7ff4a2, 0x3ee9e428, + 0x3f7ffba5, 0xbe43c0f3, 0x3f7ff1cd, 0xbf3709d4, 0x3f7ffd25, 0xbf7e8648, 0x3f7feea6, 0xbf610bf3, + 0x3f7ffe54, 0xbecac37b, 0x3f7fd26d, 0x3e48829f, 0x3f7fff32, 0x3f42a634, 0x3f7fd7a0, 0x3f7fcb1a, + 0x3f7fffc0, 0x3f585712, 0x3f7fdc83, 0x3eaab83e, 0x3f7ffffd, 0xbe85c2c7, 0x3f7fe115, 0xbf4d6169, + 0x3f7fffea, 0xbf7fe805, 0x3f7fe557, 0xbf4ea7ef, 0x3f7fff86, 0xbe89e784, 0x3f7fe948, 0x3ea6a983, + 0x3f7ffed1, 0x3f572f07, 0x3f7fece8, 0x3f7fdee4, 0x3f7ffdcb, 0x3f4409bb, 0x3f7ff038, 0x3e50ee85, + 0x3f7ffc75, 0xbec6cf73, 0x3f7ff337, 0xbf6003b9, 0x3f7fface, 0xbf7ebef6, 0x3f7ff5e5, 0xbf3888c0, + 0x3f7ff8d6, 0xbe0d1c50, 0x3f7ff843, 0x3ee60f66, 0x3f7ff68e, 0x3f67d546, 0x3f7ffa50, 0x3f7c7856, + 0x3f7ff3f5, 0x3f2c324d, 0x3f7ffc0c, 0x3d914dbe, 0x3f7ff10b, 0xbf02229c, 0x3f7ffd78, 0xbf6e9aa4, + 0x3f7fedd1, 0xbf790da6, 0x3f7ffe93, 0xbf1f14a7, 0x3f7fd3c0, 0xbd87a157, 0x3f7fff5d, 0x3f10a6fa, + 0x3f7fd8df, 0x3f744bfd, 0x3f7fffd7, 0x3f7482dc, 0x3f7fddae, 0x3f113efb, 0x3f800000, 0xba7bbccf, + 0x3f7fe22c, 0xbf1e8402, 0x3f7fffd8, 0xbf78e2bb, 0x3f7fe65a, 0xbf6edd38, 0x3f7fff60, 0xbf02c148, + 0x3f7fea36, 0x3d8b8e04, 0x3f7ffe97, 0x3f2ba9ab, 0x3f7fedc3, 0x3f792aa8, 0x3f7ffd7d, 0x3f682341, +] )) ), + +################ chunk 19456 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4935c6d7, 0x4937ebc4, 0x49368b31, 0x4938b26f, 0x49374f8a, 0x49397919, 0x493813e4, 0x493a3fc4, + 0x4938d83d, 0x493b066e, 0x49399c97, 0x493bcd18, 0x493a60f0, 0x493c93c3, 0x493b254a, 0x493d5a6d, + 0x493be9a3, 0x493e2118, 0x493cadfd, 0x493ee7c2, 0x493d7256, 0x493fae6d, 0x493e36b0, 0x49407517, + 0x493efb09, 0x49413bc1, 0x493fbf62, 0x4942026c, 0x494083bc, 0x4942c916, 0x49414815, 0x49438fc1, + 0x49420c6f, 0x4944566b, 0x4942d0c8, 0x49451d15, 0x49439522, 0x4945e3c0, 0x4944597b, 0x4946aa6a, + 0x49451dd5, 0x49477115, 0x4945e22e, 0x494837bf, 0x4946a688, 0x4948fe6a, 0x49476ae1, 0x4949c514, + 0x49482f3b, 0x494a8bbe, 0x4948f394, 0x494b5269, 0x4949b7ee, 0x494c1913, 0x494a7c47, 0x494cdfbe, + 0x494b40a1, 0x494da668, 0x494c04fa, 0x494e6d12, 0x494cc954, 0x494f33bd, 0x494d8dad, 0x494ffa67, + 0x494e5207, 0x4950c112, 0x494f1660, 0x495187bc, 0x494fdaba, 0x49524e66, 0x49509f13, 0x49531511, + 0x4951636d, 0x4953dbbb, 0x495227c6, 0x4954a266, 0x4952ec20, 0x49556910, 0x4953b079, 0x49562fbb, + 0x495474d2, 0x4956f665, 0x4955392c, 0x4957bd0f, 0x4955fd85, 0x495883ba, 0x4956c1df, 0x49594a64, + 0x49578638, 0x495a110f, 0x49584a92, 0x495ad7b9, 0x49590eeb, 0x495b9e63, 0x4959d345, 0x495c650e, + 0x495a979e, 0x495d2bb8, 0x495b5bf8, 0x495df263, 0x495c2051, 0x495eb90d, 0x495ce4ab, 0x495f7fb8, + 0x495da904, 0x49604662, 0x495e6d5e, 0x49610d0c, 0x495f31b7, 0x4961d3b7, 0x495ff611, 0x49629a61, + 0x4960ba6a, 0x4963610c, 0x49617ec4, 0x496427b6, 0x4962431d, 0x4964ee60, 0x49630777, 0x4965b50b, + 0x4963cbd0, 0x49667bb5, 0x4964902a, 0x49674260, 0x49655483, 0x4968090a, 0x496618dd, 0x4968cfb5, + 0x4966dd36, 0x4969965f, 0x4967a190, 0x496a5d09, 0x496865e9, 0x496b23b4, 0x49692a43, 0x496bea5e, + 0x4969ee9c, 0x496cb109, 0x496ab2f5, 0x496d77b3, 0x496b774f, 0x496e3e5d, 0x496c3ba8, 0x496f0508, + 0x496d0002, 0x496fcbb2, 0x496dc45b, 0x4970925d, 0x496e88b5, 0x49715907, 0x496f4d0e, 0x49721fb2, + 0x49701168, 0x4972e65c, 0x4970d5c1, 0x4973ad06, 0x49719a1b, 0x497473b1, 0x49725e74, 0x49753a5b, + 0x497322ce, 0x49760106, 0x4973e727, 0x4976c7b0, 0x4974ab81, 0x49778e5a, 0x49756fda, 0x49785505, + 0x49763434, 0x49791baf, 0x4976f88d, 0x4979e25a, 0x4977bce7, 0x497aa904, 0x49788140, 0x497b6fae, + 0x4979459a, 0x497c3659, 0x497a09f3, 0x497cfd03, 0x497ace4d, 0x497dc3ae, 0x497b92a6, 0x497e8a58, + 0x497c5700, 0x497f5103, 0x497d1b59, 0x49800bd6, 0x497ddfb3, 0x49806f2c, 0x497ea40c, 0x4980d281, + 0x497f6865, 0x498135d6, 0x4980165f, 0x4981992b, 0x4980788c, 0x4981fc81, 0x4980dab9, 0x49825fd6, + 0x49813ce6, 0x4982c32b, 0x49819f12, 0x49832680, 0x4982013f, 0x498389d5, 0x4982636c, 0x4983ed2b, + 0x4982c599, 0x49845080, 0x498327c5, 0x4984b3d5, 0x498389f2, 0x4985172a, 0x4983ec1f, 0x49857a7f, + 0x49844e4c, 0x4985ddd5, 0x4984b078, 0x4986412a, 0x498512a5, 0x4986a47f, 0x498574d2, 0x498707d4, + 0x4985d6ff, 0x49876b29, 0x4986392b, 0x4987ce7f, 0x49869b58, 0x498831d4, 0x4986fd85, 0x49889529, + 0x49875fb2, 0x4988f87e, 0x4987c1de, 0x49895bd3, 0x4988240b, 0x4989bf29, 0x49888638, 0x498a227e, + 0x4988e865, 0x498a85d3, 0x49894a91, 0x498ae928, 0x4989acbe, 0x498b4c7e, 0x498a0eeb, 0x498bafd3, + 0x498a7117, 0x498c1328, 0x498ad344, 0x498c767d, 0x498b3571, 0x498cd9d2, 0x498b979e, 0x498d3d28, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ff0fe, 0x3ee758a9, 0x3f7ffc13, 0xbe0a418f, 0x3f7ff3e9, 0xbf3808bf, 0x3f7ffa58, 0xbf7c8d0c, + 0x3f7ff683, 0xbf605cc1, 0x3f7ff84c, 0xbec82321, 0x3f7ff8cd, 0x3e4e1c2d, 0x3f7ff5f0, 0x3f4392ef, + 0x3f7ffac6, 0x3f7ecb48, 0x3f7ff343, 0x3f5792b5, 0x3f7ffc6e, 0x3ec5e75f, 0x3f7ff045, 0xbe88842e, + 0x3f7ffdc6, 0xbf4e3ae1, 0x3f7fcfb2, 0xbf7fe2c6, 0x3f7ffecd, 0xbf4dcf4a, 0x3f7fd50e, 0xbea5bb68, + 0x3f7fff83, 0x3ea95c5a, 0x3f7fda19, 0x3f57f442, 0x3f7fffe9, 0x3f7fd240, 0x3f7fded4, 0x3f431dc9, + 0x3f7ffffe, 0x3e84cfb8, 0x3f7fe33e, 0xbec9709b, 0x3f7fffc2, 0xbf589a44, 0x3f7fe757, 0xbf7e99cb, + 0x3f7fff36, 0xbf378a92, 0x3f7feb20, 0xbe4694cc, 0x3f7ffe58, 0x3ee89bd4, 0x3f7fee98, 0x3f6147d7, + 0x3f7ffd2b, 0x3f7c3ad0, 0x3f7ff1c0, 0x3f2b2308, 0x3f7ffbac, 0x3e02a46f, 0x3f7ff497, 0xbf035cfc, + 0x3f7ff9dd, 0xbf68f0cf, 0x3f7ff71d, 0xbf78b80d, 0x3f7ff7bd, 0xbf1df586, 0x3f7ff952, 0xbd7873c3, + 0x3f7ff54d, 0x3f11d418, 0x3f7ffb37, 0x3f6f8c4f, 0x3f7ff28c, 0x3f741592, 0x3f7ffccb, 0x3f1d00e6, + 0x3f7fcb76, 0xbbd64cea, 0x3f7ffe0f, 0xbf1fa282, 0x3f7fd10f, 0xbf7512b3, 0x3f7fff02, 0xbf6e58bb, + 0x3f7fd657, 0xbf0f1064, 0x3f7fffa4, 0x3d96f401, 0x3f7fdb4e, 0x3f2cb842, 0x3f7ffff5, 0x3f797d96, + 0x3f7fdff5, 0x3f67882b, 0x3f7ffff6, 0x3f007a62, 0x3f7fe44b, 0xbe0fea49, 0x3f7fffa7, 0xbf2d9cc8, + 0x3f7fe850, 0xbf7cc7dc, 0x3f7fff06, 0xbf5fabc5, 0x3f7fec05, 0xbee29f82, 0x3f7ffe15, 0x3e53b417, + 0x3f7fef69, 0x3f39dc1b, 0x3f7ffcd3, 0x3f7eedb8, 0x3f7ff27c, 0x3f56cca1, 0x3f7ffb41, 0x3ec34416, + 0x3f7ff53f, 0xbe8b447f, 0x3f7ff95d, 0xbf45446e, 0x3f7ff7b1, 0xbf7fecac, 0x3f7ff72a, 0xbf562335, + 0x3f7ff9d3, 0xbea306c8, 0x3f7ff4a5, 0x3eac0dd8, 0x3f7ffba3, 0x3f4fc88d, 0x3f7ff1d0, 0x3f7fc392, + 0x3f7ffd23, 0x3f4c3a80, 0x3f7fcce2, 0x3e820ce3, 0x3f7ffe53, 0xbecc1028, 0x3f7fd267, 0xbf595c4f, + 0x3f7fff32, 0xbf7e7299, 0x3f7fd79b, 0xbf41658b, 0x3f7fffc0, 0xbe40f91a, 0x3f7fdc7e, 0x3ece48b6, + 0x3f7ffffd, 0x3f61f49f, 0x3f7fe110, 0x3f7bfb48, 0x3f7fffea, 0x3f35b0dd, 0x3f7fe552, 0x3df9f263, + 0x3f7fff86, 0xbeed4cf9, 0x3f7fe944, 0xbf69878c, 0x3f7ffed2, 0xbf786078, 0x3f7fece4, 0xbf292a00, + 0x3f7ffdcc, 0xbd61a2dd, 0x3f7ff034, 0x3f059f5c, 0x3f7ffc76, 0x3f700c53, 0x3f7ff334, 0x3f73a656, + 0x3f7ffad0, 0x3f1bdf73, 0x3f7ff5e2, 0xbc469043, 0x3f7ff8d9, 0xbf13fda9, 0x3f7ff840, 0xbf757b6a, + 0x3f7ff691, 0xbf73466d, 0x3f7ffa4e, 0xbf004a77, 0x3f7ff3f8, 0x3c8a1011, 0x3f7ffc0a, 0x3f21b0c3, + 0x3f7fc889, 0x3f79ce87, 0x3f7f597e, 0x3f66eb3d, 0x3f7fce4a, 0x3f0cdde7, 0x3f7ffe92, 0xbdac02bf, + 0x3f7fea4a, 0xbf2ea8d1, 0x3f7f6d57, 0xbf7d00aa, 0x3f7fd8da, 0xbf5ef901, 0x3f7fffd7, 0xbefc5ff8, + 0x3f7fe243, 0x3e1a5d3f, 0x3f7f7fee, 0x3f3ad6d4, 0x3f7fe227, 0x3f7f0e1f, 0x3f7fffd9, 0x3f5604d5, + 0x3f7fd8fa, 0x3edde02f, 0x3f7f9142, 0xbe5e068c, 0x3f7fea32, 0xbf462cb3, 0x3f7ffe98, 0xbf7ff488, + 0x3f7fce6e, 0xbf4c1916, 0x3f7fa155, 0xbebe5fba, 0x3f7ff0fb, 0x3e905781, 0x3f7ffc15, 0x3f509d53, + 0x3f7fc29f, 0x3f7fb2da, 0x3f7fb025, 0x3f41413c, 0x3f7ff681, 0x3e9e030c, 0x3f7ff84f, 0xbeb104c3, + 0x3f7fb58e, 0xbf5a1c9f, 0x3f7fbdb3, 0xbf7e4961, 0x3f7ffac4, 0xbf4aa027, 0x3f7ff346, 0xbe79df28, + 0x3f7f51b7, 0x3ed0e53d, 0x3f7fc9ff, 0x3f629f9b, 0x3f7ffdc5, 0x3f7bb9be, 0x3f7fecfb, 0x3f3fa809, +] )) ), + +################ chunk 19968 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x498bf9ca, 0x498da07d, 0x498c5bf7, 0x498e03d2, 0x498cbe24, 0x498e6727, 0x498d2051, 0x498eca7c, + 0x498d827d, 0x498f2dd2, 0x498de4aa, 0x498f9127, 0x498e46d7, 0x498ff47c, 0x498ea904, 0x499057d1, + 0x498f0b30, 0x4990bb26, 0x498f6d5d, 0x49911e7c, 0x498fcf8a, 0x499181d1, 0x499031b7, 0x4991e526, + 0x499093e3, 0x4992487b, 0x4990f610, 0x4992abd0, 0x4991583d, 0x49930f26, 0x4991ba6a, 0x4993727b, + 0x49921c96, 0x4993d5d0, 0x49927ec3, 0x49943925, 0x4992e0f0, 0x49949c7a, 0x4993431d, 0x4994ffd0, + 0x4993a549, 0x49956325, 0x49940776, 0x4995c67a, 0x499469a3, 0x499629cf, 0x4994cbcf, 0x49968d25, + 0x49952dfc, 0x4996f07a, 0x49959029, 0x499753cf, 0x4995f256, 0x4997b724, 0x49965482, 0x49981a79, + 0x4996b6af, 0x49987dcf, 0x499718dc, 0x4998e124, 0x49977b09, 0x49994479, 0x4997dd35, 0x4999a7ce, + 0x49983f62, 0x499a0b23, 0x4998a18f, 0x499a6e79, 0x499903bc, 0x499ad1ce, 0x499965e8, 0x499b3523, + 0x4999c815, 0x499b9878, 0x499a2a42, 0x499bfbcd, 0x499a8c6f, 0x499c5f23, 0x499aee9b, 0x499cc278, + 0x499b50c8, 0x499d25cd, 0x499bb2f5, 0x499d8922, 0x499c1522, 0x499dec77, 0x499c774e, 0x499e4fcd, + 0x499cd97b, 0x499eb322, 0x499d3ba8, 0x499f1677, 0x499d9dd5, 0x499f79cc, 0x499e0001, 0x499fdd22, + 0x499e622e, 0x49a04077, 0x499ec45b, 0x49a0a3cc, 0x499f2688, 0x49a10721, 0x499f88b4, 0x49a16a76, + 0x499feae1, 0x49a1cdcc, 0x49a04d0e, 0x49a23121, 0x49a0af3a, 0x49a29476, 0x49a11167, 0x49a2f7cb, + 0x49a17394, 0x49a35b20, 0x49a1d5c1, 0x49a3be76, 0x49a237ed, 0x49a421cb, 0x49a29a1a, 0x49a48520, + 0x49a2fc47, 0x49a4e875, 0x49a35e74, 0x49a54bca, 0x49a3c0a0, 0x49a5af20, 0x49a422cd, 0x49a61275, + 0x49a484fa, 0x49a675ca, 0x49a4e727, 0x49a6d91f, 0x49a54953, 0x49a73c74, 0x49a5ab80, 0x49a79fca, + 0x49a60dad, 0x49a8031f, 0x49a66fda, 0x49a86674, 0x49a6d206, 0x49a8c9c9, 0x49a73433, 0x49a92d1e, + 0x49a79660, 0x49a99074, 0x49a7f88d, 0x49a9f3c9, 0x49a85ab9, 0x49aa571e, 0x49a8bce6, 0x49aaba73, + 0x49a91f13, 0x49ab1dc9, 0x49a98140, 0x49ab811e, 0x49a9e36c, 0x49abe473, 0x49aa4599, 0x49ac47c8, + 0x49aaa7c6, 0x49acab1d, 0x49ab09f2, 0x49ad0e73, 0x49ab6c1f, 0x49ad71c8, 0x49abce4c, 0x49add51d, + 0x49ac3079, 0x49ae3872, 0x49ac92a5, 0x49ae9bc7, 0x49acf4d2, 0x49aeff1d, 0x49ad56ff, 0x49af6272, + 0x49adb92c, 0x49afc5c7, 0x49ae1b58, 0x49b0291c, 0x49ae7d85, 0x49b08c71, 0x49aedfb2, 0x49b0efc7, + 0x49af41df, 0x49b1531c, 0x49afa40b, 0x49b1b671, 0x49b00638, 0x49b219c6, 0x49b06865, 0x49b27d1b, + 0x49b0ca92, 0x49b2e071, 0x49b12cbe, 0x49b343c6, 0x49b18eeb, 0x49b3a71b, 0x49b1f118, 0x49b40a70, + 0x49b25345, 0x49b46dc6, 0x49b2b571, 0x49b4d11b, 0x49b3179e, 0x49b53470, 0x49b379cb, 0x49b597c5, + 0x49b3dbf8, 0x49b5fb1a, 0x49b43e24, 0x49b65e70, 0x49b4a051, 0x49b6c1c5, 0x49b5027e, 0x49b7251a, + 0x49b564aa, 0x49b7886f, 0x49b5c6d7, 0x49b7ebc4, 0x49b62904, 0x49b84f1a, 0x49b68b31, 0x49b8b26f, + 0x49b6ed5d, 0x49b915c4, 0x49b74f8a, 0x49b97919, 0x49b7b1b7, 0x49b9dc6e, 0x49b813e4, 0x49ba3fc4, + 0x49b87610, 0x49baa319, 0x49b8d83d, 0x49bb066e, 0x49b93a6a, 0x49bb69c3, 0x49b99c97, 0x49bbcd18, + 0x49b9fec3, 0x49bc306e, 0x49ba60f0, 0x49bc93c3, 0x49bac31d, 0x49bcf718, 0x49bb254a, 0x49bd5a6d, + 0x49bb8776, 0x49bdbdc2, 0x49bbe9a3, 0x49be2118, 0x49bc4bd0, 0x49be846d, 0x49bcadfd, 0x49bee7c2, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7f6609, 0x3e36972a, 0x3f7fd508, 0xbeefd411, 0x3f7fff83, 0xbf6a1c6e, 0x3f7fe56d, 0xbf7806e9, + 0x3f7f7918, 0xbf33d235, 0x3f7fdecf, 0xbde4f7e6, 0x3f7ffffe, 0x3f06d6bb, 0x3f7fdc9c, 0x3f708a6e, + 0x3f7f8ae6, 0x3f733528, 0x3f7fe753, 0x3f272c5c, 0x3f7fff36, 0x3d377133, 0x3f7fd289, 0xbf152772, + 0x3f7f9b71, 0xbf75e22d, 0x3f7fee95, 0xbf6d4a0f, 0x3f7ffd2c, 0xbf19c521, 0x3f7fc734, 0x3cb7c339, + 0x3f7faabb, 0x3f22cb9d, 0x3f7ff494, 0x3f7a1d7a, 0x3f7ff9df, 0x3f664c77, 0x3f7fba9c, 0x3f0bac03, + 0x3f7fb8c2, 0xbdb76511, 0x3f7ff950, 0xbf2fb377, 0x3f7ff550, 0xbf7d3772, 0x3f7f49c3, 0xbf6c5e75, + 0x3f7fc587, 0xbef9e2a6, 0x3f7ffcca, 0x3e200296, 0x3f7fef7e, 0x3f3bd00f, 0x3f7f5e8d, 0x3f7f2c7e, + 0x3f7fd109, 0x3f653ad3, 0x3f7fff01, 0x3edb4c33, 0x3f7fe869, 0xbe63998a, 0x3f7f7216, 0xbf471365, + 0x3f7fdb49, 0xbf7ffa5a, 0x3f7ffff5, 0xbf5d0e04, 0x3f7fe012, 0xbebbb811, 0x3f7f845c, 0x3e93149a, + 0x3f7fe446, 0x3f51706f, 0x3f7fffa7, 0x3f7fa018, 0x3f7fd678, 0x3f53e17e, 0x3f7f9561, 0x3e9b4ac8, + 0x3f7fec01, 0xbeb3b24a, 0x3f7ffe16, 0xbf5adb32, 0x3f7fcb9b, 0xbf7e1e21, 0x3f7fa523, 0xbf49bfdd, + 0x3f7ff279, 0xbe7453b4, 0x3f7ffb42, 0x3ed3801b, 0x3f7fbf7d, 0x3f6348c8, 0x3f7fb3a3, 0x3f7f7b9a, + 0x3f7ff7af, 0x3f3eb4d9, 0x3f7ff72c, 0x3e30f735, 0x3f7fb21c, 0xbef25941, 0x3f7fc0e1, 0xbf6aaf71, + 0x3f7ffba2, 0xbf7dd019, 0x3f7ff1d3, 0xbf32cd39, 0x3f7f56e4, 0xbdd99bfc, 0x3f7fccdc, 0x3f080d07, + 0x3f7ffe52, 0x3f71069e, 0x3f7feb37, 0x3f7afefb, 0x3f7f6ae6, 0x3f2616c3, 0x3f7fd795, 0x3d209ba8, + 0x3f7fffbf, 0xbf16500a, 0x3f7fe359, 0xbf7646fa, 0x3f7f7da5, 0xbf770b83, 0x3f7fe10c, 0xbf18a02a, + 0x3f7fffea, 0x3ce574e9, 0x3f7fda39, 0x3f23e52c, 0x3f7f8f23, 0x3f7a6a70, 0x3f7fe940, 0x3f71fa42, + 0x3f7ffed2, 0x3f0a7902, 0x3f7fcfd5, 0xbdc2c5ec, 0x3f7f9f5e, 0xbf30bcb6, 0x3f7ff031, 0xbf7d6c37, + 0x3f7ffc78, 0xbf6bd115, 0x3f7fc430, 0xbef76355, 0x3f7fae57, 0x3e25a6a7, 0x3f7ff5e0, 0x3f3cc7cc, + 0x3f7ff8db, 0x3f7ae878, 0x3f7fb748, 0x3f64971d, 0x3f7fbc0e, 0x3ed8b678, 0x3f7ffa4c, 0xbe692ab7, + 0x3f7ff3fb, 0xbf47f880, 0x3f7f4f0e, 0xbf7dc124, 0x3f7fc882, 0xbf5c54b6, 0x3f7ffd75, 0xbeb90eea, + 0x3f7fedd9, 0x3e95d087, 0x3f7f6388, 0x3f5241e0, 0x3f7fd3b4, 0x3f7f7444, 0x3f7fff5c, 0x3f53136d, + 0x3f7fe673, 0x3e989147, 0x3f7f76c0, 0xbeb65e63, 0x3f7fdda4, 0xbf5b9806, 0x3f800000, 0xbf7fffe1, + 0x3f7fddcc, 0xbf48ddf7, 0x3f7f88b7, 0xbe6ec64e, 0x3f7fe651, 0x3ed61948, 0x3f7fff61, 0x3f63f025, + 0x3f7fd3e2, 0x3f7f635a, 0x3f7f996b, 0x3f3dc025, 0x3f7fedbb, 0x3e2b55d6, 0x3f7ffd80, 0xbef4dc82, + 0x3f7fc8b5, 0xbf5cd478, 0x3f7fa8dd, 0xbf7d9f64, 0x3f7ff3e3, 0xbf31c6d1, 0x3f7ffa5c, 0xbdce3e56, + 0x3f7fbc46, 0x3f09423d, 0x3f7fb70d, 0x3f650803, 0x3f7ff8c8, 0x3f7ab609, 0x3f7ff5f5, 0x3f24ffd6, + 0x3f7f470a, 0x3d09c4d5, 0x3f7fc3fb, 0xbf177770, 0x3f7ffc6b, 0xbf6c329c, 0x3f7ff04c, 0xbf76aaa8, + 0x3f7f5bfd, 0xbf1779fb, 0x3f7fcfa6, 0x3d099263, 0x3f7ffecb, 0x3f24fd6c, 0x3f7fe960, 0x3f724bf9, + 0x3f7f6fae, 0x3f7181ef, 0x3f7fda0e, 0x3f0944e6, 0x3f7fffe8, 0xbdce253b, 0x3f7fe132, 0xbf31c48c, + 0x3f7f821e, 0xbf774d0b, 0x3f7fe335, 0xbf6b41d5, 0x3f7fffc3, 0xbef4e20c, 0x3f7fd7c1, 0x3e2b4966, + 0x3f7f934b, 0x3f3dbe07, 0x3f7feb18, 0x3f7b300a, 0x3f7ffe5b, 0x3f63f195, 0x3f7fcd0d, 0x3ed61f03, +] )) ), + +################ chunk 20480 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x49bd1029, 0x49bf4b17, 0x49bd7256, 0x49bfae6d, 0x49bdd483, 0x49c011c2, 0x49be36b0, 0x49c07517, + 0x49be98dc, 0x49c0d86c, 0x49befb09, 0x49c13bc1, 0x49bf5d36, 0x49c19f17, 0x49bfbf62, 0x49c2026c, + 0x49c0218f, 0x49c265c1, 0x49c083bc, 0x49c2c916, 0x49c0e5e9, 0x49c32c6b, 0x49c14815, 0x49c38fc1, + 0x49c1aa42, 0x49c3f316, 0x49c20c6f, 0x49c4566b, 0x49c26e9c, 0x49c4b9c0, 0x49c2d0c8, 0x49c51d15, + 0x49c332f5, 0x49c5806b, 0x49c39522, 0x49c5e3c0, 0x49c3f74f, 0x49c64715, 0x49c4597b, 0x49c6aa6a, + 0x49c4bba8, 0x49c70dbf, 0x49c51dd5, 0x49c77115, 0x49c58002, 0x49c7d46a, 0x49c5e22e, 0x49c837bf, + 0x49c6445b, 0x49c89b14, 0x49c6a688, 0x49c8fe6a, 0x49c708b5, 0x49c961bf, 0x49c76ae1, 0x49c9c514, + 0x49c7cd0e, 0x49ca2869, 0x49c82f3b, 0x49ca8bbe, 0x49c89168, 0x49caef14, 0x49c8f394, 0x49cb5269, + 0x49c955c1, 0x49cbb5be, 0x49c9b7ee, 0x49cc1913, 0x49ca1a1a, 0x49cc7c68, 0x49ca7c47, 0x49ccdfbe, + 0x49cade74, 0x49cd4313, 0x49cb40a1, 0x49cda668, 0x49cba2cd, 0x49ce09bd, 0x49cc04fa, 0x49ce6d12, + 0x49cc6727, 0x49ced068, 0x49ccc954, 0x49cf33bd, 0x49cd2b80, 0x49cf9712, 0x49cd8dad, 0x49cffa67, + 0x49cdefda, 0x49d05dbc, 0x49ce5207, 0x49d0c112, 0x49ceb433, 0x49d12467, 0x49cf1660, 0x49d187bc, + 0x49cf788d, 0x49d1eb11, 0x49cfdaba, 0x49d24e66, 0x49d03ce6, 0x49d2b1bc, 0x49d09f13, 0x49d31511, + 0x49d10140, 0x49d37866, 0x49d1636d, 0x49d3dbbb, 0x49d1c599, 0x49d43f11, 0x49d227c6, 0x49d4a266, + 0x49d289f3, 0x49d505bb, 0x49d2ec20, 0x49d56910, 0x49d34e4c, 0x49d5cc65, 0x49d3b079, 0x49d62fbb, + 0x49d412a6, 0x49d69310, 0x49d474d2, 0x49d6f665, 0x49d4d6ff, 0x49d759ba, 0x49d5392c, 0x49d7bd0f, + 0x49d59b59, 0x49d82065, 0x49d5fd85, 0x49d883ba, 0x49d65fb2, 0x49d8e70f, 0x49d6c1df, 0x49d94a64, + 0x49d7240c, 0x49d9adb9, 0x49d78638, 0x49da110f, 0x49d7e865, 0x49da7464, 0x49d84a92, 0x49dad7b9, + 0x49d8acbf, 0x49db3b0e, 0x49d90eeb, 0x49db9e63, 0x49d97118, 0x49dc01b9, 0x49d9d345, 0x49dc650e, + 0x49da3572, 0x49dcc863, 0x49da979e, 0x49dd2bb8, 0x49daf9cb, 0x49dd8f0e, 0x49db5bf8, 0x49ddf263, + 0x49dbbe25, 0x49de55b8, 0x49dc2051, 0x49deb90d, 0x49dc827e, 0x49df1c62, 0x49dce4ab, 0x49df7fb8, + 0x49dd46d8, 0x49dfe30d, 0x49dda904, 0x49e04662, 0x49de0b31, 0x49e0a9b7, 0x49de6d5e, 0x49e10d0c, + 0x49decf8b, 0x49e17062, 0x49df31b7, 0x49e1d3b7, 0x49df93e4, 0x49e2370c, 0x49dff611, 0x49e29a61, + 0x49e0583d, 0x49e2fdb6, 0x49e0ba6a, 0x49e3610c, 0x49e11c97, 0x49e3c461, 0x49e17ec4, 0x49e427b6, + 0x49e1e0f0, 0x49e48b0b, 0x49e2431d, 0x49e4ee60, 0x49e2a54a, 0x49e551b6, 0x49e30777, 0x49e5b50b, + 0x49e369a3, 0x49e61860, 0x49e3cbd0, 0x49e67bb5, 0x49e42dfd, 0x49e6df0a, 0x49e4902a, 0x49e74260, + 0x49e4f256, 0x49e7a5b5, 0x49e55483, 0x49e8090a, 0x49e5b6b0, 0x49e86c5f, 0x49e618dd, 0x49e8cfb5, + 0x49e67b09, 0x49e9330a, 0x49e6dd36, 0x49e9965f, 0x49e73f63, 0x49e9f9b4, 0x49e7a190, 0x49ea5d09, + 0x49e803bc, 0x49eac05f, 0x49e865e9, 0x49eb23b4, 0x49e8c816, 0x49eb8709, 0x49e92a43, 0x49ebea5e, + 0x49e98c6f, 0x49ec4db3, 0x49e9ee9c, 0x49ecb109, 0x49ea50c9, 0x49ed145e, 0x49eab2f5, 0x49ed77b3, + 0x49eb1522, 0x49eddb08, 0x49eb774f, 0x49ee3e5d, 0x49ebd97c, 0x49eea1b3, 0x49ec3ba8, 0x49ef0508, + 0x49ec9dd5, 0x49ef685d, 0x49ed0002, 0x49efcbb2, 0x49ed622f, 0x49f02f07, 0x49edc45b, 0x49f0925d, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fa336, 0xbe6eba09, 0x3f7ff1b9, 0xbf33810c, 0x3f7ffbb0, 0xbf7df074, 0x3f7fc117, 0xbf5b99a5, + 0x3f7fb1df, 0xbeb66448, 0x3f7ff718, 0x3e988b41, 0x3f7ff7c2, 0x3f3f5c6e, 0x3f7f3ed9, 0x3f7f8b1d, + 0x3f7fbf46, 0x3f5243ad, 0x3f7ffb33, 0x3e95d68f, 0x3f7ff292, 0xbeb90908, 0x3f7f5445, 0xbf4a5a72, + 0x3f7fcb6a, 0xbf7ffe28, 0x3f7ffe0d, 0xbf47fa78, 0x3f7fec1f, 0xbe693701, 0x3f7f686f, 0x3ed8b0c1, + 0x3f7fd64c, 0x3f546e60, 0x3f7fffa3, 0x3f7f4911, 0x3f7fe46a, 0x3f3cc9ed, 0x3f7f7b57, 0x3e25b31b, + 0x3f7fdfeb, 0xbef75dcf, 0x3f7ffff7, 0xbf5d8c91, 0x3f7fdb72, 0xbf7d6ca9, 0x3f7f8cfe, 0xbf30befe, + 0x3f7fe848, 0xbdc2df0c, 0x3f7fff08, 0x3edd12bd, 0x3f7fd138, 0x3f65aa77, 0x3f7f9d62, 0x3f7a6b17, + 0x3f7fef62, 0x3f23e798, 0x3f7ffcd6, 0x3ce5d9d2, 0x3f7fc5bb, 0xbefb999d, 0x3f7fac84, 0xbf6cbeb0, + 0x3f7ff539, 0xbf7647d6, 0x3f7ff962, 0xbf165298, 0x3f7f367a, 0x3d206938, 0x3f7fba63, 0x3f0c7eb7, + 0x3f7ff9ce, 0x3f72c10a, 0x3f7ff4ab, 0x3f7107af, 0x3f7f4c5f, 0x3f080fb3, 0x3f7fc700, 0xbdd982e4, + 0x3f7ffd21, 0xbf1a8e1a, 0x3f7feeb1, 0xbf77aa93, 0x3f7f6102, 0xbf6ab0b4, 0x3f7fd25b, 0xbef25ed0, + 0x3f7fff30, 0x3e30eac7, 0x3f7fe775, 0x3f27eab2, 0x3f7f7463, 0x3f7b759b, 0x3f7fdc74, 0x3f634a3b, + 0x3f7ffffd, 0x3ed385da, 0x3f7fdef6, 0xbe744773, 0x3f7f8683, 0xbf34850b, 0x3f7fe54a, 0xbf7e1dbf, + 0x3f7fff87, 0xbf5adcd5, 0x3f7fd535, 0xbeb3b833, 0x3f7f9760, 0x3e3a75a1, 0x3f7fecdd, 0x3f404e90, + 0x3f7ffdcf, 0x3f7f9fed, 0x3f7fca31, 0x3f517240, 0x3f7fa6fb, 0x3e931aa5, 0x3f7ff32e, 0xbe7daf32, + 0x3f7ffad4, 0xbf4b399f, 0x3f7f2dee, 0xbf7ffa65, 0x3f7fb553, 0xbf471560, 0x3f7ff83c, 0xbe63a5d8, + 0x3f7ff696, 0x3e9fe1a6, 0x3f7f444c, 0x3f553997, 0x3f7fc26a, 0x3f7f2cbf, 0x3f7ffc07, 0x3f3bd234, + 0x3f7ff115, 0x3e200f0d, 0x3f7f5968, 0xbec032bf, 0x3f7fce3d, 0xbf5e42e5, 0x3f7ffe90, 0xbf7d37e9, + 0x3f7fea52, 0xbf2fb5c2, 0x3f7f6d42, 0xbdb77e33, 0x3f7fd8cf, 0x3edfa582, 0x3f7fffd6, 0x3f664b17, + 0x3f7fe24d, 0x3f7a1e27, 0x3f7f7fda, 0x3f22ce0d, 0x3f7fe21e, 0x3e167983, 0x3f7fffd9, 0xbefe158d, + 0x3f7fd904, 0xbf6d48e0, 0x3f7f9130, 0xbf75e30d, 0x3f7fea2a, 0xbf152a02, 0x3f7ffe9a, 0xbda42ba4, + 0x3f7fce7a, 0x3f0dafd6, 0x3f7fa144, 0x3f73342c, 0x3f7ff0f4, 0x3f708b83, 0x3f7ffc18, 0x3f06d969, + 0x3f7fc2ad, 0x3c5532bd, 0x3f7fb016, 0xbf1bb0fe, 0x3f7ff67c, 0xbf780621, 0x3f7ff853, 0xbf6a1db4, + 0x3f7f3c0c, 0xbeefd9a4, 0x3f7fbda5, 0x3d5dfb92, 0x3f7ffac0, 0x3f28fe0b, 0x3f7ff34c, 0x3f7bb92b, + 0x3f7f51a1, 0x3f62a112, 0x3f7fc9f2, 0x3ed0eb00, 0x3f7ffdc2, 0xbdf82184, 0x3f7fed02, 0xbf35879a, + 0x3f7f65f3, 0xbf7e4903, 0x3f7fd4fd, 0xbf5a1e46, 0x3f7fff81, 0xbeb10aae, 0x3f7fe576, 0x3e40131b, + 0x3f7f7904, 0x3f413f2a, 0x3f7fdec5, 0x3f7fb2b3, 0x3f7ffffe, 0x3f509f27, 0x3f7fdca7, 0x3ecc7b85, + 0x3f7f8ad3, 0xbe819ba1, 0x3f7fe74a, 0xbf4c172e, 0x3f7fff38, 0xbf7ff497, 0x3f7fd295, 0xbf462eb3, + 0x3f7f9b60, 0xbeac7c1a, 0x3f7fee8d, 0x3ea297c6, 0x3f7ffd2f, 0x3f56031a, 0x3f7fc741, 0x3f7f0e65, + 0x3f7faaab, 0x3f3ad8fc, 0x3f7ff48e, 0x3e8bb528, 0x3f7ff9e4, 0xbec2d7d5, 0x3f7f339e, 0xbf5ef774, + 0x3f7fb8b3, 0xbf7d0125, 0x3f7ff94c, 0xbf2eab20, 0x3f7ff555, 0xbe54992f, 0x3f7f49ac, 0x3ee2367e, + 0x3f7fc579, 0x3f66e9e0, 0x3f7ffcc7, 0x3f79cf38, 0x3f7fef85, 0x3f21b335, 0x3f7f5e77, 0x3e10d21f, +] )) ), + +################ chunk 20992 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x49ee2688, 0x49f0f5b2, 0x49ee88b5, 0x49f15907, 0x49eeeae2, 0x49f1bc5c, 0x49ef4d0e, 0x49f21fb2, + 0x49efaf3b, 0x49f28307, 0x49f01168, 0x49f2e65c, 0x49f07395, 0x49f349b1, 0x49f0d5c1, 0x49f3ad06, + 0x49f137ee, 0x49f4105c, 0x49f19a1b, 0x49f473b1, 0x49f1fc48, 0x49f4d706, 0x49f25e74, 0x49f53a5b, + 0x49f2c0a1, 0x49f59db0, 0x49f322ce, 0x49f60106, 0x49f384fb, 0x49f6645b, 0x49f3e727, 0x49f6c7b0, + 0x49f44954, 0x49f72b05, 0x49f4ab81, 0x49f78e5a, 0x49f50dad, 0x49f7f1b0, 0x49f56fda, 0x49f85505, + 0x49f5d207, 0x49f8b85a, 0x49f63434, 0x49f91baf, 0x49f69660, 0x49f97f04, 0x49f6f88d, 0x49f9e25a, + 0x49f75aba, 0x49fa45af, 0x49f7bce7, 0x49faa904, 0x49f81f13, 0x49fb0c59, 0x49f88140, 0x49fb6fae, + 0x49f8e36d, 0x49fbd304, 0x49f9459a, 0x49fc3659, 0x49f9a7c6, 0x49fc99ae, 0x49fa09f3, 0x49fcfd03, + 0x49fa6c20, 0x49fd6059, 0x49face4d, 0x49fdc3ae, 0x49fb3079, 0x49fe2703, 0x49fb92a6, 0x49fe8a58, + 0x49fbf4d3, 0x49feedad, 0x49fc5700, 0x49ff5103, 0x49fcb92c, 0x49ffb458, 0x49fd1b59, 0x4a000bd6, + 0x49fd7d86, 0x4a003d81, 0x49fddfb3, 0x4a006f2c, 0x49fe41df, 0x4a00a0d6, 0x49fea40c, 0x4a00d281, + 0x49ff0639, 0x4a01042c, 0x49ff6865, 0x4a0135d6, 0x49ffca92, 0x4a016781, 0x4a00165f, 0x4a01992b, + 0x4a004776, 0x4a01cad6, 0x4a00788c, 0x4a01fc81, 0x4a00a9a3, 0x4a022e2b, 0x4a00dab9, 0x4a025fd6, + 0x4a010bcf, 0x4a029180, 0x4a013ce6, 0x4a02c32b, 0x4a016dfc, 0x4a02f4d6, 0x4a019f12, 0x4a032680, + 0x4a01d029, 0x4a03582b, 0x4a02013f, 0x4a0389d5, 0x4a023256, 0x4a03bb80, 0x4a02636c, 0x4a03ed2b, + 0x4a029482, 0x4a041ed5, 0x4a02c599, 0x4a045080, 0x4a02f6af, 0x4a04822a, 0x4a0327c5, 0x4a04b3d5, + 0x4a0358dc, 0x4a04e580, 0x4a0389f2, 0x4a05172a, 0x4a03bb09, 0x4a0548d5, 0x4a03ec1f, 0x4a057a7f, + 0x4a041d35, 0x4a05ac2a, 0x4a044e4c, 0x4a05ddd5, 0x4a047f62, 0x4a060f7f, 0x4a04b078, 0x4a06412a, + 0x4a04e18f, 0x4a0672d4, 0x4a0512a5, 0x4a06a47f, 0x4a0543bb, 0x4a06d62a, 0x4a0574d2, 0x4a0707d4, + 0x4a05a5e8, 0x4a07397f, 0x4a05d6ff, 0x4a076b29, 0x4a060815, 0x4a079cd4, 0x4a06392b, 0x4a07ce7f, + 0x4a066a42, 0x4a080029, 0x4a069b58, 0x4a0831d4, 0x4a06cc6e, 0x4a08637e, 0x4a06fd85, 0x4a089529, + 0x4a072e9b, 0x4a08c6d4, 0x4a075fb2, 0x4a08f87e, 0x4a0790c8, 0x4a092a29, 0x4a07c1de, 0x4a095bd3, + 0x4a07f2f5, 0x4a098d7e, 0x4a08240b, 0x4a09bf29, 0x4a085521, 0x4a09f0d3, 0x4a088638, 0x4a0a227e, + 0x4a08b74e, 0x4a0a5428, 0x4a08e865, 0x4a0a85d3, 0x4a09197b, 0x4a0ab77e, 0x4a094a91, 0x4a0ae928, + 0x4a097ba8, 0x4a0b1ad3, 0x4a09acbe, 0x4a0b4c7e, 0x4a09ddd4, 0x4a0b7e28, 0x4a0a0eeb, 0x4a0bafd3, + 0x4a0a4001, 0x4a0be17d, 0x4a0a7117, 0x4a0c1328, 0x4a0aa22e, 0x4a0c44d3, 0x4a0ad344, 0x4a0c767d, + 0x4a0b045b, 0x4a0ca828, 0x4a0b3571, 0x4a0cd9d2, 0x4a0b6687, 0x4a0d0b7d, 0x4a0b979e, 0x4a0d3d28, + 0x4a0bc8b4, 0x4a0d6ed2, 0x4a0bf9ca, 0x4a0da07d, 0x4a0c2ae1, 0x4a0dd227, 0x4a0c5bf7, 0x4a0e03d2, + 0x4a0c8d0e, 0x4a0e357d, 0x4a0cbe24, 0x4a0e6727, 0x4a0cef3a, 0x4a0e98d2, 0x4a0d2051, 0x4a0eca7c, + 0x4a0d5167, 0x4a0efc27, 0x4a0d827d, 0x4a0f2dd2, 0x4a0db394, 0x4a0f5f7c, 0x4a0de4aa, 0x4a0f9127, + 0x4a0e15c1, 0x4a0fc2d1, 0x4a0e46d7, 0x4a0ff47c, 0x4a0e77ed, 0x4a102627, 0x4a0ea904, 0x4a1057d1, + 0x4a0eda1a, 0x4a10897c, 0x4a0f0b30, 0x4a10bb26, 0x4a0f3c47, 0x4a10ecd1, 0x4a0f6d5d, 0x4a111e7c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7fd0fd, 0xbf0047bc, 0x3f7ffeff, 0xbf6dd12d, 0x3f7fe871, 0xbf757c4f, 0x3f7f7201, 0xbf2ce373, + 0x3f7fdb3e, 0xbd98c70f, 0x3f7ffff5, 0x3f0edfd3, 0x3f7fe01b, 0x3f73a55e, 0x3f7f8449, 0x3f700d6c, + 0x3f7fe43d, 0x3f1fd043, 0x3f7fffa8, 0x3bf39247, 0x3f7fd683, 0xbf1cd2a4, 0x3f7f954f, 0xbf785fb5, + 0x3f7febf9, 0xbf6988d7, 0x3f7ffe18, 0xbf120432, 0x3f7fcba8, 0x3d74ccc5, 0x3f7fa513, 0x3f2a100b, + 0x3f7ff273, 0x3f7bfaba, 0x3f7ffb46, 0x3f61f61b, 0x3f7f2b03, 0x3f038f39, 0x3f7fb394, 0xbe01bc29, + 0x3f7ff7aa, 0xbf3688b7, 0x3f7ff731, 0xbf7e7241, 0x3f7f4189, 0xbf595dfa, 0x3f7fc0d3, 0xbee9041d, + 0x3f7ffb9e, 0x3e45af0c, 0x3f7ff1da, 0x3f422e3a, 0x3f7f56ce, 0x3f7fc36f, 0x3f7fccd0, 0x3f4fca65, + 0x3f7ffe50, 0x3ec9dc3a, 0x3f7feb3f, 0xbe845ea1, 0x3f7f6ad1, 0xbf4cf31d, 0x3f7fd78a, 0xbf7fecc0, + 0x3f7fffbf, 0xbf5813ad, 0x3f7fe362, 0xbea9cad4, 0x3f7f7d92, 0x3ea54c9b, 0x3f7fe102, 0x3f56cae9, + 0x3f7fffeb, 0x3f7eee02, 0x3f7fda43, 0x3f4e5d8c, 0x3f7f8f10, 0x3e88f504, 0x3f7fe937, 0xbefed5cf, + 0x3f7ffed4, 0xbf5faa3c, 0x3f7fcfe1, 0xbf7fdac5, 0x3f7f9f4d, 0xbf2d9f19, 0x3f7ff02a, 0xbe4f0189, + 0x3f7ffc7b, 0x3ea9e15a, 0x3f7f223a, 0x3f6786d3, 0x3f7fae47, 0x3f7eb265, 0x3f7d66d1, 0x3f209713, + 0x3f7ff8df, 0x3e0b2993, 0x3f7f3939, 0xbec9f22b, 0x3f7f3150, 0xbf6e5794, 0x3f7ffa48, 0xbf7c6362, + 0x3f7e9118, 0xbf12d547, 0x3f7fa92d, 0xbd8d6143, 0x3f7fc875, 0x3ee9195e, 0x3f7db604, 0x3f74149e, + 0x3f7fede0, 0x3f78f069, 0x3f7f6373, 0x3f0469a0, 0x3f7f012f, 0x3af2f48f, 0x3f7fff5b, 0xbf039976, + 0x3f7ecb54, 0xbf78b74e, 0x3f7f8914, 0xbf745d76, 0x3f7fdd9a, 0xbeeac997, 0x3f7e0037, 0x3d85ce02, + 0x3f7fddd6, 0x3f120e00, 0x3f7f88a4, 0x3f7c3a46, 0x3f7ecc08, 0x3f6eafd4, 0x3f7fff63, 0x3ecbb054, + 0x3f7f008b, 0xbe076687, 0x3f7f63f3, 0xbf1fd996, 0x3f7fedb4, 0xbf7e9977, 0x3f7e4569, 0xbf67ee15, + 0x3f7fc8c2, 0xbeabab70, 0x3f7fa8cd, 0x3e4b496b, 0x3f7d5764, 0x3f2cec41, 0x3f7ffa60, 0x3f7fd222, + 0x3f7f30bc, 0x3f602009, 0x3f7f39ca, 0x3e8adff5, 0x3f7ff8c4, 0xbe872092, 0x3f7e8599, 0xbf3936e2, + 0x3f7faea4, 0xbf7fe2de, 0x3f7fc3ed, 0xbf574eb8, 0x3f7da786, 0xbe52e7a7, 0x3f7ff053, 0x3ea8001e, + 0x3f7f5be7, 0x3f44ab41, 0x3f7f0a9a, 0x3f7ecb97, 0x3f7ffec9, 0x3f4d8456, 0x3f7ec0c6, 0x3e0f1b6a, + 0x3f7f8f7d, 0xbec81d52, 0x3f7fda04, 0xbf4f3c1e, 0x3f7df2aa, 0xbf7c8d90, 0x3f7fe13b, 0xbf42cc35, + 0x3f7f820b, 0xbd955341, 0x3f7ed665, 0x3ee75308, 0x3f7fffc4, 0x3f58dd41, 0x3f7ef6ef, 0x3f792b61, + 0x3f7f6b4e, 0x3f3732bd, 0x3f7feb10, 0x3e818488, 0x3f7e38cd, 0xbf02be92, 0x3f7fcd19, 0xbf618384, + 0x3f7fa326, 0xbf74a8f5, 0x3f7d47ca, 0xbf2ac557, 0x3f7ffbb3, 0xbe3fe434, 0x3f7f2812, 0x3f113c61, + 0x3f7f4217, 0x3f6924e8, 0x3f7ff713, 0x3f6f0b82, 0x3f7e79ee, 0x3f1d9266, 0x3f7fb3ee, 0x3df7c2ba, + 0x3f7fbf38, 0xbf1f122e, 0x3f7d98dc, 0xbf6fb897, 0x3f7ff298, 0xbf685989, 0x3f7f542e, 0xbf0fa92c, + 0x3f7f13d9, 0xbd5d3cdc, 0x3f7ffe0a, 0x3f2c2ff7, 0x3f7eb60c, 0x3f7536f7, 0x3f7f95b9, 0x3f609ac6, + 0x3f7fd641, 0x3f0119c2, 0x3f7de4f0, 0xbc582ea0, 0x3f7fe473, 0xbf388690, 0x3f7f7b44, 0xbf7999ac, + 0x3f7ee094, 0xbf57d831, 0x3f7ffff7, 0xbee3ea01, 0x3f7eed26, 0x3da48ad4, 0x3f7f727c, 0x3f4407b4, + 0x3f7fe83f, 0x3f7cdba4, 0x3f7e2c03, 0x3f4e1beb, 0x3f7fd143, 0x3ec498d6, 0x3f7f9d51, 0xbe16a8be, +] )) ), + +################ chunk 21504 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4a0f9e73, 0x4a115026, 0x4a0fcf8a, 0x4a1181d1, 0x4a1000a0, 0x4a11b37b, 0x4a1031b7, 0x4a11e526, + 0x4a1062cd, 0x4a1216d1, 0x4a1093e3, 0x4a12487b, 0x4a10c4fa, 0x4a127a26, 0x4a10f610, 0x4a12abd0, + 0x4a112726, 0x4a12dd7b, 0x4a11583d, 0x4a130f26, 0x4a118953, 0x4a1340d0, 0x4a11ba6a, 0x4a13727b, + 0x4a11eb80, 0x4a13a425, 0x4a121c96, 0x4a13d5d0, 0x4a124dad, 0x4a14077b, 0x4a127ec3, 0x4a143925, + 0x4a12afd9, 0x4a146ad0, 0x4a12e0f0, 0x4a149c7a, 0x4a131206, 0x4a14ce25, 0x4a13431d, 0x4a14ffd0, + 0x4a137433, 0x4a15317a, 0x4a13a549, 0x4a156325, 0x4a13d660, 0x4a1594d0, 0x4a140776, 0x4a15c67a, + 0x4a14388c, 0x4a15f825, 0x4a1469a3, 0x4a1629cf, 0x4a149ab9, 0x4a165b7a, 0x4a14cbcf, 0x4a168d25, + 0x4a14fce6, 0x4a16becf, 0x4a152dfc, 0x4a16f07a, 0x4a155f13, 0x4a172224, 0x4a159029, 0x4a1753cf, + 0x4a15c13f, 0x4a17857a, 0x4a15f256, 0x4a17b724, 0x4a16236c, 0x4a17e8cf, 0x4a165482, 0x4a181a79, + 0x4a168599, 0x4a184c24, 0x4a16b6af, 0x4a187dcf, 0x4a16e7c6, 0x4a18af79, 0x4a1718dc, 0x4a18e124, + 0x4a1749f2, 0x4a1912ce, 0x4a177b09, 0x4a194479, 0x4a17ac1f, 0x4a197624, 0x4a17dd35, 0x4a19a7ce, + 0x4a180e4c, 0x4a19d979, 0x4a183f62, 0x4a1a0b23, 0x4a187079, 0x4a1a3cce, 0x4a18a18f, 0x4a1a6e79, + 0x4a18d2a5, 0x4a1aa023, 0x4a1903bc, 0x4a1ad1ce, 0x4a1934d2, 0x4a1b0378, 0x4a1965e8, 0x4a1b3523, + 0x4a1996ff, 0x4a1b66ce, 0x4a19c815, 0x4a1b9878, 0x4a19f92c, 0x4a1bca23, 0x4a1a2a42, 0x4a1bfbcd, + 0x4a1a5b58, 0x4a1c2d78, 0x4a1a8c6f, 0x4a1c5f23, 0x4a1abd85, 0x4a1c90cd, 0x4a1aee9b, 0x4a1cc278, + 0x4a1b1fb2, 0x4a1cf422, 0x4a1b50c8, 0x4a1d25cd, 0x4a1b81de, 0x4a1d5778, 0x4a1bb2f5, 0x4a1d8922, + 0x4a1be40b, 0x4a1dbacd, 0x4a1c1522, 0x4a1dec77, 0x4a1c4638, 0x4a1e1e22, 0x4a1c774e, 0x4a1e4fcd, + 0x4a1ca865, 0x4a1e8177, 0x4a1cd97b, 0x4a1eb322, 0x4a1d0a91, 0x4a1ee4cc, 0x4a1d3ba8, 0x4a1f1677, + 0x4a1d6cbe, 0x4a1f4822, 0x4a1d9dd5, 0x4a1f79cc, 0x4a1dceeb, 0x4a1fab77, 0x4a1e0001, 0x4a1fdd22, + 0x4a1e3118, 0x4a200ecc, 0x4a1e622e, 0x4a204077, 0x4a1e9344, 0x4a207221, 0x4a1ec45b, 0x4a20a3cc, + 0x4a1ef571, 0x4a20d577, 0x4a1f2688, 0x4a210721, 0x4a1f579e, 0x4a2138cc, 0x4a1f88b4, 0x4a216a76, + 0x4a1fb9cb, 0x4a219c21, 0x4a1feae1, 0x4a21cdcc, 0x4a201bf7, 0x4a21ff76, 0x4a204d0e, 0x4a223121, + 0x4a207e24, 0x4a2262cb, 0x4a20af3a, 0x4a229476, 0x4a20e051, 0x4a22c621, 0x4a211167, 0x4a22f7cb, + 0x4a21427e, 0x4a232976, 0x4a217394, 0x4a235b20, 0x4a21a4aa, 0x4a238ccb, 0x4a21d5c1, 0x4a23be76, + 0x4a2206d7, 0x4a23f020, 0x4a2237ed, 0x4a2421cb, 0x4a226904, 0x4a245375, 0x4a229a1a, 0x4a248520, + 0x4a22cb31, 0x4a24b6cb, 0x4a22fc47, 0x4a24e875, 0x4a232d5d, 0x4a251a20, 0x4a235e74, 0x4a254bca, + 0x4a238f8a, 0x4a257d75, 0x4a23c0a0, 0x4a25af20, 0x4a23f1b7, 0x4a25e0ca, 0x4a2422cd, 0x4a261275, + 0x4a2453e4, 0x4a26441f, 0x4a2484fa, 0x4a2675ca, 0x4a24b610, 0x4a26a775, 0x4a24e727, 0x4a26d91f, + 0x4a25183d, 0x4a270aca, 0x4a254953, 0x4a273c74, 0x4a257a6a, 0x4a276e1f, 0x4a25ab80, 0x4a279fca, + 0x4a25dc96, 0x4a27d174, 0x4a260dad, 0x4a28031f, 0x4a263ec3, 0x4a2834c9, 0x4a266fda, 0x4a286674, + 0x4a26a0f0, 0x4a28981f, 0x4a26d206, 0x4a28c9c9, 0x4a27031d, 0x4a28fb74, 0x4a273433, 0x4a292d1e, + 0x4a276549, 0x4a295ec9, 0x4a279660, 0x4a299074, 0x4a27c776, 0x4a29c21e, 0x4a27f88d, 0x4a29f3c9, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7d3802, 0xbf4ea612, 0x3f7ffcd9, 0xbf7ef91a, 0x3f7f1f3a, 0xbf437137, 0x3f7f4a36, 0xbea4643f, + 0x3f7ff534, 0x3e5a5dc9, 0x3f7e6e15, 0x3f585563, 0x3f7fb90a, 0x3f7fef9c, 0x3f7fba55, 0x3f37e46c, + 0x3f7d8a05, 0x3e83717c, 0x3f7ff4b1, 0xbe8e8b1c, 0x3f7f4c48, 0xbf610a72, 0x3f7f1ce9, 0xbf7fbe0c, + 0x3f7ffd1e, 0xbf2b82e7, 0x3f7eab24, 0xbe43cd56, 0x3f7f9bc7, 0x3eaf426f, 0x3f7fd250, 0x3f68bb2d, + 0x3f7dd708, 0x3f7e64a4, 0x3f7fe77d, 0x3f1e5afa, 0x3f7f744f, 0x3dffaa67, 0x3f7eea97, 0xbecf2f04, + 0x3f7ffffd, 0xbf6f5eaf, 0x3f7ee32f, 0xbf7be4f3, 0x3f7f797c, 0xbf4046af, 0x3f7fe541, 0xbd6d24bf, + 0x3f7e1f0c, 0x3eee2bed, 0x3f7fd540, 0x3f74ed49, 0x3f7f974e, 0x3f7841dd, 0x3f7d280e, 0x3f347c94, + 0x3f7ffdd1, 0xbc187691, 0x3f7f1635, 0xbf060aa9, 0x3f7f5228, 0xbf79608d, 0x3f7ff327, 0xbf737f99, + 0x3f7e620f, 0xbf27e1af, 0x3f7fbdf9, 0x3d9c99f8, 0x3f7fb544, 0x3f14644b, 0x3f7d7b00, 0x3f7cb357, + 0x3f7ff69b, 0x3f6da3a5, 0x3f7f4435, 0x3f1a8496, 0x3f7f25cd, 0xbe12b7fb, 0x3f7ffc04, 0xbf221245, + 0x3f7ea00f, 0xbf7ee1cd, 0x3f7fa1a8, 0xbf66b4cb, 0x3f7fce31, 0xbf0c74bd, 0x3f7dc8f4, 0x3e56793f, + 0x3f7fea5a, 0x3f2f04c2, 0x3f7f6d2d, 0x3f7fe969, 0x3f7ef46c, 0x3f5ebb0f, 0x3f7fffd5, 0x3efb84d2, + 0x3f7ed90b, 0xbe8ca135, 0x3f7f804e, 0xbf3b2cc9, 0x3f7fe215, 0xbf7fc8fc, 0x3f7e11e8, 0xbf55bfab, + 0x3f7fd90f, 0xbedcfd35, 0x3f7f911e, 0x3ead631c, 0x3f7ebe05, 0x3f467c49, 0x3f7ffe9c, 0x3f7e80a9, + 0x3f7f0d02, 0x3f4bcd02, 0x3f7f59ed, 0x3ebd75f3, 0x3f7ff0ee, 0xbecd5c6f, 0x3f7e55dc, 0xbf50e62e, + 0x3f7fc2ba, 0xbf7c11ed, 0x3f7fb007, 0xbf40ee98, 0x3f7d6bcf, 0xbe9d1386, 0x3f7ff858, 0x3eec6832, + 0x3f7f3bf4, 0x3f5a5e6a, 0x3f7f2e83, 0x3f787f99, 0x3f7ffabc, 0x3f3530fe, 0x3f7e94cd, 0x3e77f6c8, + 0x3f7fa75b, 0xbf05313e, 0x3f7fc9e6, 0xbf62da0b, 0x3f7dbab3, 0xbf73cdce, 0x3f7fed0a, 0xbf28a1ca, + 0x3f7f65de, 0xbe34a7ac, 0x3f7efe13, 0x3f13944e, 0x3f7fff80, 0x3f6a4f3e, 0x3f7eceba, 0x3f7deef1, + 0x3f7f86f4, 0x3f1b4f83, 0x3f7fdebb, 0x3de10f28, 0x3f7e0497, 0xbf214ca6, 0x3f7fdcb1, 0xbf70b565, + 0x3f7f8ac1, 0xbf7b2dbc, 0x3f7ec89e, 0xbf0d4991, 0x3f7fff39, 0xbd2f953b, 0x3f7f03a3, 0x3f2e4a67, + 0x3f7f6184, 0x3f760518, 0x3f7fee86, 0x3f7749f5, 0x3f7e497b, 0x3efd405d, 0x3f7fc74e, 0xbcc77deb, + 0x3f7faa9b, 0xbf3a7e88, 0x3f7d5c70, 0xbf7a3831, 0x3f7ff9e8, 0xbf72481e, 0x3f7f3385, 0xbedec8a1, + 0x3f7f370c, 0x3dbb4fe2, 0x3f7ff947, 0x3f45daed, 0x3f7e895d, 0x3f7d49d7, 0x3f7face1, 0x3f6c2e01, + 0x3f7fc56c, 0x3ebf4f2e, 0x3f7dac44, 0xbe21f3cd, 0x3f7fef8c, 0xbf505270, 0x3f7f5e62, 0xbf7f367a, + 0x3f7f078d, 0xbf6502ae, 0x3f7ffefd, 0xbe9ef86b, 0x3f7ec43c, 0x3e658450, 0x3f7f8d6c, 0x3f59d8f7, + 0x3f7fdb34, 0x3f7ffbe2, 0x3f7df719, 0x3f5cce6e, 0x3f7fe025, 0x3e7bd386, 0x3f7f8436, 0xbe9405a9, + 0x3f7ed309, 0xbf62637b, 0x3f7fffa9, 0xbf7f992b, 0x3f7efa15, 0xbf539ac0, 0x3f7f68ed, 0xbe3892e5, + 0x3f7febf2, 0x3eb49dee, 0x3f7e3cee, 0x3f69e81c, 0x3f7fcbb4, 0x3f7e0ec6, 0x3f7fa502, 0x3f49724a, + 0x3f7d4ce4, 0x3de8f980, 0x3f7ffb4a, 0xbed46542, 0x3f7f2aea, 0xbf705e28, 0x3f7f3f67, 0xbf7b5e7b, + 0x3f7ff7a5, 0xbf3e60ca, 0x3f7e7dc0, 0xbd3f7f69, 0x3f7fb23a, 0x3ef336e4, 0x3f7fc0c6, 0x3f75be24, + 0x3f7d9da8, 0x3f778b68, 0x3f7ff1e0, 0x3f32730f, 0x3f7f56b8, 0xbca7a36c, 0x3f7f10da, 0xbf087795, +] )) ), + +################ chunk 22016 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x4a2829a3, 0x4a2a2574, 0x4a285ab9, 0x4a2a571e, 0x4a288bd0, 0x4a2a88c9, 0x4a28bce6, 0x4a2aba73, + 0x4a28edfc, 0x4a2aec1e, 0x4a291f13, 0x4a2b1dc9, 0x4a295029, 0x4a2b4f73, 0x4a298140, 0x4a2b811e, + 0x4a29b256, 0x4a2bb2c8, 0x4a29e36c, 0x4a2be473, 0x4a2a1483, 0x4a2c161e, 0x4a2a4599, 0x4a2c47c8, + 0x4a2a76af, 0x4a2c7973, 0x4a2aa7c6, 0x4a2cab1d, 0x4a2ad8dc, 0x4a2cdcc8, 0x4a2b09f2, 0x4a2d0e73, + 0x4a2b3b09, 0x4a2d401d, 0x4a2b6c1f, 0x4a2d71c8, 0x4a2b9d36, 0x4a2da372, 0x4a2bce4c, 0x4a2dd51d, + 0x4a2bff62, 0x4a2e06c8, 0x4a2c3079, 0x4a2e3872, 0x4a2c618f, 0x4a2e6a1d, 0x4a2c92a5, 0x4a2e9bc7, + 0x4a2cc3bc, 0x4a2ecd72, 0x4a2cf4d2, 0x4a2eff1d, 0x4a2d25e9, 0x4a2f30c7, 0x4a2d56ff, 0x4a2f6272, + 0x4a2d8815, 0x4a2f941c, 0x4a2db92c, 0x4a2fc5c7, 0x4a2dea42, 0x4a2ff772, 0x4a2e1b58, 0x4a30291c, + 0x4a2e4c6f, 0x4a305ac7, 0x4a2e7d85, 0x4a308c71, 0x4a2eae9c, 0x4a30be1c, 0x4a2edfb2, 0x4a30efc7, + 0x4a2f10c8, 0x4a312171, 0x4a2f41df, 0x4a31531c, 0x4a2f72f5, 0x4a3184c6, 0x4a2fa40b, 0x4a31b671, + 0x4a2fd522, 0x4a31e81c, 0x4a300638, 0x4a3219c6, 0x4a30374e, 0x4a324b71, 0x4a306865, 0x4a327d1b, + 0x4a30997b, 0x4a32aec6, 0x4a30ca92, 0x4a32e071, 0x4a30fba8, 0x4a33121b, 0x4a312cbe, 0x4a3343c6, + 0x4a315dd5, 0x4a337570, 0x4a318eeb, 0x4a33a71b, 0x4a31c001, 0x4a33d8c6, 0x4a31f118, 0x4a340a70, + 0x4a32222e, 0x4a343c1b, 0x4a325345, 0x4a346dc6, 0x4a32845b, 0x4a349f70, 0x4a32b571, 0x4a34d11b, + 0x4a32e688, 0x4a3502c5, 0x4a33179e, 0x4a353470, 0x4a3348b4, 0x4a35661b, 0x4a3379cb, 0x4a3597c5, + 0x4a33aae1, 0x4a35c970, 0x4a33dbf8, 0x4a35fb1a, 0x4a340d0e, 0x4a362cc5, 0x4a343e24, 0x4a365e70, + 0x4a346f3b, 0x4a36901a, 0x4a34a051, 0x4a36c1c5, 0x4a34d167, 0x4a36f36f, 0x4a35027e, 0x4a37251a, + 0x4a353394, 0x4a3756c5, 0x4a3564aa, 0x4a37886f, 0x4a3595c1, 0x4a37ba1a, 0x4a35c6d7, 0x4a37ebc4, + 0x4a35f7ee, 0x4a381d6f, 0x4a362904, 0x4a384f1a, 0x4a365a1a, 0x4a3880c4, 0x4a368b31, 0x4a38b26f, + 0x4a36bc47, 0x4a38e419, 0x4a36ed5d, 0x4a3915c4, 0x4a371e74, 0x4a39476f, 0x4a374f8a, 0x4a397919, + 0x4a3780a1, 0x4a39aac4, 0x4a37b1b7, 0x4a39dc6e, 0x4a37e2cd, 0x4a3a0e19, 0x4a3813e4, 0x4a3a3fc4, + 0x4a3844fa, 0x4a3a716e, 0x4a387610, 0x4a3aa319, 0x4a38a727, 0x4a3ad4c3, 0x4a38d83d, 0x4a3b066e, + 0x4a390954, 0x4a3b3819, 0x4a393a6a, 0x4a3b69c3, 0x4a396b80, 0x4a3b9b6e, 0x4a399c97, 0x4a3bcd18, + 0x4a39cdad, 0x4a3bfec3, 0x4a39fec3, 0x4a3c306e, 0x4a3a2fda, 0x4a3c6218, 0x4a3a60f0, 0x4a3c93c3, + 0x4a3a9206, 0x4a3cc56d, 0x4a3ac31d, 0x4a3cf718, 0x4a3af433, 0x4a3d28c3, 0x4a3b254a, 0x4a3d5a6d, + 0x4a3b5660, 0x4a3d8c18, 0x4a3b8776, 0x4a3dbdc2, 0x4a3bb88d, 0x4a3def6d, 0x4a3be9a3, 0x4a3e2118, + 0x4a3c1ab9, 0x4a3e52c2, 0x4a3c4bd0, 0x4a3e846d, 0x4a3c7ce6, 0x4a3eb618, 0x4a3cadfd, 0x4a3ee7c2, + 0x4a3cdf13, 0x4a3f196d, 0x4a3d1029, 0x4a3f4b17, 0x4a3d4140, 0x4a3f7cc2, 0x4a3d7256, 0x4a3fae6d, + 0x4a3da36c, 0x4a3fe017, 0x4a3dd483, 0x4a4011c2, 0x4a3e0599, 0x4a40436c, 0x4a3e36b0, 0x4a407517, + 0x4a3e67c6, 0x4a40a6c2, 0x4a3e98dc, 0x4a40d86c, 0x4a3ec9f3, 0x4a410a17, 0x4a3efb09, 0x4a413bc1, + 0x4a3f2c1f, 0x4a416d6c, 0x4a3f5d36, 0x4a419f17, 0x4a3f8e4c, 0x4a41d0c1, 0x4a3fbf62, 0x4a42026c, + 0x49bfbf63, 0x49bfbf63, 0x49bfbf63, 0x47f12065, 0x49712065, 0x489965e8, 0x4884ba86, 0x490cebfb, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffe4d, 0xbf649c7d, 0x3f7eb990, 0xbf7299f8, 0x3f7f93b6, 0xbf25b6e6, 0x3f7fd77f, 0x3db360ef, + 0x3f7de96e, 0x3f16b5db, 0x3f7fe36c, 0x3f6bd5ba, 0x3f7f7d7e, 0x3f6c8fe4, 0x3f7edd48, 0x3f183b0a, + 0x3f7fffeb, 0xbe1e04c1, 0x3f7ef05b, 0xbf2445c9, 0x3f7f702a, 0xbf71fe27, 0x3f7fe92f, 0xbf657427, + 0x3f7e3033, 0xbf0a0f14, 0x3f7fcfed, 0x3e61a23e, 0x3f7f9f3c, 0x3f3117af, 0x3f7d3d2c, 0x3f770ea4, + 0x3f7ffc7e, 0x3f5d4efb, 0x3f7f2221, 0x3ef686d1, 0x3f7f4795, 0xbe921d5c, 0x3f7ff5d5, 0xbf3d1cb9, + 0x3f7e71f6, 0xbf7b0154, 0x3f7fb765, 0xbf5429cd, 0x3f7fbbf2, 0xbed7d24b, 0x3f7d8ee0, 0x3eb2c092, + 0x3f7ff407, 0x3f4846fe, 0x3f7f4ee0, 0x3f7dd1a7, 0x3f7f19fa, 0x3f4a0f30, 0x3f7ffd70, 0x3eb8241b, + 0x3f7eaeb7, 0xbed294ff, 0x3f7f99d3, 0xbf528995, 0x3f7fd39d, 0xbf7f7c5c, 0x3f7ddb95, 0xbf3f0ad4, + 0x3f7fe685, 0xbe97a0e8, 0x3f7f7698, 0x3ef175d3, 0x3f7ee759, 0x3f5bd89e, 0x3f800000, 0x3f7fff84, + 0x3f7ee673, 0x3f332979, 0x3f7f7739, 0x3e6cdc99, 0x3f7fe63f, 0xbf079faa, 0x3f7e234b, 0xbf642956, + 0x3f7fd3f8, 0xbf7f5a89, 0x3f7f9948, 0xbf2678dc, 0x3f7d2d46, 0xbe296561, 0x3f7ffd85, 0x3f15e786, + 0x3f7f192a, 0x3f6b721d, 0x3f7f4f96, 0x3f7d8e28, 0x3f7ff3d7, 0x3f1907ac, 0x3f7e65ff, 0x3dca5469, + 0x3f7fbc62, 0xbf2381fa, 0x3f7fb6f0, 0xbf71aa87, 0x3f7d7fea, 0xbf7a9c77, 0x3f7ff600, 0xbf0ae575, + 0x3f7f46db, 0xbd01e802, 0x3f7f22ec, 0x3ef9f77c, 0x3f7ffc65, 0x3f76cb61, 0x3f7ea3b0, 0x3f7688dd, + 0x3f7f9fc3, 0x3ef84523, 0x3f7fcf8e, 0xbd116f15, 0x3f7dcd8f, 0xbf0bb604, 0x3f7fe970, 0xbf7acebd, + 0x3f7f6f85, 0xbf715812, 0x3f7ef13c, 0xbed9a028, 0x3f7fffe7, 0x3dd20ef7, 0x3f7edc5e, 0x3f19ceac, + 0x3f7f7e1a, 0x3f7daff6, 0x3f7fe322, 0x3f6b1016, 0x3f7e1635, 0x3eb9ff6c, 0x3f7fd7d6, 0xbe2d39b3, + 0x3f7f9327, 0xbf273567, 0x3f7d1d33, 0xbf7f6bb7, 0x3f7ffe5f, 0xbf63b82f, 0x3f7f1007, 0xbe998787, + 0x3f7f576a, 0x3e70a386, 0x3f7ff1ac, 0x3f33dab4, 0x3f7e59da, 0x3f800000, 0x3f7fc132, 0x3f5b58da, + 0x3f7fb1c1, 0x3e70bc0e, 0x3f7d70c7, 0xbe997b7d, 0x3f7ff7cc, 0xbf3faff3, 0x3f7f3ea9, 0xbf7f6c24, + 0x3f7f2bb1, 0xbf51fbc7, 0x3f7ffb2c, 0xbe2d5292, 0x3f7e987d, 0x3eb9f3aa, 0x3f7fa585, 0x3f4aa773, + 0x3f7fcb51, 0x3f7db0cf, 0x3f7dbf5d, 0x3f47abcb, 0x3f7fec2f, 0x3dd2412d, 0x3f7f6845, 0xbed994bb, + 0x3f7efaf3, 0xbf54b484, 0x3f7fffa1, 0xbf7ad001, 0x3f7ed21c, 0xbf3c74d3, 0x3f7f84ce, 0xbd11d3f8, + 0x3f7fdfd7, 0x3ef83a1a, 0x3f7e08f3, 0x3f5dcb87, 0x3f7fdb87, 0x3f76cd0e, 0x3f7f8cd9, 0x3f3063da, + 0x3f7d0cf4, 0xbd01831c, 0x3f7fff0b, 0xbf0ae029, 0x3f7f06b6, 0xbf65e1f6, 0x3f7f5f0f, 0xbf71ac9c, + 0x3f7fef54, 0xbf2386d5, 0x3f7e4d89, 0x3dca222e, 0x3f7fc5d5, 0x3f19029d, 0x3f7fac64, 0x3f6cee77, + 0x3f7d6177, 0x3f6b7497, 0x3f7ff96b, 0x3f15eca4, 0x3f7f364a, 0x3daba396, 0x3f7f3449, 0xbf267411, + 0x3f7ff9c6, 0xbf72e8e3, 0x3f7e8d1c, 0xbf642c32, 0x3f7fab1a, 0xbf07a504, 0x3f7fc6e7, 0xbc889225, + 0x3f7db0fd, 0x3f3324f7, 0x3f7feebf, 0x3f77ca50, 0x3f7f60d7, 0x3f5bdbd9, 0x3f7f047c, 0x3ef180f4, + 0x3f7fff2d, 0xbd4f0406, 0x3f7ec7ac, 0xbf3f06a1, 0x3f7f8b55, 0xbf7b8d16, 0x3f7fdc5f, 0xbf528d2b, + 0x3f7dfb84, 0xbed2a080, 0x3f7fdf0a, 0x3df0b0d2, 0x3f7f865d, 0x3f4a0b50, 0x3f7cfc87, 0x3f7e2cde, + 0x3f7fb3df, 0x3f7fb3df, 0x3f7fb3df, 0x3d53e807, 0x3f6a5dc2, 0x3f7ff845, 0x3e9d5619, 0xbe01019a, +] )) ), + +################ chunk 22528 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0x49536e96, 0x492ca22c, 0x4996b43f, 0x4b16b43f, 0x4a3fbf63, 0x4a25e927, 0x4ab026f9, 0x4b04251e, + 0x4ad7cab8, 0x4b3c614f, 0x4cbc614f, 0x4befaf3b, 0x4bcf6371, 0x4c5c30b8, 0x4ca52e66, 0x4c86deb3, + 0x4ceb79a3, 0x4e6b79a3, 0x4d95cd85, 0x4d819e27, 0x4e099e73, 0x4e4e79ff, 0x4e28965f, 0x4e932c06, + 0x50132c06, 0x4f3b40e6, 0x4f2205b0, 0x4fac060f, 0x50010c3f, 0x4fd2bbf7, 0x5037f707, 0x51b7f707, + 0x50ea1120, 0x50ca871c, 0x51570793, 0x51a14f4f, 0x5183b57b, 0x51e5f4c9, 0x5365f4c9, 0x52924ab4, + 0x527d28e4, 0x530664bc, 0x5349a323, 0x5324a2d9, 0x538fb8fe, 0x550fb8fe, 0x5436dd61, 0x541e398e, + 0x54a7fdeb, 0x54fc0bec, 0x54cdcb90, 0x5533a73d, 0x56b3a73d, 0x55e494b9, 0x55c5c7f2, 0x5651fd66, + 0x569d8773, 0x56809f3a, 0x56e0910c, 0x5860910c, 0x578edcf4, 0x577739ee, 0x58033e60, 0x5844e950, + 0x5820c708, 0x588c5aa8, 0x5a0c5aa8, 0x59329431, 0x591a8435, 0x59a40df8, 0x59f623a4, 0x59c8f8ca, + 0x5a2f7151, 0x5baf7152, 0x5adf393d, 0x5ac12542, 0x5b4d1175, 0x5b99d647, 0x5b7b36fd, 0xc39d1463, + 0xc39d1463, 0xc39d1463, 0xc39d1463, 0xc39d1463, 0xc41d1463, 0xc41d1463, 0xc41d1463, 0xc41d1463, + 0xc41d1463, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc49d1463, 0xc49d1463, + 0xc49d1463, 0xc49d1463, 0xc49d1463, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, + 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc50971d6, 0xc50971d6, 0xc50971d6, + 0xc50971d6, 0xc50971d6, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc530b6ef, + 0xc530b6ef, 0xc530b6ef, 0xc530b6ef, 0xc530b6ef, 0xc544597c, 0xc544597c, 0xc544597c, 0xc544597c, + 0xc544597c, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc56b9e94, 0xc56b9e94, + 0xc56b9e94, 0xc56b9e94, 0xc56b9e94, 0xc57f4121, 0xc57f4121, 0xc57f4121, 0xc57f4121, 0xc57f4121, + 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc593431d, 0xc593431d, 0xc593431d, + 0xc593431d, 0xc593431d, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc5a6e5a9, + 0xc5a6e5a9, 0xc5a6e5a9, 0xc5a6e5a9, 0xc5a6e5a9, 0xc5b0b6ef, 0xc5b0b6ef, 0xc5b0b6ef, 0xc5b0b6ef, + 0xc5b0b6ef, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5c4597c, 0xc5c4597c, + 0xc5c4597c, 0xc5c4597c, 0xc5c4597c, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, + 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5e1cd4e, 0xc5e1cd4e, 0xc5e1cd4e, + 0xc5e1cd4e, 0xc5e1cd4e, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5f56fda, + 0xc5f56fda, 0xc5f56fda, 0xc5f56fda, 0xc5f56fda, 0xc5ff4121, 0xc5ff4121, 0xc5ff4121, 0xc5ff4121, + 0xc5ff4121, 0xc6048933, 0xc6048933, 0xc6048933, 0xc6048933, 0xc6048933, 0xc60971d6, 0xc60971d6, + 0xc60971d6, 0xc60971d6, 0xc60971d6, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, + 0xc613431d, 0xc613431d, 0xc613431d, 0xc613431d, 0xc613431d, 0xc6182bc0, 0xc6182bc0, 0xc6182bc0, + 0xc6182bc0, 0xc6182bc0, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc621fd06, + 0xc621fd06, 0xc621fd06, 0xc621fd06, 0xc621fd06, 0xc626e5a9, 0xc626e5a9, 0xc626e5a9, 0xc626e5a9, + 0xc626e5a9, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc630b6ef, 0xc630b6ef, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3e447690, 0xbf79fd4d, 0xbf606bb3, 0xbf24480d, 0x3f7ecfa9, 0x3f7d625f, 0x3d89e781, 0x3de055b4, + 0xbf6432f4, 0x3f075e59, 0xbe812d82, 0x3f5c1c8a, 0x3f18e481, 0x3f2f7ef7, 0x3f78b65d, 0xbc0f0283, + 0xbe8ea22c, 0xbf22817b, 0x3e574846, 0xbf669efe, 0xbe97a01f, 0xbf7c7e21, 0x3f3465fa, 0xbf51c2f3, + 0x3e2e9813, 0xbf14e7f4, 0xbe0fc7b9, 0x3f54a199, 0x3f18bbac, 0x3f3e8d0a, 0xbf7ebf9b, 0x3f33eeda, + 0xbf7f1a49, 0xbe2533ac, 0x3f79f539, 0xbf68e93a, 0x3f791092, 0x3e853016, 0xbf026791, 0x3f2b57ba, + 0xbf19ae4d, 0x3f1e7812, 0x3f5b1166, 0xbf5a3d48, 0xbe964265, 0xbf39c901, 0xbefef1d1, 0x3de84c39, + 0xbf6c9b15, 0x3f46727f, 0x3f1c387e, 0x3f7fff09, 0x3f7fc25a, 0xbf1e9dbe, 0xbdc6dea7, 0xbf67b6bc, + 0xbea67f7c, 0xbf760042, 0x3f3f2084, 0x3f655e48, 0x3f608210, 0x3f5d726c, 0x3f0ab6e7, 0x3ef8484a, + 0x3f06d02e, 0xbe0fdaf1, 0x3edb8f9e, 0x3e975720, 0xbf544b72, 0xbf595591, 0xbeafc1dd, 0xbf3d8e0b, + 0x3ef747b3, 0x3e8db2d7, 0xbf7b4e98, 0xbf7ff202, 0xbebb9bfd, 0xbf2a5c8b, 0xbf3fde49, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, +] )) ), + +################ chunk 23040 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0xc630b6ef, 0xc630b6ef, 0xc630b6ef, 0xc6359f92, 0xc6359f92, 0xc6359f92, 0xc6359f92, 0xc6359f92, + 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63f70d8, 0xc63f70d8, 0xc63f70d8, + 0xc63f70d8, 0xc63f70d8, 0xc644597c, 0xc644597c, 0xc644597c, 0xc644597c, 0xc644597c, 0xc649421f, + 0xc649421f, 0xc649421f, 0xc649421f, 0xc649421f, 0xc64e2ac2, 0xc64e2ac2, 0xc64e2ac2, 0xc64e2ac2, + 0xc64e2ac2, 0xc6531365, 0xc6531365, 0xc6531365, 0xc6531365, 0xc6531365, 0xc657fc08, 0xc657fc08, + 0xc657fc08, 0xc657fc08, 0xc657fc08, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, + 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc666b5f1, 0xc666b5f1, 0xc666b5f1, + 0xc666b5f1, 0xc666b5f1, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc6708737, + 0xc6708737, 0xc6708737, 0xc6708737, 0xc6708737, 0xc6756fda, 0xc6756fda, 0xc6756fda, 0xc6756fda, + 0xc6756fda, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67f4121, 0xc67f4121, + 0xc67f4121, 0xc67f4121, 0xc67f4121, 0xc68214e2, 0xc68214e2, 0xc68214e2, 0xc68214e2, 0xc68214e2, + 0xc6848933, 0xc6848933, 0xc6848933, 0xc6848933, 0xc6848933, 0xc686fd85, 0xc686fd85, 0xc686fd85, + 0xc686fd85, 0xc686fd85, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68be628, + 0xc68be628, 0xc68be628, 0xc68be628, 0xc68be628, 0xc68e5a7a, 0xc68e5a7a, 0xc68e5a7a, 0xc68e5a7a, + 0xc68e5a7a, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc693431d, 0xc693431d, + 0xc693431d, 0xc693431d, 0xc693431d, 0xc695b76e, 0xc695b76e, 0xc695b76e, 0xc695b76e, 0xc695b76e, + 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc69aa011, 0xc69aa011, 0xc69aa011, + 0xc69aa011, 0xc69aa011, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69f88b4, + 0xc69f88b4, 0xc69f88b4, 0xc69f88b4, 0xc69f88b4, 0xc6a1fd06, 0xc6a1fd06, 0xc6a1fd06, 0xc6a1fd06, + 0xc6a1fd06, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a6e5a9, 0xc6a6e5a9, + 0xc6a6e5a9, 0xc6a6e5a9, 0xc6a6e5a9, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, + 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6ae429e, 0xc6ae429e, 0xc6ae429e, + 0xc6ae429e, 0xc6ae429e, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b32b41, + 0xc6b32b41, 0xc6b32b41, 0xc6b32b41, 0xc6b32b41, 0xc6b59f92, 0xc6b59f92, 0xc6b59f92, 0xc6b59f92, + 0xc6b59f92, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6ba8835, 0xc6ba8835, + 0xc6ba8835, 0xc6ba8835, 0xc6ba8835, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, + 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6c1e52a, 0xc6c1e52a, 0xc6c1e52a, + 0xc6c1e52a, 0xc6c1e52a, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c6cdcd, + 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c9421f, 0xc6c9421f, 0xc6c9421f, 0xc6c9421f, + 0xc6c9421f, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6ce2ac2, 0xc6ce2ac2, + 0xc6ce2ac2, 0xc6ce2ac2, 0xc6ce2ac2, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, + 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d587b6, 0xc6d587b6, 0xc6d587b6, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, + 0x3f7ffffb, 0x3f7ffffb, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, + 0x3f7ffffb, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, +] )) ), + +################ chunk 23552 ################ + ( bitcast(float32_t, Vec(uint32_t)( [ + 0xc6d587b6, 0xc6d587b6, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6da7059, + 0xc6da7059, 0xc6da7059, 0xc6da7059, 0xc6da7059, 0xc6dce4ab, 0xc6dce4ab, 0xc6dce4ab, 0xc6dce4ab, + 0xc6dce4ab, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6e1cd4e, 0xc6e1cd4e, + 0xc6e1cd4e, 0xc6e1cd4e, 0xc6e1cd4e, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, + 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e92a43, 0xc6e92a43, 0xc6e92a43, + 0xc6e92a43, 0xc6e92a43, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6ee12e6, + 0xc6ee12e6, 0xc6ee12e6, 0xc6ee12e6, 0xc6ee12e6, 0xc6f08737, 0xc6f08737, 0xc6f08737, 0xc6f08737, + 0xc6f08737, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f56fda, 0xc6f56fda, + 0xc6f56fda, 0xc6f56fda, 0xc6f56fda, 0xc6f7e42c, 0x59800000, 0x59800000, 0x59800000, 0x5a000000, + 0x5a000000, 0x59329431, 0x591a8435, 0x58a0c708, 0x40c90fdb, 0x41490fdb, 0x41c90fdb, 0x493fbf56, + 0x4aefaf3a, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x441d1463, 0x441d1463, + 0x441d1463, 0x441d1463, 0x441d1463, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, + 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x44c4597c, 0x44c4597c, 0x44c4597c, + 0x44c4597c, 0x44c4597c, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x450971d6, + 0x450971d6, 0x450971d6, 0x450971d6, 0x450971d6, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, + 0x451d1463, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4544597c, 0x4544597c, + 0x4544597c, 0x4544597c, 0x4544597c, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, + 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x457f4121, 0x457f4121, 0x457f4121, + 0x457f4121, 0x457f4121, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x4593431d, + 0x4593431d, 0x4593431d, 0x4593431d, 0x4593431d, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, + 0x459d1463, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45b0b6ef, 0x45b0b6ef, + 0x45b0b6ef, 0x45b0b6ef, 0x45b0b6ef, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, + 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, + 0x45ce2ac2, 0x45ce2ac2, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45e1cd4e, + 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, + 0x45eb9e94, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45ff4121, 0x45ff4121, + 0x45ff4121, 0x45ff4121, 0x45ff4121, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x46048933, + 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, + 0x460e5a7a, 0x460e5a7a, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x46182bc0, + 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, + 0x461d1463, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4626e5a9, 0x4626e5a9, + 0x4626e5a9, 0x4626e5a9, 0x4626e5a9, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, +] )), bitcast(float32_t, Vec(uint32_t)( [ + 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffb, + 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, + 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, + 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffb, 0x3f7ffffb, + 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f800000, 0xbef89807, 0xbef89807, 0xbef89807, 0xbf074c8c, + 0xbf074c8c, 0x3e975720, 0xbf544b72, 0xbee4059b, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f3479c1, + 0x3f4e4104, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, + 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, + 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, + 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, +] )) ), +] diff --git a/npsr/trig/tests/data/large.py.py b/npsr/trig/tests/data/large.py.py new file mode 100644 index 0000000..3c3b912 --- /dev/null +++ b/npsr/trig/tests/data/large.py.py @@ -0,0 +1,46 @@ +from pathlib import Path +from generator import py_array, sollya, pad_list + + +def generate(func, prec): + """Generate a large sin/cos table using Sollya.""" + return sollya( + f""" + prec = {200}; + display = hexadecimal; + procedure trig_func(input) {{ + sc = {prec}(input); + if (sc != infty && sc != -infty) then {{ + print{prec}(sc); + print{prec}({func}(sc)); + }}; + }}; + """, + from_path=Path(__file__).parent / "large.sollya", + ) + + +print("from numpy_sr import Vec, bitcast, float32_t, float64_t, uint32_t, uint64_t\n") + +for func in ["sin", "cos"]: + chunk_size = 512 + for prec, lane, ulane in [ + ("double", "float64_t", "uint64_t"), + ("single", "float32_t", "uint32_t"), + ]: + data = pad_list(generate(func, prec), chunk_size) + print(f"{func}_{lane} = [") + for i in range(0, len(data), chunk_size): + chunk = data[i : i + chunk_size] + print( + f"\n################ chunk {i} ################\n", + "(", + f"bitcast({lane}, Vec({ulane})(", + py_array(chunk[::2], col=8), + ")),", + f"bitcast({lane}, Vec({ulane})(", + py_array(chunk[1::2], col=8), + "))", + "),", + ) + print("]") diff --git a/npsr/trig/tests/data/large.sollya b/npsr/trig/tests/data/large.sollya new file mode 100644 index 0000000..479acfb --- /dev/null +++ b/npsr/trig/tests/data/large.sollya @@ -0,0 +1,164 @@ +// procedure trig_func(input) { +// return printsingle(sin(input)); +// }; + +large_args = [||]; + +// 1. Systematic multiples of pi with perturbations +for k from 100 to 100000 by 100 do { + base = pi * k; + large_args = large_args @ [|base|]; + large_args = large_args @ [|base + 1e-15|]; + large_args = large_args @ [|base - 1e-15|]; + large_args = large_args @ [|base + 1e-12|]; + large_args = large_args @ [|base - 1e-12|]; +}; + +// 2. Systematic multiples of pi/2 with perturbations +for k from 100 to 100000 by 137 do { + base = pi/2 * k; + large_args = large_args @ [|base|]; + large_args = large_args @ [|base + 1e-15|]; + large_args = large_args @ [|base - 1e-15|]; + large_args = large_args @ [|base + 1e-14|]; + large_args = large_args @ [|base - 1e-14|]; +}; + +// 3. Powers of 2 and nearby values (floating point boundaries) +for e from 10 to 50 do { + base = 2^e; + large_args = large_args @ [|base|]; + large_args = large_args @ [|base + 1|]; + large_args = large_args @ [|base - 1|]; + large_args = large_args @ [|base + 0.5|]; + large_args = large_args @ [|base - 0.5|]; +}; + +// 4. Powers of 10 ranges +for e from 3 to 18 do { + base = 10^e; + large_args = large_args @ [|base|]; + large_args = large_args @ [|base * 1.1|]; + large_args = large_args @ [|base * 0.9|]; + large_args = large_args @ [|base + 1|]; + large_args = large_args @ [|base - 1|]; +}; + +// 5. Fibonacci-like sequences (often problematic for range reduction) +fib_scale = [|1, 1|]; // Reset +for i from 2 to 20 do { + next_fib = fib_scale[i-1] + fib_scale[i-2]; + fib_scale = fib_scale @ [|next_fib|]; + large_args = large_args @ [|next_fib * 1000|]; + large_args = large_args @ [|next_fib * 10000|]; + +}; + +// 6. Prime number scales (irregular patterns) +primes = [|101, 103, 107, 109, 113, 127, 131, 137, 139, 149, 151, 157, 163, 167, 173, 179, + 181, 191, 193, 197, 199, 211, 223, 227, 229, 233, 239, 241, 251, 257, 263, 269, + 271, 277, 281, 283, 293, 307, 311, 313, 317, 331, 337, 347, 349, 353, 359, 367|]; +for i from 0 to length(primes) - 1 do { + p = primes[i]; + large_args = large_args @ [|p * 1000|]; + large_args = large_args @ [|p * 10000|]; + large_args = large_args @ [|p * 100000|]; + large_args = large_args @ [|p * pi|]; + large_args = large_args @ [|p * pi/2|]; +}; + +// 7. Arguments near IEEE 754 double precision limits +large_args = large_args @ [|1.7976931348623157e+308 / 2|]; // Near max double / 2 +large_args = large_args @ [|1e308|]; +large_args = large_args @ [|1e307|]; +large_args = large_args @ [|1e306|]; + +// 8. Machine epsilon scaled values (precision boundaries) +eps = 2.220446049250313e-16; // double precision machine epsilon +for scale from 12 to 20 do { + base = 2^scale; + large_args = large_args @ [|base + eps * base|]; + large_args = large_args @ [|base - eps * base|]; + large_args = large_args @ [|base + eps * base * 2|]; + large_args = large_args @ [|base - eps * base * 2|]; +}; + +// 9. Transcendental number multiples +large_args = large_args @ [|exp(1) * 1e6|]; // e * 1M +large_args = large_args @ [|exp(1) * 1e7|]; // e * 10M +large_args = large_args @ [|exp(1) * 1e8|]; // e * 100M +large_args = large_args @ [|sqrt(2) * 1e6|]; // sqrt(2) * 1M +large_args = large_args @ [|sqrt(2) * 1e7|]; // sqrt(2) * 10M +large_args = large_args @ [|log(2) * 1e8|]; // ln(2) * 100M +large_args = large_args @ [|log(10) * 1e7|]; // ln(10) * 10M + +// 10. Arguments designed to stress specific range reduction algorithms +// Cody-Waite constants and their problematic neighbors +cody_waite_pi_hi = 3.1415926218032837; +cody_waite_pi_lo = 3.1786509424591227e-08; +for scale from 1000 to 1000000 by 1000 do { + large_args = large_args @ [|cody_waite_pi_hi * scale|]; + large_args = large_args @ [|cody_waite_pi_lo * scale * 1e8|]; +}; + +// 11. Payne-Hanek problematic arguments +// Arguments where naive range reduction fails +large_args = large_args @ [|0x1.921fb54442d18p+0 * 1e6|]; // pi with specific bit pattern +large_args = large_args @ [|0x1.921fb54442d19p+0 * 1e6|]; // pi + 1 ulp +large_args = large_args @ [|0x1.921fb54442d17p+0 * 1e6|]; // pi - 1 ulp + +// 12. Random large values in different ranges +for e from 6 to 17 do { + base = 10^e; + // Add some pseudo-random values in each range + large_args = large_args @ [|base * 0.123456789|]; + large_args = large_args @ [|base * 0.987654321|]; + large_args = large_args @ [|base * 0.314159265|]; + large_args = large_args @ [|base * 0.271828182|]; + large_args = large_args @ [|base * 0.577215664|]; // Euler-Mascheroni constant + large_args = large_args @ [|base * 0.866025403|]; // sqrt(3)/2 + large_args = large_args @ [|base * 0.707106781|]; // sqrt(2)/2 +}; + +// 13. Negative versions of all critical ranges +neg_critical = [||]; +for i from 0 to min(500, length(large_args) - 1) do { + neg_critical = neg_critical @ [|-large_args[i]|]; +}; +large_args = large_args @ neg_critical; + +// 14. Arguments that expose specific algorithmic weaknesses +// Values near 2^52 (where double precision integer representation changes) +large_args = large_args @ [|4503599627370496.0|]; // 2^52 +large_args = large_args @ [|4503599627370497.0|]; // 2^52 + 1 +large_args = large_args @ [|4503599627370495.0|]; // 2^52 - 1 +large_args = large_args @ [|9007199254740992.0|]; // 2^53 +large_args = large_args @ [|9007199254740991.0|]; // 2^53 - 1 + +// 15. Additional stress test values +stress_values = [| + // Mathematical constants scaled up + pi * 1e15, exp(1) * 1e15, sqrt(2) * 1e15, + + // Values that have caused issues in other implementations + 6.2831853071795864769, // 2*pi with specific precision + 12.566370614359172954, // 4*pi + 25.132741228718345908, // 8*pi + + // Large odd multiples of pi/4 + pi/4 * 999999, pi/4 * 9999999, + + // Values near overflow in intermediate calculations + 1e154, 1e155, 1e156, + + // Challenging values for specific processor architectures + 0x1.fffffffffffffp+1023, // Near max normal double + 0x1.fffffffffffffp+1022 +|]; + +large_args = large_args @ stress_values; +num_cases = length(large_args) - 1; +for i from 0 to num_cases do { + arg = large_args[i]; + trig_func(arg); +}; diff --git a/npsr/trig/tests/test_sincos.py b/npsr/trig/tests/test_sincos.py new file mode 100644 index 0000000..6c18522 --- /dev/null +++ b/npsr/trig/tests/test_sincos.py @@ -0,0 +1,26 @@ +from pytest import mark +from numpy_sr import Precise +from .data import large as large_data + + +@mark.parametrize( + "prec, max_ulp", + [ + (Precise(), 1), + (Precise(kLowAccuracy=True), 4), + ], +) +class TestSinCos: + @mark.parametrize("lane_str", ["float64_t", "float32_t"]) + def test_sin_stress(self, prec, max_ulp, lane_str): + data = getattr(large_data, f"sin_{lane_str}") + for input, expected in data: + actual = Sin(prec, input) + assert_ulp(actual, expected, input, max_ulp=max_ulp) + + @mark.parametrize("lane_str", ["float64_t", "float32_t"]) + def test_cos_stress(self, prec, max_ulp, lane_str): + data = getattr(large_data, f"cos_{lane_str}") + for input, expected in data: + actual = Cos(prec, input) + assert_ulp(actual, expected, input, max_ulp=max_ulp) From 4188588533268a1a7526318ffcba606a2eb3f494 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:30:16 +0300 Subject: [PATCH 10/20] Remove Sin/Cos bindings from precision template Clean up empty PreciseBind function in preparation for proper implementation --- test/src/prec-bind-inl.h | 2 -- 1 file changed, 2 deletions(-) diff --git a/test/src/prec-bind-inl.h b/test/src/prec-bind-inl.h index f5a3ec6..abab60b 100644 --- a/test/src/prec-bind-inl.h +++ b/test/src/prec-bind-inl.h @@ -15,8 +15,6 @@ namespace npsr::HWY_NAMESPACE::test { template HWY_ATTR bool PreciseBind(PyObject *m) { bool r = true; - r &= AttachIntrinsic...>(m, "Sin"); - r &= AttachIntrinsic...>(m, "Cos"); return r; } From 2edd3d7057274d84fc0ed2a98d64a017b9a15bb3 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 10:31:11 +0300 Subject: [PATCH 11/20] Bind Sin/Cos intrinsics to Python interface Enable trigonometric functions in the Python testing framework --- test/src/prec-bind-inl.h | 2 ++ 1 file changed, 2 insertions(+) diff --git a/test/src/prec-bind-inl.h b/test/src/prec-bind-inl.h index abab60b..f5a3ec6 100644 --- a/test/src/prec-bind-inl.h +++ b/test/src/prec-bind-inl.h @@ -15,6 +15,8 @@ namespace npsr::HWY_NAMESPACE::test { template HWY_ATTR bool PreciseBind(PyObject *m) { bool r = true; + r &= AttachIntrinsic...>(m, "Sin"); + r &= AttachIntrinsic...>(m, "Cos"); return r; } From b6593084b5eff083ab4c67fba658cd5d4b4727f1 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 11:04:33 +0300 Subject: [PATCH 12/20] Fix polynomial evaluation for large arguments in double precision - Correct polynomial coefficients for double precision cosine - Fix table indexing and data layout for lookup tables - Improve accuracy for large argument range reduction --- npsr/trig/large-inl.h | 121 +++++++++++++++++++++++------------------- 1 file changed, 67 insertions(+), 54 deletions(-) diff --git a/npsr/trig/large-inl.h b/npsr/trig/large-inl.h index c7f8072..c3f4eb6 100644 --- a/npsr/trig/large-inl.h +++ b/npsr/trig/large-inl.h @@ -1,20 +1,25 @@ -#include "npsr/common.h" -#include "npsr/trig/lut-inl.h" -// clang-format off -#if defined(NPSR_TRIG_LARGE_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#if defined(NPSR_TRIG_LARGE_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT #ifdef NPSR_TRIG_LARGE_INL_H_ #undef NPSR_TRIG_LARGE_INL_H_ #else #define NPSR_TRIG_LARGE_INL_H_ #endif +#include "npsr/common.h" +#include "npsr/trig/data/large-aprox.h" +#include "npsr/trig/data/large-reduction.h" + HWY_BEFORE_NAMESPACE(); namespace npsr::HWY_NAMESPACE::sincos { -template HWY_API V LargeArg(V x) { +template +HWY_API V LargeArg(V x) { using namespace hwy; using namespace hwy::HWY_NAMESPACE; - + using trig::data::kCosApproxTable; + using trig::data::kLargeReductionTable; + using trig::data::kSinApproxTable; + using D = DFromV; using DI = RebindToSigned; using DU = RebindToUnsigned; @@ -27,14 +32,15 @@ template HWY_API V LargeArg(V x) { const DU du; constexpr bool kIsSingle = std::is_same_v; - + // ============================================================================= // PHASE 1: Table Lookup for Reduction Constants // ============================================================================= // Each table entry contains 3 consecutive values [high, mid, low] // providing ~96-bit (F32) or ~192-bit (F64) precision for (4/π) × 2^exp VU u_exponent = GetBiasedExponent(x); - VI i_table_idx = BitCast(di, Add(ShiftLeft<1>(u_exponent), u_exponent)); // × 2 + 1 = × 3 + VI i_table_idx = + BitCast(di, Add(ShiftLeft<1>(u_exponent), u_exponent)); // × 2 + 1 = × 3 // Gather three parts of (4/π) × 2^exp from precomputed table // Generated by Python script with offset: 70 (F32) or 137 (F64) @@ -50,10 +56,11 @@ template HWY_API V LargeArg(V x) { V abx = Abs(x); VU u_input = BitCast(du, abx); VU u_significand = And(u_input, Set(du, MantissaMask())); - // Add implicit leading 1 bit - VU u_integer_bit = Or(u_significand, Set(du, static_cast(1) << MantissaBits())); + // Add implicit leading 1 bit + VU u_integer_bit = + Or(u_significand, Set(du, static_cast(1) << MantissaBits())); VU u_mantissa = Or(u_significand, u_integer_bit); - + // Split mantissa into halves for extended precision multiplication // F32: 16-bit halves, F64: 32-bit halves constexpr int kHalfShift = (sizeof(T) / 2) * 8; @@ -68,7 +75,7 @@ template HWY_API V LargeArg(V x) { VU u_p3 = ShiftRight(u_p_med); VU u_p4 = And(u_p_hi, u_low_mask); VU u_p5 = ShiftRight(u_p_hi); - + // ============================================================================= // PHASE 3: Extended Precision Multiplication // ============================================================================= @@ -81,7 +88,7 @@ template HWY_API V LargeArg(V x) { VU u_m14 = Mul(u_m1, u_p4); // Omit u_m1 × u_p5 to prevent overflow - // Products with medium precision part + // Products with medium precision part VU u_m02 = Mul(u_m0, u_p2); VU u_m03 = Mul(u_m0, u_p3); VU u_m12 = Mul(u_m1, u_p2); @@ -114,7 +121,7 @@ template HWY_API V LargeArg(V x) { VU u_col1 = Add(u_low02, Add(u_m11, u_carry01)); VU u_col0 = Add(u_low03, Add(u_m12, u_carry02)); - // Carry propagation through columns + // Carry propagation through columns VU u_sum0 = Add(u_carry10, u_col1); VU u_carry_final0 = ShiftRight(u_sum0); VU u_sum1 = Add(u_carry_final0, u_col0); @@ -124,34 +131,37 @@ template HWY_API V LargeArg(V x) { VU u_carry_final2 = ShiftRight(u_sum2); VU u_sum3 = Add(u_carry_final2, u_col3); - // Assemble final result + // Assemble final result VU u_result0 = And(u_sum0, u_low_mask); VU u_result2 = And(u_sum2, u_low_mask); VU u_result3 = ShiftLeft(u_sum3); VU u_reduce_lo = Add(u_sum1_shifted, u_result0); - VU u_reduce_hi = Add(u_result3, u_result2); + VU u_reduce_hi = Add(u_result3, u_result2); // ============================================================================= // PHASE 5: Extract Quotient and Fractional Parts // ============================================================================= - - // Extract integer quotient - constexpr int kQuotientShift = ExponentBits() + 1; // 9 for F32, 12 for F64 + + // Extract integer quotient + constexpr int kQuotientShift = + ExponentBits() + 1; // 9 for F32, 12 for F64 VU u_shifted_n = ShiftRight(u_reduce_hi); // fractional shifts derived from magic constants // F32: 5, 18, 14 (sum = 37, total with quotient = 46 = 2×23) // F64: 28, 24, 40 (sum = 92, total with quotient = 104 = 2×52) - constexpr int kFracLowShift = kIsSingle ? 5 : 28; - constexpr int kFracMidShift = kIsSingle ? 18 : 24; - constexpr int kFracHighShift = kIsSingle ? 14 : 40; + constexpr int kFracLowShift = kIsSingle ? 5 : 28; + constexpr int kFracMidShift = kIsSingle ? 18 : 24; + constexpr int kFracHighShift = kIsSingle ? 14 : 40; // Verify total shift constraint - constexpr int kTotalShift = kQuotientShift + kFracLowShift + kFracMidShift + kFracHighShift; - static_assert(kTotalShift == (kIsSingle ? 46 : 104), "Total shift must equal 2×mantissa_bits"); - - // Extract fractional parts + constexpr int kTotalShift = + kQuotientShift + kFracLowShift + kFracMidShift + kFracHighShift; + static_assert(kTotalShift == (kIsSingle ? 46 : 104), + "Total shift must equal 2×mantissa_bits"); + + // Extract fractional parts constexpr TU kFracMidMask = (static_cast(1) << kFracMidShift) - 1; VU u_frac_low_bits = And(u_reduce_lo, Set(du, kFracMidMask)); VU u_shifted_sig_lo = ShiftLeft(u_frac_low_bits); @@ -163,12 +173,14 @@ template HWY_API V LargeArg(V x) { // magic constants for branchless int→float conversion // Handle sign bit VU u_sign_bit = And(BitCast(du, x), Set(du, SignMask())); - VU u_exponent_part = Xor(u_sign_bit, BitCast(du, Set(d, static_cast(1.0)))); + VU u_exponent_part = + Xor(u_sign_bit, BitCast(du, Set(d, static_cast(1.0)))); VU u_quotient_signed = Or(u_shifted_n, u_exponent_part); // Magic number conversion for quotient V shifter = Set(d, kIsSingle ? 0x1.8p15f : 0x1.8p43); V integer_part = Add(shifter, BitCast(d, u_quotient_signed)); + V n = Sub(integer_part, shifter); V reduced_hi = Sub(BitCast(d, u_quotient_signed), n); @@ -177,14 +189,16 @@ template HWY_API V LargeArg(V x) { VU u_exp_low = Xor(u_sign_bit, u_epsilon_low); VU u_frac_low_combined = Or(u_shifted_sig_lo, u_exp_low); - constexpr TU kFracHighMask = (static_cast(1) << (kFracHighShift - kFracLowShift)) - 1; + constexpr TU kFracHighMask = + (static_cast(1) << (kFracHighShift - kFracLowShift)) - 1; VU u_frac_high_bits = And(u_reduce_hi, Set(du, kFracHighMask)); V shifter_lo = BitCast(d, u_exp_low); V reduced_lo = Sub(BitCast(d, u_frac_low_combined), shifter_lo); VU u_epsilon = BitCast(du, Set(d, kIsSingle ? 0x1p-23f : 0x1p-52)); VU u_exp_mid = Xor(u_sign_bit, u_epsilon); - VU u_shifted_sig_mid = Or(ShiftLeft(u_frac_high_bits), u_frac_mid_bits); + VU u_shifted_sig_mid = + Or(ShiftLeft(u_frac_high_bits), u_frac_mid_bits); VU u_frac_mid_combined = Or(u_shifted_sig_mid, u_exp_mid); V shifter_mid = BitCast(d, u_exp_mid); V reduced_med = Sub(BitCast(d, u_frac_mid_combined), shifter_mid); @@ -193,7 +207,7 @@ template HWY_API V LargeArg(V x) { // PHASE 7: Convert to Radians // ============================================================================= - // High-precision 2π constants + // High-precision 2π constants V _2pu_lead = Set(d, kIsSingle ? 0x1.921fb6p2f : 0x1.921fb54442d18p+2); V _2pu_trail = Set(d, kIsSingle ? -0x1.777a5cp-23f : 0x1.1a62633145c07p-52); @@ -210,7 +224,7 @@ template HWY_API V LargeArg(V x) { V red_lo_final = MulAdd(_2pu_lead, r_lo, red_lo_final_part); // ============================================================================= - // PHASE 8: Small Argument Handling + // PHASE 8: Small Argument Handling // ============================================================================= const V min_input = Set(d, static_cast(0x1p-20)); @@ -219,35 +233,32 @@ template HWY_API V LargeArg(V x) { V r = IfThenElse(ismall_arg, x, red_hi); V e = IfThenElse(ismall_arg, Zero(d), red_lo_final); - // Calculate table index + // Calculate table index VU u_n_mask = Set(du, kIsSingle ? 0xFF : 0x1FF); VU u_index = And(BitCast(du, integer_part), u_n_mask); - constexpr int kTableEntryBytesShift = kIsSingle ? 2 : 3; - VI u_table_index = BitCast(di, ShiftLeft(u_index)); + VI u_table_index = BitCast(di, ShiftLeft<2>(u_index)); // ============================================================================= - // PHASE 9: Table Lookup + // PHASE 9: Table Lookup // ============================================================================= - + const T *table_base = IS_COS ? kCosApproxTable : kSinApproxTable; - // Gather table values: [deriv_error, sin_hi, sin_lo, deriv] + // Gather table values: [deriv_error, sin_hi, sin_lo, deriv] // Based on Sollya script: p0=deriv_error, p1=sin_hi, p2=sin_lo, - // p3=deriv + // p3=deriv V deriv_error = GatherIndex(d, table_base, u_table_index); - V sin_hi = GatherIndex(d, table_base + 1, u_table_index); - V sin_lo = GatherIndex(d, table_base + 2, u_table_index); - V deriv = GatherIndex(d, table_base + 3, u_table_index); - + V deriv = GatherIndex(d, table_base + 1, u_table_index); + V sin_hi = GatherIndex(d, table_base + 2, u_table_index); + V sin_lo = GatherIndex(d, table_base + 3, u_table_index); // ============================================================================= - // PHASE 10: Final Assembly + // PHASE 10: Final Assembly // ============================================================================= V r2 = Mul(r, r); - // Apply first-order correction: sin_hi + deriv × r V first_order = MulAdd(deriv, r, sin_hi); - V linear_error =MulAdd(deriv, r, Sub(sin_hi, first_order)); + V linear_error = MulAdd(deriv, r, Sub(sin_hi, first_order)); // Apply derivative error correction V deriv_corrected = MulAdd(r, deriv_error, first_order); @@ -264,25 +275,27 @@ template HWY_API V LargeArg(V x) { V c2 = Set(d, kIsSingle ? 0x1.5554f8p-5f : 0x1.5555555554ccfp-5); V c1 = Set(d, static_cast(-0.5)); - V cos_poly = MulAdd(c2, r2, c1); + V cos_poly; + if constexpr (kIsSingle) { + cos_poly = MulAdd(c2, r2, c1); + } else { + V c3 = Set(d, -0x1.6c16ab163b2d7p-10); + cos_poly = MulAdd(c3, r2, c2); + cos_poly = MulAdd(r2, cos_poly, c1); + } cos_poly = Mul(cos_poly, r2); - // Apply cross-term corrections V func_deriv_sum = Add(deriv_error, deriv); V corr1 = NegMulAdd(sin_hi, r, func_deriv_sum); // Apply remaining corrections V corr = MulAdd(corr1, e, sin_lo); - - V poly_correction = MulAdd(corr1, sin_poly, total_linear_error); - + V poly_correction = MulAdd(func_deriv_sum, sin_poly, total_linear_error); V cos_correction = MulAdd(sin_hi, cos_poly, corr); V final_correction = Add(cos_correction, poly_correction); - - // Assemble final result: primary_value + all_corrections return Add(deriv_corrected, final_correction); } // NOLINTNEXTLINE(google-readability-namespace-comments) -} // namespace npsr::HWY_NAMESPACE::sincos +} // namespace npsr::HWY_NAMESPACE::sincos HWY_AFTER_NAMESPACE(); -#endif // NPSR_TRIG_LARGE_INL_H_ +#endif // NPSR_TRIG_LARGE_INL_H_ From 2de06078fda96657d17fa43a0f32de6b2a31bfc1 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 11:05:44 +0300 Subject: [PATCH 13/20] Fix small argument handling and add cosine support for double precision - Implement efficient SVML-style linear approximation for sin/cos - Fix precision issues in Cody-Waite range reduction - Add proper sign handling for both sine and cosine - Improve polynomial evaluation with correction terms - Document mathematical equivalence between traditional and optimized approaches --- npsr/trig/small-inl.h | 226 +++++++++++++++++++++++++++--------------- 1 file changed, 146 insertions(+), 80 deletions(-) diff --git a/npsr/trig/small-inl.h b/npsr/trig/small-inl.h index 145d6e0..4e47ff6 100644 --- a/npsr/trig/small-inl.h +++ b/npsr/trig/small-inl.h @@ -1,8 +1,8 @@ #include "npsr/common.h" -#include "npsr/trig/lut-inl.h" +#include "npsr/trig/data/small.h" #include "npsr/utils-inl.h" -#if defined(NPSR_TRIG_SMALL_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#if defined(NPSR_TRIG_SMALL_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT #ifdef NPSR_TRIG_SMALL_INL_H_ #undef NPSR_TRIG_SMALL_INL_H_ #else @@ -67,25 +67,22 @@ HWY_API V SmallPolyLow(V r, V r2) { poly = MulAdd(r2, poly, c7); poly = MulAdd(r2, poly, c5); poly = MulAdd(r2, poly, c3); - V r3 = Mul(r2, r); - poly = MulAdd(r3, poly, r); return poly; } -template HWY_API V SmallArgLow(V x) { +template +HWY_API V SmallArgLow(V x) { const DFromV d; const RebindToUnsigned du; - using U = VFromD; using T = TFromV; // Load frequently used constants as vector registers const V abs_mask = BitCast(d, Set(du, SignMask() - 1)); const V x_abs = And(abs_mask, x); - const V x_sign = AndNot(abs_mask, x); - - constexpr bool IsSingle = std::is_same_v; + const V x_sign = AndNot(x_abs, x); + constexpr bool kIsSingle = std::is_same_v; // Transform cosine to sine using identity: cos(x) = sin(x + π/2) - const V half_pi = Set(d, 0x1.921fb6p0f); + const V half_pi = Set(d, kIsSingle ? 0x1.921fb6p0f : 0x1.921fb54442d18p0); V x_trans = x_abs; if constexpr (IS_COS) { x_trans = Add(x_abs, half_pi); @@ -95,11 +92,10 @@ template HWY_API V SmallArgLow(V x) { // Compute N = round(x/π) using "magic number" technique // and stores integer part in mantissa - const V inv_pi = Set(d, IsSingle ? 0x1.45f306p-2f : 0x1.45f306dc9c883p-2); - const V magic_round = Set(d, IsSingle ? 0x1.8p23f : 0x1.8p52); + const V inv_pi = Set(d, kIsSingle ? 0x1.45f306p-2f : 0x1.45f306dc9c883p-2); + const V magic_round = Set(d, kIsSingle ? 0x1.8p23f : 0x1.8p52); V n_biased = MulAdd(x_trans, inv_pi, magic_round); V n = Sub(n_biased, magic_round); - // Adjust quotient for cosine (accounts for π/2 phase shift) if constexpr (IS_COS) { // For cosine, we computed N = round((x + π/2)/π) but need N' for x: @@ -109,20 +105,25 @@ template HWY_API V SmallArgLow(V x) { n = Sub(n, Set(d, static_cast(0.5))); } // Use Cody-Waite method with triple-precision PI - const V pi_hi = Set(d, IsSingle ? 0x1.921fb6p1f : 0x1.921fb54442d18p+1); - const V pi_med = Set(d, -0x1.777a5cp-24f); - const V pi_lo = Set(d, IsSingle ? -0x1.ee59dap-49f : 0x1.1a62633145c06p-53); - V r = NegMulAdd(n, pi_hi, x_abs); // x - N*π_hi - if constexpr (IsSingle) { - r = NegMulAdd(n, pi_med, r); // - N*π_medium + const V pi_hi = Set(d, kIsSingle ? 0x1.921fb6p1f : 0x1.921fb54442d18p+1); + const V pi_med = + Set(d, kIsSingle ? -0x1.777a5cp-24f : 0x1.c1cd129024e09p-106); + const V pi_lo = Set(d, kIsSingle ? -0x1.ee59dap-49f : 0x1.1a62633145c06p-53); + V r = NegMulAdd(n, pi_hi, x_abs); + if constexpr (kIsSingle) { + r = NegMulAdd(n, pi_med, r); } - r = NegMulAdd(n, pi_lo, r); // - N*π_low + r = NegMulAdd(n, pi_lo, r); V r2 = Mul(r, r); - // Extract octant sign information from quotient - // to determines sign flip in final result - r = Xor(r, BitCast(d, ShiftLeft(BitCast(du, n_biased)))); - V poly = SmallPolyLow(r, r2); + if constexpr (!kIsSingle) { + V r_mid = NegMulAdd(n, pi_med, r); + V r2_corr = Mul(r2, r_mid); + poly = MulAdd(r2_corr, poly, r_mid); + } + // Extract octant sign information from quotient and flip the sign bit + poly = Xor(poly, + BitCast(d, ShiftLeft(BitCast(du, n_biased)))); if constexpr (IS_COS) { poly = IfThenElse(is_cos_near_zero, Set(d, static_cast(1.0)), poly); } else { @@ -139,18 +140,16 @@ HWY_INLINE V SmallArg(V x) { using DU = RebindToUnsigned; using DH = Half; using DW = RepartitionToWide; - using VU = Vec; using VW = Vec; const D d; const DU du; const DH dh; const DW dw; - // Load frequently used constants as vector registers const V abs_mask = BitCast(d, Set(du, 0x7FFFFFFF)); const V x_abs = And(abs_mask, x); - const V x_sign = AndNot(abs_mask, x); + const V x_sign = AndNot(x_abs, x); // Transform cosine to sine using identity: cos(x) = sin(x + π/2) const V half_pi = Set(d, 0x1.921fb6p0f); @@ -236,6 +235,10 @@ HWY_INLINE V SmallArg(V x) { */ template )> HWY_INLINE V SmallArg(V x) { + using trig::data::kHiCosKPi16Table; + using trig::data::kHiSinKPi16Table; + using trig::data::kPackedLowSinCosKPi16Table; + using T = TFromV; using D = DFromV; using DU = RebindToUnsigned; @@ -245,11 +248,10 @@ HWY_INLINE V SmallArg(V x) { const DU du; // Constants for range reduction - constexpr T kInvPi = 0x1.45f306dc9c883p2; // 16/π for range reduction - constexpr T kPi16High = 0x1.921fb54442d18p-3; // π/16 high precision part - constexpr T kPi16Low = 0x1.1a62633p-57; // π/16 low precision part - constexpr T kPi16Tiny = 0x1.45c06e0e68948p-89; // π/16 tiny precision part - + constexpr T kInvPi = 0x1.45f306dc9c883p2; // 16/π for range reduction + constexpr T kPi16High = 0x1.921fb54442d18p-3; // π/16 high precision part + constexpr T kPi16Low = 0x1.1a62633p-57; // π/16 low precision part + constexpr T kPi16Tiny = 0x1.45c06e0e68948p-89; // π/16 tiny precision part // Step 1: Range reduction - find n such that x = n*(π/16) + r, where |r| < // π/16 V magic = Set(d, 0x1.8p52); @@ -258,21 +260,26 @@ HWY_INLINE V SmallArg(V x) { // Extract integer index for table lookup (n mod 16) VU n_int = BitCast(du, n_biased); + VU table_idx = And(n_int, Set(du, 0xF)); // Mask to get n mod 16 // Step 2: Load precomputed sine/cosine values for n mod 16 - V sin_hi = LutX2(kHiSinKPi16Table, n_int); - V cos_hi = LutX2(kHiCosKPi16Table, n_int); - V cos_lo = LutX2(kPackedLowSinCosKPi16Table, n_int); + V sin_hi = LutX2(kHiSinKPi16Table, table_idx); + V cos_hi = LutX2(kHiCosKPi16Table, table_idx); + // Note: cos_lo and sin_lo are packed together (32 bits each) to save memory. + // cos_lo can be used as-is since it's in the upper bits, sin_lo needs + // extraction. The precision loss is negligible for the final result. + // see lut-inl.h.py for the table generation code. + V cos_lo = LutX2(kPackedLowSinCosKPi16Table, table_idx); + // Extract sin_low from packed format (upper 32 bits) + V sin_lo = BitCast(d, ShiftLeft<32>(BitCast(du, cos_lo))); // Step 3: Multi-precision computation of remainder r - V r_hi = NegMulAdd(n, Set(d, kPi16High), x); // r = x - n*(π/16)_high - V r_mid = NegMulAdd(n, Set(d, kPi16Low), r_hi); // Subtract low part - V r = NegMulAdd(n, Set(d, kPi16Tiny), r_mid); // Subtract tiny part - + V r_hi = NegMulAdd(n, Set(d, kPi16High), x); // r = x - n*(π/16)_high + V r_mid = NegMulAdd(n, Set(d, kPi16Low), r_hi); // Subtract low part + V r = NegMulAdd(n, Set(d, kPi16Tiny), r_mid); // Subtract tiny part // Compute low precision part of r for extra accuracy - V delta = Sub(r, r_mid); - V term = NegMulAdd(Set(d, kPi16Low), n, Sub(r_hi, delta)); - V r_lo = MulAdd(Set(d, kPi16Tiny), n, delta); + V term = NegMulAdd(Set(d, kPi16Low), n, Sub(r_hi, r_mid)); + V r_lo = MulAdd(Set(d, kPi16Tiny), n, Sub(r, r_mid)); r_lo = Sub(term, r_lo); // Step 4: Polynomial approximation @@ -295,58 +302,117 @@ HWY_INLINE V SmallArg(V x) { cos_poly = MulAdd(cos_poly, r2, Set(d, -0x1.ffffffffffffcp-2)); // Step 5: Reconstruction using angle addition formulas - // sin(n*π/16 + r) = sin(n*π/16)*cos(r) + cos(n*π/16)*sin(r) - // cos(n*π/16 + r) = cos(n*π/16)*cos(r) - sin(n*π/16)*sin(r) // - // Where: - // sin(r) = r * (1 + sin_poly) - // cos(r) = 1 + r² * cos_poly + // Mathematical equivalence between traditional and SVML approaches: + // + // Traditional angle addition: + // sin(a+r) = sin(a)*cos(r) + cos(a)*sin(r) + // cos(a+r) = cos(a)*cos(r) - sin(a)*sin(r) + // + // Where for small r (|r| < π/16): + // cos(r) ≈ 1 + r²*cos_poly + // sin(r) ≈ r*(1 + sin_poly) ≈ r + r*sin_poly + // + // SVML's efficient linear approximation: + // sin(a+r) ≈ sin(a) + cos(a)*r + polynomial_corrections + // cos(a+r) ≈ cos(a) - sin(a)*r + polynomial_corrections + // + // This is mathematically equivalent but computationally more efficient: + // - Uses first-order linear terms directly: Sh + Ch*R, Ch - R*Sh + // - Applies higher-order polynomial corrections separately + // - Fewer multiplications and better numerical stability + // + // Implementation follows SVML structure: + // sin(n*π/16 + r) = sin_table + cos_table*remainder (+ corrections) + // cos(n*π/16 + r) = cos_table - sin_table*remainder (+ corrections) + V result; + if constexpr (IS_COS) { + // Cosine reconstruction: cos_table - sin_table*remainder + // Equivalent to: cos(a)*cos(r) - sin(a)*sin(r) but more efficient + V res_hi = NegMulAdd(r, sin_hi, cos_hi); // cos_hi - r*sin_hi - // Apply angle addition with multi-precision arithmetic - // Main term: sin(n*π/16) + r*cos(n*π/16) - V res_hi = MulAdd(r, cos_hi, sin_hi); + // This captures the precision lost in the main computation + V r_sin_hi = Sub(cos_hi, res_hi); // Extract high part of multiplication - // Compute error from r*cos_hi multiplication - V r_cos = Sub(res_hi, sin_hi); - V mul_err = MulSub(r, cos_hi, r_cos); + // Handles rounding errors and adds sin_low contribution + V r_sin_low = MulSub(r, sin_hi, r_sin_hi); // Compute multiplication error + V sin_low_corr = MulAdd(r, sin_lo, r_sin_low); // Add sin_low term - // Compute cos(n*π/16) - r*sin(n*π/16) for intermediate calculations - V cos_r_sin = NegMulAdd(r, sin_hi, cos_hi); + // This is used to apply the low-precision remainder correction + V sin_cos_r = MulAdd(r, cos_hi, sin_hi); - // Extract sin_low from packed format (upper 32 bits) - V sin_lo = BitCast(d, ShiftLeft<32>(BitCast(du, cos_lo))); - V lo_corr = MulAdd(r_lo, cos_r_sin, sin_lo); + // Main low precision correction: cos_low - r_low*(sin_table + cos_table*r) + // Applies the effect of the low-precision remainder on the final result + V low_corr = NegMulAdd(r_lo, sin_cos_r, cos_lo); - // Apply polynomial corrections - V r_cos_hi = Mul(cos_hi, r); - V sin_corr = Mul(sin_hi, cos_poly); // sin(n*π/16) * (cos(r)-1)/r² + // Polynomial corrections using the remainder + V r_sin = Mul(r, sin_hi); // For polynomial application - // Extract cos_low from packed format (lower 32 bits used directly) - V cos_corr = MulAdd(r, cos_lo, mul_err); - V total_corr = Add(cos_corr, lo_corr); + // Apply polynomial corrections: cos_table*cos_poly - r*sin_table*sin_poly + // This handles the higher-order terms from cos(r) and sin(r) expansions + V poly_corr = Mul(cos_hi, cos_poly); // cos(a) * (cos(r)-1)/r² + // - sin(a)*r * (sin(r)/r-1) + poly_corr = NegMulAdd(r_sin, sin_poly, poly_corr); - // Combine all terms: sin(n*π/16 + r) ≈ sin(n*π/16) + r*cos(n*π/16) + - // corrections - V result = MulAdd(r_cos_hi, sin_poly, sin_corr); - result = MulAdd(r2, result, total_corr); - result = Add(res_hi, result); + // Combine all low precision corrections + V total_low = Sub(low_corr, sin_low_corr); - // Handle sign for negative zero edge case - if constexpr (IS_COS) { - // For cosine, we need to adjust the phase by π/2 - // This would require additional logic not shown in the original - // TODO: Implement cosine-specific adjustments + // Final assembly: main_term + r²*polynomial_corrections + low_corrections + result = MulAdd(r2, poly_corr, total_low); + result = Add(res_hi, result); + + } else { + // Sine reconstruction: sin_table + cos_table*remainder + // Equivalent to: sin(a)*cos(r) + cos(a)*sin(r) but more efficient + V res_hi = MulAdd(r, cos_hi, sin_hi); // sin_hi + r*cos_hi + + // This captures the precision lost in the main computation + V r_cos_hi = Sub(res_hi, sin_hi); // Extract high part of multiplication + + // Handles rounding errors and adds cos_low contribution + V r_cos_low = MulSub(r, cos_hi, r_cos_hi); // Compute multiplication error + V cos_low_corr = MulAdd(r, cos_lo, r_cos_low); // Add cos_low term + + // Intermediate term for r_low correction: cos_table - sin_table*r + // This is used to apply the low-precision remainder correction + V cos_r_sin = NegMulAdd(r, sin_hi, cos_hi); + + // Main low precision correction: sin_low - r_low*(cos_table - sin_table*r) + // Applies the effect of the low-precision remainder on the final result + V low_corr = MulAdd(r_lo, cos_r_sin, sin_lo); + // Polynomial corrections using the remainder + V r_cos = Mul(r, cos_hi); // For polynomial application + + // Apply polynomial corrections: sin_table*cos_poly + r*cos_table*sin_poly + // This handles the higher-order terms from cos(r) and sin(r) expansions + V poly_corr = Mul(sin_hi, cos_poly); // sin(a) * (cos(r)-1)/r² + poly_corr = + MulAdd(r_cos, sin_poly, poly_corr); // + cos(a)*r * (sin(r)/r-1) + + // Combine all low precision corrections + V total_low = Add(low_corr, cos_low_corr); + // Final assembly: main_term + r²*polynomial_corrections + low_corrections + result = MulAdd(r2, poly_corr, total_low); + result = Add(res_hi, result); } - // Apply final sign correction based on quadrant - VU sign_bits = ShiftRight<4>(n_int); - sign_bits = ShiftLeft<63>(sign_bits); - result = Xor(result, BitCast(d, sign_bits)); + // Apply final sign correction same for both sine and cosine + // Both functions change sign every π radians, corresponding to bit 4 of n_int + // This unified approach works because: + // - sin(x + π) = -sin(x) + // - cos(x + π) = -cos(x) + VU x_sign_int = ShiftLeft<63>(BitCast(du, x)); + // XOR with quadrant info in n_biased + VU combined = Xor(BitCast(du, n_biased), ShiftLeft<4>(x_sign_int)); + // Extract final sign + VU sign = ShiftRight<4>(combined); + sign = ShiftLeft<63>(sign); + result = Xor(result, BitCast(d, sign)); // Apply sign flip return result; } // NOLINTNEXTLINE(google-readability-namespace-comments) -} // namespace npsr::HWY_NAMESPACE::sincos +} // namespace npsr::HWY_NAMESPACE::sincos HWY_AFTER_NAMESPACE(); -#endif // NPSR_TRIG_SMALL_INL_H_ +#endif // NPSR_TRIG_SMALL_INL_H_ From 66bdf4d676cf93149d1f57e7352447da57263e2f Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 11:06:40 +0300 Subject: [PATCH 14/20] Refactor: Extract Precise class to separate header - Move Precise class and related types to npsr/precise.h - Add deduction guides for cleaner template instantiation - Improve modularity by separating precision control from common utilities --- npsr/common.h | 174 +-------------------------------------------- npsr/precise.h | 188 +++++++++++++++++++++++++++++++++++++++++++++++++ 2 files changed, 191 insertions(+), 171 deletions(-) create mode 100644 npsr/precise.h diff --git a/npsr/common.h b/npsr/common.h index 90204fe..05e536e 100644 --- a/npsr/common.h +++ b/npsr/common.h @@ -1,179 +1,11 @@ #ifndef NUMPY_SIMD_ROUTINES_NPSR_COMMON_H_ #define NUMPY_SIMD_ROUTINES_NPSR_COMMON_H_ -#include "hwy/highway.h" +#include #include #include -namespace npsr { +#include "precise.h" -struct _NoLargeArgument {}; -struct _NoSpecialCases {}; -struct _NoExceptions {}; -struct _LowAccuracy {}; -constexpr auto kNoLargeArgument = _NoLargeArgument{}; -constexpr auto kNoSpecialCases = _NoSpecialCases{}; -constexpr auto kNoExceptions = _NoExceptions{}; -constexpr auto kLowAccuracy = _LowAccuracy{}; - -struct Round { - struct _Force {}; - struct _Nearest {}; - struct _Down {}; - struct _Up {}; - struct _Zero {}; - static constexpr auto kForce = _Force{}; - static constexpr auto kNearest = _Nearest{}; -#if 0 // not used yet - static constexpr auto kDown = _Down{}; - static constexpr auto kUp = _Up{}; - static constexpr auto kZero = _Zero{}; -#endif -}; - -struct Subnormal { - struct _DAZ {}; - struct _FTZ {}; - struct _IEEE754 {}; -#if 0 // not used yet - static constexpr auto kDAZ = _DAZ{}; - static constexpr auto kFTZ = _FTZ{}; -#endif - static constexpr auto kIEEE754 = _IEEE754{}; -}; - -struct FPExceptions { - static constexpr auto kNone = 0; - static constexpr auto kInvalid = FE_INVALID; - static constexpr auto kDivByZero = FE_DIVBYZERO; - static constexpr auto kOverflow = FE_OVERFLOW; - static constexpr auto kUnderflow = FE_UNDERFLOW; -}; - -/** - * @brief RAII floating-point precision control class - * - * The Precise class provides automatic management of floating-point environment - * settings during its lifetime. It uses RAII principles to save the current - * floating-point state on construction and restore it on destruction. - * - * The class is configured using variadic template arguments that specify - * the desired floating-point behavior through tag types. - * - * **IMPORTANT PERFORMANCE NOTE**: Create the Precise object BEFORE loops, - * not inside them. The constructor and destructor have overhead from saving - * and restoring floating-point state, so it should be done once per - * computational scope, not per iteration. - * - * @tparam Args Variadic template arguments for configuration flags - * - * @example - * ```cpp - * using namespace hwy::HWY_NAMESPACE; - * using namespace npsr; - * using namespace npsr::HWY_NAMESPACE; - * - * Precise precise = {kLowAccuracy, kNoSpecialCases, kNoLargeArgument}; - * const ScalableTag d; - * typename V = Vec>; - * for (size_t i = 0; i < n; i += Lanes(d)) { - * V input = LoadU(d, &input[i]); - * V result = Sin(precise, input); - * StoreU(result, d, &output[i]); - * } - * ``` - */ -template class Precise { -public: - Precise(Args...) { - if constexpr (!kNoExceptions) { - fegetexceptflag(&_exceptions, FE_ALL_EXCEPT); - } - if constexpr (kRoundForce) { - _rounding_mode = fegetround(); - int new_mode = _NewRoundingMode(); - if (_rounding_mode != new_mode) { - _retrieve_rounding_mode = true; - fesetround(new_mode); - } - } - } - void FlushExceptions() { fesetexceptflag(&_exceptions, FE_ALL_EXCEPT); } - - void Raise(int errors) { - static_assert(!kNoExceptions, - "Cannot raise exceptions in NoExceptions mode"); - _exceptions |= errors; - } - ~Precise() { - FlushExceptions(); - if constexpr (kRoundForce) { - if (_retrieve_rounding_mode) { - fesetround(_rounding_mode); - } - } - } - static constexpr bool kNoExceptions = - (std::is_same_v<_NoExceptions, Args> || ...); - static constexpr bool kNoLargeArgument = - (std::is_same_v<_NoLargeArgument, Args> || ...); - static constexpr bool kNoSpecialCases = - (std::is_same_v<_NoSpecialCases, Args> || ...); - static constexpr bool kLowAccuracy = - (std::is_same_v<_LowAccuracy, Args> || ...); - // defaults to high accuracy if no low accuracy flag is set - static constexpr bool kHighAccuracy = !kLowAccuracy; - // defaults to large argument support if no no large argument flag is set - static constexpr bool kLargeArgument = !kNoLargeArgument; - // defaults to special cases support if no no special cases flag is set - static constexpr bool kSpecialCases = !kNoSpecialCases; - // defaults to exception support if no no exception flag is set - static constexpr bool kException = !kNoExceptions; - - static constexpr bool kRoundForce = - (std::is_same_v || ...); - static constexpr bool _kRoundNearest = - (std::is_same_v || ...); - static constexpr bool kRoundZero = - (std::is_same_v || ...); - static constexpr bool kRoundDown = - (std::is_same_v || ...); - static constexpr bool kRoundUp = (std::is_same_v || ...); - // only one rounding mode can be set - static_assert((_kRoundNearest + kRoundDown + kRoundUp + kRoundZero) <= 1, - "Only one rounding mode can be set at a time"); - // if no rounding mode is set, default to round nearest - static constexpr bool kRoundNearest = - _kRoundNearest || (!kRoundDown && !kRoundUp && !kRoundZero); - - static constexpr bool kDAZ = (std::is_same_v || ...); - static constexpr bool kFTZ = (std::is_same_v || ...); - static constexpr bool _kIEEE754 = - (std::is_same_v || ...); - static_assert(!_kIEEE754 || !(kDAZ || kFTZ), - "IEEE754 mode cannot be used " - "with Denormals Are Zero (DAZ) or Flush To Zero (FTZ) " - "subnormal handling"); - static constexpr bool kIEEE754 = _kIEEE754 || !(kDAZ || kFTZ); - -private: - int _NewRoundingMode() const { - if constexpr (kRoundDown) { - return FE_DOWNWARD; - } else if constexpr (kRoundUp) { - return FE_UPWARD; - } else if constexpr (kRoundZero) { - return FE_TOWARDZERO; - } else { - return FE_TONEAREST; - } - } - int _rounding_mode = 0; - bool _retrieve_rounding_mode = false; - fexcept_t _exceptions; -}; - -} // namespace npsr - -#endif // NUMPY_SIMD_ROUTINES_NPSR_COMMON_H_ +#endif // NUMPY_SIMD_ROUTINES_NPSR_COMMON_H_ diff --git a/npsr/precise.h b/npsr/precise.h new file mode 100644 index 0000000..2097a45 --- /dev/null +++ b/npsr/precise.h @@ -0,0 +1,188 @@ +#ifndef NUMPY_SIMD_ROUTINES_NPSR_PRECISE_H_ +#define NUMPY_SIMD_ROUTINES_NPSR_PRECISE_H_ +#include +#include + +#include "hwy/highway.h" + +namespace npsr { + +struct _NoLargeArgument {}; +struct _NoSpecialCases {}; +struct _NoExceptions {}; +struct _LowAccuracy {}; +constexpr auto kNoLargeArgument = _NoLargeArgument{}; +constexpr auto kNoSpecialCases = _NoSpecialCases{}; +constexpr auto kNoExceptions = _NoExceptions{}; +constexpr auto kLowAccuracy = _LowAccuracy{}; + +struct Round { + struct _Force {}; + struct _Nearest {}; + struct _Down {}; + struct _Up {}; + struct _Zero {}; + static constexpr auto kForce = _Force{}; + static constexpr auto kNearest = _Nearest{}; +#if 0 // not used yet + static constexpr auto kDown = _Down{}; + static constexpr auto kUp = _Up{}; + static constexpr auto kZero = _Zero{}; +#endif +}; + +struct Subnormal { + struct _DAZ {}; + struct _FTZ {}; + struct _IEEE754 {}; +#if 0 // not used yet + static constexpr auto kDAZ = _DAZ{}; + static constexpr auto kFTZ = _FTZ{}; +#endif + static constexpr auto kIEEE754 = _IEEE754{}; +}; + +struct FPExceptions { + static constexpr auto kNone = 0; + static constexpr auto kInvalid = FE_INVALID; + static constexpr auto kDivByZero = FE_DIVBYZERO; + static constexpr auto kOverflow = FE_OVERFLOW; + static constexpr auto kUnderflow = FE_UNDERFLOW; +}; + +/** + * @brief RAII floating-point precision control class + * + * The Precise class provides automatic management of floating-point + * environment settings during its lifetime. It uses RAII principles to save + * the current floating-point state on construction and restore it on + * destruction. + * + * The class is configured using variadic template arguments that specify + * the desired floating-point behavior through tag types. + * + * **IMPORTANT PERFORMANCE NOTE**: Create the Precise object BEFORE loops, + * not inside them. The constructor and destructor have overhead from saving + * and restoring floating-point state, so it should be done once per + * computational scope, not per iteration. + * + * @tparam Args Variadic template arguments for configuration flags + * + * @example + * ```cpp + * using namespace hwy::HWY_NAMESPACE; + * using namespace npsr; + * using namespace npsr::HWY_NAMESPACE; + * + * Precise precise = {kLowAccuracy, kNoSpecialCases, kNoLargeArgument}; + * const ScalableTag d; + * typename V = Vec>; + * for (size_t i = 0; i < n; i += Lanes(d)) { + * V input = LoadU(d, &input[i]); + * V result = Sin(precise, input); + * StoreU(result, d, &output[i]); + * } + * ``` + */ +template +class Precise { + public: + Precise() { + if constexpr (!kNoExceptions) { + fegetexceptflag(&_exceptions, FE_ALL_EXCEPT); + } + if constexpr (kRoundForce) { + _rounding_mode = fegetround(); + int new_mode = _NewRoundingMode(); + if (_rounding_mode != new_mode) { + _retrieve_rounding_mode = true; + fesetround(new_mode); + } + } + } + template + Precise(T1&& arg1, Rest&&... rest) {} + + void FlushExceptions() { fesetexceptflag(&_exceptions, FE_ALL_EXCEPT); } + + void Raise(int errors) { + static_assert(!kNoExceptions, + "Cannot raise exceptions in NoExceptions mode"); + _exceptions |= errors; + } + ~Precise() { + FlushExceptions(); + if constexpr (kRoundForce) { + if (_retrieve_rounding_mode) { + fesetround(_rounding_mode); + } + } + } + static constexpr bool kNoExceptions = + (std::is_same_v<_NoExceptions, Args> || ...); + static constexpr bool kNoLargeArgument = + (std::is_same_v<_NoLargeArgument, Args> || ...); + static constexpr bool kNoSpecialCases = + (std::is_same_v<_NoSpecialCases, Args> || ...); + static constexpr bool kLowAccuracy = + (std::is_same_v<_LowAccuracy, Args> || ...); + // defaults to high accuracy if no low accuracy flag is set + static constexpr bool kHighAccuracy = !kLowAccuracy; + // defaults to large argument support if no no large argument flag is set + static constexpr bool kLargeArgument = !kNoLargeArgument; + // defaults to special cases support if no no special cases flag is set + static constexpr bool kSpecialCases = !kNoSpecialCases; + // defaults to exception support if no no exception flag is set + static constexpr bool kExceptions = !kNoExceptions; + + static constexpr bool kRoundForce = + (std::is_same_v || ...); + static constexpr bool _kRoundNearest = + (std::is_same_v || ...); + static constexpr bool kRoundZero = + (std::is_same_v || ...); + static constexpr bool kRoundDown = + (std::is_same_v || ...); + static constexpr bool kRoundUp = (std::is_same_v || ...); + // only one rounding mode can be set + static_assert((_kRoundNearest + kRoundDown + kRoundUp + kRoundZero) <= 1, + "Only one rounding mode can be set at a time"); + // if no rounding mode is set, default to round nearest + static constexpr bool kRoundNearest = + _kRoundNearest || (!kRoundDown && !kRoundUp && !kRoundZero); + + static constexpr bool kDAZ = (std::is_same_v || ...); + static constexpr bool kFTZ = (std::is_same_v || ...); + static constexpr bool _kIEEE754 = + (std::is_same_v || ...); + static_assert(!_kIEEE754 || !(kDAZ || kFTZ), + "IEEE754 mode cannot be used " + "with Denormals Are Zero (DAZ) or Flush To Zero (FTZ) " + "subnormal handling"); + static constexpr bool kIEEE754 = _kIEEE754 || !(kDAZ || kFTZ); + + private: + int _NewRoundingMode() const { + if constexpr (kRoundDown) { + return FE_DOWNWARD; + } else if constexpr (kRoundUp) { + return FE_UPWARD; + } else if constexpr (kRoundZero) { + return FE_TOWARDZERO; + } else { + return FE_TONEAREST; + } + } + int _rounding_mode = 0; + bool _retrieve_rounding_mode = false; + fexcept_t _exceptions; +}; + +Precise() -> Precise<>; + +// For Precise{args...} -> Precise +template +Precise(T1&&, Rest&&...) -> Precise, std::decay_t...>; + +} // namespace npsr +#endif // NUMPY_SIMD_ROUTINES_NPSR_PRECISE_H_ From e47f828efc209701e38acad5a572d678f6e1eba1 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 11:07:53 +0300 Subject: [PATCH 15/20] Refactor: Move Precise parameter to first position in function signatures - Change parameter order to Precise, V for consistency - Update include paths from sincos/ to trig/ - Fix constant types and naming conventions (kException -> kExceptions) --- npsr/trig/inl.h | 29 +++++++++++++---------------- 1 file changed, 13 insertions(+), 16 deletions(-) diff --git a/npsr/trig/inl.h b/npsr/trig/inl.h index a77463f..fa4e372 100644 --- a/npsr/trig/inl.h +++ b/npsr/trig/inl.h @@ -1,10 +1,8 @@ #include "npsr/common.h" +#include "npsr/trig/large-inl.h" +#include "npsr/trig/small-inl.h" -#include "npsr/sincos/large-inl.h" -#include "npsr/sincos/small-inl.h" - -// clang-format off -#if defined(NPSR_TRIG_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#if defined(NPSR_TRIG_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT #ifdef NPSR_TRIG_INL_H_ #undef NPSR_TRIG_INL_H_ #else @@ -14,7 +12,7 @@ HWY_BEFORE_NAMESPACE(); namespace npsr::HWY_NAMESPACE::sincos { -template +template HWY_API V SinCos(Prec &prec, V x) { using namespace hwy::HWY_NAMESPACE; constexpr bool kIsSingle = std::is_same_v, float>; @@ -22,40 +20,39 @@ HWY_API V SinCos(Prec &prec, V x) { V ret; if constexpr (Prec::kLowAccuracy) { ret = SmallArgLow(x); - } - else { + } else { ret = SmallArg(x); } if constexpr (Prec::kLargeArgument) { // Identify inputs requiring extended precision (very large arguments) - auto has_large_arg = Gt(Abs(x), Set(d, kIsSingle ? 10000.0 : 16777216.0)); + auto has_large_arg = Gt(Abs(x), Set(d, kIsSingle ? 10000.0f : 16777216.0)); if (HWY_UNLIKELY(!AllFalse(d, has_large_arg))) { // Use extended precision algorithm for large arguments ret = IfThenElse(has_large_arg, LargeArg(x), ret); } } - if constexpr (Prec::kSpecialCases || Prec::kException) { + if constexpr (Prec::kSpecialCases || Prec::kExceptions) { auto is_finite = IsFinite(x); ret = IfThenElse(is_finite, ret, NaN(d)); - if constexpr (Prec::kException) { + if constexpr (Prec::kExceptions) { prec.Raise(!AllFalse(d, IsInf(x)) ? FPExceptions::kInvalid : 0); } } return ret; } -} // namespace npsr::HWY_NAMESPACE::sincos +} // namespace npsr::HWY_NAMESPACE::sincos namespace npsr::HWY_NAMESPACE { -template +template HWY_API V Sin(Prec &prec, V x) { return sincos::SinCos(prec, x); } -template +template HWY_API V Cos(Prec &prec, V x) { return sincos::SinCos(prec, x); } -} // namespace npsr::HWY_NAMESPACE +} // namespace npsr::HWY_NAMESPACE HWY_AFTER_NAMESPACE(); -#endif // NPSR_TRIG_INL_H_ +#endif // NPSR_TRIG_INL_H_ From 1a6c7ee7fdaf952a3496b63eebd44be471d8298e Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 11:08:22 +0300 Subject: [PATCH 16/20] Install sin/cos test cases in build system Add meson configuration to include trigonometric test data in installation --- npsr/meson.build | 1 + 1 file changed, 1 insertion(+) diff --git a/npsr/meson.build b/npsr/meson.build index e69de29..6ab5ec1 100644 --- a/npsr/meson.build +++ b/npsr/meson.build @@ -0,0 +1 @@ +install_subdir('trig/tests', install_dir: npsr_dir/'npsr'/'trig') From 88e58e99d922c3f92187a61b2c032bd2771dbe41 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Tue, 10 Jun 2025 11:26:10 +0300 Subject: [PATCH 17/20] Add test requirements file Define Python dependencies for building and testing: - meson/meson-python for build system - ninja for compilation - spin for development workflow - pytest for test execution --- test_requirements.txt | 6 ++++++ 1 file changed, 6 insertions(+) create mode 100644 test_requirements.txt diff --git a/test_requirements.txt b/test_requirements.txt new file mode 100644 index 0000000..2588837 --- /dev/null +++ b/test_requirements.txt @@ -0,0 +1,6 @@ +meson +meson-python>=0.13.1 +ninja +spin==0.13 +pytest + From a84cb48f30719a05280cdf2b514d7735b9ce8ab9 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Mon, 28 Jul 2025 20:31:24 +0300 Subject: [PATCH 18/20] remove unit tests (will be included in a separate PR) --- .gitmodules | 3 - .spin/cmds.py | 83 +------- meson.build | 18 -- npsr/meson.build | 1 - npsr/precise.h | 2 - test/__init__.py | 173 ----------------- test/conftest.py | 10 - test/datatypes.py | 226 ---------------------- test/highway | 1 - test/meson.build | 32 --- test/src/bind-inl.h | 48 ----- test/src/helper-intrins-inl.h | 71 ------- test/src/intrins-inl.h | 311 ------------------------------ test/src/module.cpp | 178 ----------------- test/src/prec-bind-inl.h | 25 --- test/test/__init__.py | 0 test/test/tests/__init__.py | 0 test/test/tests/test_datatypes.py | 1 - test/utils.py | 6 - test_requirements.txt | 6 - 20 files changed, 2 insertions(+), 1193 deletions(-) delete mode 100644 .gitmodules delete mode 100644 meson.build delete mode 100644 npsr/meson.build delete mode 100644 test/__init__.py delete mode 100644 test/conftest.py delete mode 100644 test/datatypes.py delete mode 160000 test/highway delete mode 100644 test/meson.build delete mode 100644 test/src/bind-inl.h delete mode 100644 test/src/helper-intrins-inl.h delete mode 100644 test/src/intrins-inl.h delete mode 100644 test/src/module.cpp delete mode 100644 test/src/prec-bind-inl.h delete mode 100644 test/test/__init__.py delete mode 100644 test/test/tests/__init__.py delete mode 100644 test/test/tests/test_datatypes.py delete mode 100644 test/utils.py delete mode 100644 test_requirements.txt diff --git a/.gitmodules b/.gitmodules deleted file mode 100644 index d55a603..0000000 --- a/.gitmodules +++ /dev/null @@ -1,3 +0,0 @@ -[submodule "test/highway"] - path = test/highway - url = https://github.com/google/highway diff --git a/.spin/cmds.py b/.spin/cmds.py index ac53a56..6376c2a 100644 --- a/.spin/cmds.py +++ b/.spin/cmds.py @@ -11,87 +11,8 @@ @click.command(help="Generate sollya python based files") @click.option("-f", "--force", is_flag=True, help="Force regenerate all files") -@click.option("-s", "--sollya-path", help="Path to sollya") -def generate(*, force, sollya_path): +def generate(*, force): spin.util.run( - ["python", str(rootdir / "tools" / "generator.py")] + ["python", str(rootdir / "tools" / "sollya" / "generate.py")] + (["--force"] if force else []), ) - - -@spin.util.extend_command(spin.cmds.meson.build) -def build(*, parent_callback, **kwargs): - parent_callback(**kwargs) - - -@click.option( - "-m", - "markexpr", - metavar="MARKEXPR", - default="", - help="Run tests with the given markers", -) -@click.option( - "-m", - "markexpr", - metavar="MARKEXPR", - default="", - help="Run tests with the given markers", -) -@spin.util.extend_command(spin.cmds.meson.test) -def test(*, parent_callback, pytest_args, tests, markexpr, **kwargs): - """ - By default, spin will run `-m 'not slow'`. To run the full test suite, use - `spin test -m full` - """ # noqa: E501 - if (not pytest_args) and (not tests): - pytest_args = ( - "--pyargs", - "numpy_sr", - ) - - if "-m" not in pytest_args: - if markexpr != "full": - pytest_args = ("-m", markexpr) + pytest_args - - kwargs["pytest_args"] = pytest_args - parent_callback(**{"pytest_args": pytest_args, "tests": tests, **kwargs}) - - -@spin.util.extend_command(meson.python) -def python(*, parent_callback, **kwargs): - env = os.environ - env["PYTHONWARNINGS"] = env.get("PYTHONWARNINGS", "all") - - parent_callback(**kwargs) - - -@click.command(context_settings={"ignore_unknown_options": True}) -@click.argument("ipython_args", metavar="", nargs=-1) -@meson.build_dir_option -def ipython(*, ipython_args, build_dir): - """💻 Launch IPython shell with PYTHONPATH set - - OPTIONS are passed through directly to IPython, e.g.: - - spin ipython -i myscript.py - """ - env = os.environ - env["PYTHONWARNINGS"] = env.get("PYTHONWARNINGS", "all") - - ctx = click.get_current_context() - ctx.invoke(spin.cmds.meson.build) - - ppath = meson._set_pythonpath(build_dir) - - print(f'💻 Launching IPython with PYTHONPATH="{ppath}"') - - # In spin >= 0.13.1, can replace with extended command, setting `pre_import` - preimport = ( - r"import numpy_sr as sr; " - r"print(f'\nPreimported NumPy SIMD Routines Tests {sr.__version__} as sr')" - ) - spin.util.run( - ["ipython", "--ignore-cwd", f"--TerminalIPythonApp.exec_lines={preimport}"] - + list(ipython_args) - ) diff --git a/meson.build b/meson.build deleted file mode 100644 index 19bab5a..0000000 --- a/meson.build +++ /dev/null @@ -1,18 +0,0 @@ -project( - 'NumPy SIMD routines tests', - 'cpp', - version: '0.01', - license: 'BSD-3', - meson_version: '>=1.5.2', - default_options: [ - 'buildtype=debugoptimized', - 'b_ndebug=if-release', - 'cpp_std=c++17', - ], -) - -py = import('python').find_installation(pure: false) -npsr_dir = py.get_install_dir() / 'numpy_sr' - -subdir('test') -subdir('npsr') diff --git a/npsr/meson.build b/npsr/meson.build deleted file mode 100644 index 6ab5ec1..0000000 --- a/npsr/meson.build +++ /dev/null @@ -1 +0,0 @@ -install_subdir('trig/tests', install_dir: npsr_dir/'npsr'/'trig') diff --git a/npsr/precise.h b/npsr/precise.h index 2097a45..67bcf99 100644 --- a/npsr/precise.h +++ b/npsr/precise.h @@ -3,8 +3,6 @@ #include #include -#include "hwy/highway.h" - namespace npsr { struct _NoLargeArgument {}; diff --git a/test/__init__.py b/test/__init__.py deleted file mode 100644 index 05271de..0000000 --- a/test/__init__.py +++ /dev/null @@ -1,173 +0,0 @@ -from .datatypes import ( - uint16_t, - int16_t, - uint32_t, - int32_t, - uint64_t, - int64_t, - float32_t, - float64_t, - Vec, - Precise, - SRType, -) -from .utils import bitcast - - -from ._intrins import __targets__ as targets - - -def _get_type_from_overload_arg(probs): - scalar_map = { - (2, 0, 1): uint16_t, - (2, 0, 0): int16_t, - (4, 0, 1): uint32_t, - (4, 0, 0): int32_t, - (8, 0, 1): uint64_t, - (8, 0, 0): int64_t, - (4, 1, 0): float32_t, - (8, 1, 0): float64_t, - } - scalar_type = scalar_map.get( - (probs["kTypeSize"], probs["kIsFloat"], probs["kIsUnsigned"]) - ) - if scalar_type is None: - raise ValueError( - f"Unsupported scalar type: kTypeSize={probs['kTypeSize']}, " - f"kIsFloat={probs['kIsFloat']}, kIsUnsigned={probs['kIsUnsigned']}" - ) - nlanes = probs.get("kLanes", 1) - if nlanes == 1: - return scalar_type - else: - return Vec(scalar_type) - - -class WrapIntrinsic: - def __init__(self, name, overloads): - self.name = name - self.overloads = {} - for cfunc, info in overloads: - args_types = [] - ret_type = None - for dct in info: - if dct is None: - continue - if dct.pop("kIsPrecise", False): - args_types.append(Precise(**dct)) - elif dct.pop("kIsRet", False): - ret_type = _get_type_from_overload_arg(dct) - elif dct: - args_types += [_get_type_from_overload_arg(dct)] - self.overloads[hash(tuple(args_types))] = (cfunc, ret_type, args_types) - - def signatures(self): - args = self.overloads.values() - return "\n".join( - [ - f"{ret_type.__name__} {self.name}( {', '.join([str(a) for a in args_types])} )" - for _, ret_type, args_types in args - ] - ) - - def __call__(self, *args): - # Check if the first argument is a Precise instance - # hash of Precise based on the value of its attributes - args_prec = [a if isinstance(a, Precise) else type(a) for a in args] - args_only = [a for a in args if not isinstance(a, Precise)] - try: - h = hash(tuple(args_prec)) - cfunc, ret_type, _ = self.overloads.get(h, [None] * 3) - # incase of mismatch unhashable types - except TypeError: - cfunc, ret_type = None, None - if not cfunc: - args_str = ", ".join([str(a) for a in args_prec]) - raise TypeError( - f"no matching signature to call {self.name}( {args_str} )\n" - f"only the following signatures are supported:\n" + self.signatures() - ) - ret_bytes = cfunc(*[a.to_bytearray() for a in args_only]) - if not isinstance(ret_bytes, bytearray): - raise TypeError( - f"expected bytearray return type from {self.name}, got {type(ret_bytes).__name__}" - ) - if ret_type is not None: - return ret_type.from_bytes(ret_bytes) - return ret_type - - -class SimdExtention: - def __init__(self, name, mod_ext): - self.__name__ = name - self.intrinsics = {} - for name, val in mod_ext.__dict__.items(): - if name.startswith("_"): - setattr(self, name, val) - continue - func = WrapIntrinsic(name, val) - self.intrinsics[name] = func - setattr(self, name, func) - - for extra_intrin in ["Lanes", "Set", "BitCast", "assert_ulp"]: - self.intrinsics[extra_intrin] = getattr(self, extra_intrin) - - def __repr__(self): - return "numpy_sr." + self.__name__ - - def __str__(self): - return self.__name__ - - def Lanes(self, element_type): - return self._REGISTER_WIDTH // element_type.element_size - - def Set(self, element_type, val): - return Vec(element_type)([val] * self.Lanes(element_type)) - - def BitCast(self, eltype, value): - return bitcast(eltype, value) - - def assert_ulp(self, actual, expected, input, max_ulp=1, per_line=4): - __tracebackhide__ = True # Hide traceback for py.test - ulp = self.UlpDistance(actual, expected) - actual, expected, input, ulp = ( - arg.to_list() for arg in [actual, expected, input, ulp] - ) - if any([i > max_ulp for i in ulp]): - vals = [] - for i, ul in enumerate(ulp): - if int(ul) <= max_ulp: - continue - vals.append( - str(tuple(x for x in (input[i], actual[i], expected[i], ul))) - ) - raise AssertionError( - f"Expected ULP distance {max_ulp}, worst {max(ulp)}, interleaved(input, actual, expected, ulp) as follow:" - + "\n " - + "\n ".join(vals) - + "\n", - ) - - -wrap_targets = {} -for name, simd_ext in targets.items(): - wrap_targets[name] = SimdExtention(name, simd_ext) - globals()[name] = wrap_targets[name] -targets = wrap_targets - -__version__ = "1.0.0" - -__all__ = [ - "uint16_t", - "int16_t", - "uint32_t", - "int32_t", - "uint64_t", - "int64_t", - "float32_t", - "float64_t", - "Vec", - "Precise", - "targets", - "bitcast", -] diff --git a/test/conftest.py b/test/conftest.py deleted file mode 100644 index 3587e19..0000000 --- a/test/conftest.py +++ /dev/null @@ -1,10 +0,0 @@ -import pytest -import numpy_sr as sr - - -@pytest.fixture(params=list(sr.targets.values()), autouse=True, scope="function") -def setup_target(request): - target = request.param - _globals = request.function.__globals__ - _globals.update(target.intrinsics) - yield target diff --git a/test/datatypes.py b/test/datatypes.py deleted file mode 100644 index e3f46f6..0000000 --- a/test/datatypes.py +++ /dev/null @@ -1,226 +0,0 @@ -import operator -import ctypes -from dataclasses import dataclass -from enum import IntEnum, auto - - -@dataclass(frozen=True) -class Precise: - kNoExceptions: bool = False - kLowAccuracy: bool = False - kNoLargeArgument: bool = False - kNoSpecialCases: bool = False - kDAZ: bool = False - kFTZ: bool = False - kIEEE754: bool = True - kRoundForce: bool = False - kRoundNearest: bool = True - kRoundDown: bool = False - kRoundUp: bool = False - kRoundZero: bool = False - - -class _ContainerID(IntEnum): - SCALAR = 1 - VEC = auto() - - -class _ElementID(IntEnum): - VOID = 0 - UINT16 = auto() - INT16 = auto() - UINT32 = auto() - INT32 = auto() - UINT64 = auto() - INT64 = auto() - FLOAT32 = auto() - FLOAT64 = auto() - - -def _float_cvt(val): - if isinstance(val, float): - return val - elif isinstance(val, int): - return float(val) - elif isinstance(val, str): - return float.fromhex(val) - else: - raise TypeError(f"Cannot convert {type(val)} to float") - - -class _Sequence: - def __init__(self, vals): - data_type = self.element_ctype * len(vals) - cvt = _float_cvt if self.element_id > _ElementID.INT64 else int - data = data_type(*[cvt(v) for v in vals]) - self._bytearray = bytearray(bytes(data)) - - def data(self): - data_type = self.element_ctype * len(self) - return data_type.from_buffer(self._bytearray) - - def __getitem__(self, index): - data = self.data() - try: - data = data[index] - except IndexError: - raise IndexError(type(self).__name__ + " index out of range") - if isinstance(index, int): - tp = SRType.byid(_ContainerID.SCALAR, self.element_id) - return tp(data) - return type(self)(*data) - - def __setitem__(self, index, value): - data = self.data() - data[index] = value - - def __len__(self): - return len(self._bytearray) // self.element_size - - def __iter__(self): - yield from self._iterate_items() - - def _iterate_items(self): - tp = SRType.byid(_ContainerID.SCALAR, self.element_id) - data = self.data() - for d in data: - yield tp(d) - - def __str__(self): - return str(tuple(self.data())) - - def __repr__(self): - return type(self).__name__ + str(self) - - def to_list(self): - return [v for v in self.data()] - - def to_bytearray(self): - return self._bytearray - - @classmethod - def from_bytes(cls, raw): - self = super().__new__(cls) - self._bytearray = bytearray(bytes(raw)) - return self - - -class _Scalar: - def __init__(self, val): - cvt = _float_cvt if self.element_id > _ElementID.INT64 else int - data = self.element_ctype(cvt(val)) - self._bytearray = bytearray(bytes(data)) - - def data(self): - return self.element_ctype.from_buffer(self._bytearray) - - def __str__(self): - return str(self.data().value) - - def __repr__(self): - return type(self).__name__ + f"({str(self)})" - - def __int__(self): - return int(self.data().value) - - def __float__(self): - return float(self.data().value) - - def __bool__(self): - return bool(self.data().value) - - def to_bytearray(self): - return self._bytearray - - @classmethod - def from_bytes(cls, raw): - self = super().__new__(cls) - self._bytearray = bytearray(bytes(raw)) - return self - - -class SRType(type): - _insta_cache = {} - _prop_by_eid = { - _ElementID.UINT16: ("uint16_t", ctypes.c_uint16), - _ElementID.INT16: ("int16_t", ctypes.c_int16), - _ElementID.UINT32: ("uint32_t", ctypes.c_uint32), - _ElementID.INT32: ("int32_t", ctypes.c_int32), - _ElementID.UINT64: ("uint64_t", ctypes.c_uint64), - _ElementID.INT64: ("int64_t", ctypes.c_int64), - _ElementID.FLOAT32: ("float32_t", ctypes.c_float), - _ElementID.FLOAT64: ("float64_t", ctypes.c_double), - } - - _prop_by_cid = { - _ContainerID.SCALAR: ("{}", _Scalar), - _ContainerID.VEC: ("Vec({})", _Sequence), - } - - def __new__(cls, _, bases, attrs): - container_id = attrs["container_id"] - element_id = attrs["element_id"] - cache_key = (container_id, element_id) - instance = cls._insta_cache.get(cache_key) - if instance: - return instance - element_name, element_ctype = cls._prop_by_eid[element_id] - container_name, container_base = cls._prop_by_cid[container_id] - bases += (container_base,) - name = container_name.format(element_name) - attrs.update( - dict(element_ctype=element_ctype, element_size=ctypes.sizeof(element_ctype)) - ) - instance = super().__new__(cls, name, bases, attrs) - SRType._insta_cache[cache_key] = instance - return instance - - @classmethod - def byid(cls, container_id, element_id): - return SRType(cls, (), dict(container_id=container_id, element_id=element_id)) - - -class uint16_t(metaclass=SRType): - container_id = _ContainerID.SCALAR - element_id = _ElementID.UINT16 - - -class int16_t(metaclass=SRType): - container_id = _ContainerID.SCALAR - element_id = _ElementID.INT16 - - -class uint32_t(metaclass=SRType): - container_id = _ContainerID.SCALAR - element_id = _ElementID.UINT32 - - -class int32_t(metaclass=SRType): - container_id = _ContainerID.SCALAR - element_id = _ElementID.INT32 - - -class uint64_t(metaclass=SRType): - container_id = _ContainerID.SCALAR - element_id = _ElementID.UINT64 - - -class int64_t(metaclass=SRType): - container_id = _ContainerID.SCALAR - element_id = _ElementID.INT64 - - -class float32_t(metaclass=SRType): - container_id = _ContainerID.SCALAR - element_id = _ElementID.FLOAT32 - - -class float64_t(metaclass=SRType): - container_id = _ContainerID.SCALAR - element_id = _ElementID.FLOAT64 - - -class Vec(SRType): - def __new__(cls, element_type): - s = cls.byid(_ContainerID.VEC, element_type.element_id) - return s diff --git a/test/highway b/test/highway deleted file mode 160000 index 136317f..0000000 --- a/test/highway +++ /dev/null @@ -1 +0,0 @@ -Subproject commit 136317f6366d0d5aa0dd24f660e3af1b1ce4dcbd diff --git a/test/meson.build b/test/meson.build deleted file mode 100644 index 68f7233..0000000 --- a/test/meson.build +++ /dev/null @@ -1,32 +0,0 @@ -highway_lib = static_library('highway', - [ - 'highway/hwy/abort.cc', - 'highway/hwy/aligned_allocator.cc', - 'highway/hwy/nanobenchmark.cc', - 'highway/hwy/per_target.cc', - 'highway/hwy/perf_counters.cc', - 'highway/hwy/print.cc', - 'highway/hwy/targets.cc', - 'highway/hwy/timer.cc', - ], - cpp_args: '-DTOOLCHAIN_MISS_ASM_HWCAP_H', - include_directories: ['highway'], - install: false, - gnu_symbol_visibility: 'hidden', -) - -py.extension_module('_intrins', - ['src/module.cpp'], - link_with: [ - highway_lib, - ], - include_directories: ['highway', '../'], - install: true, - install_dir: npsr_dir, -) -py.install_sources( - ['__init__.py', 'datatypes.py', 'conftest.py', 'utils.py'], - subdir: npsr_dir, -) - -install_subdir('test', install_dir: npsr_dir/'test') diff --git a/test/src/bind-inl.h b/test/src/bind-inl.h deleted file mode 100644 index 4ed2a91..0000000 --- a/test/src/bind-inl.h +++ /dev/null @@ -1,48 +0,0 @@ -#if defined(NPSR_TEST_SRC_BIND_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT -#ifdef NPSR_TEST_SRC_BIND_INL_H_ -#undef NPSR_TEST_SRC_BIND_INL_H_ -#else -#define NPSR_TEST_SRC_BIND_INL_H_ -#endif - -#include "intrins-inl.h" -#include "npsr/npsr.h" - -HWY_BEFORE_NAMESPACE(); -namespace npsr::HWY_NAMESPACE::test { - -template -HWY_API TVec And(const TVec a, const TVec b) { - return hn::And(a, b); -} -template -HWY_API TVec Or(const TVec a, const TVec b) { - return hn::Or(a, b); -} -template -HWY_API TVec Xor(const TVec a, const TVec b) { - return hn::Xor(a, b); -} -template -HWY_API TVec Not(const TVec a) { - return hn::Not(a); -} -template -HWY_API TVec Neg(const TVec a) { - return hn::Neg(a); -} - -template -HWY_ATTR bool Bind(PyObject *m) { - bool r = true; - r &= AttachIntrinsic...>(m, "And"); - r &= AttachIntrinsic...>(m, "Xor"); - r &= AttachIntrinsic...>(m, "Or"); - r &= AttachIntrinsic...>(m, "Not"); - r &= AttachIntrinsic...>(m, "Neg"); - return r; -} - -} // namespace npsr::HWY_NAMESPACE::test -HWY_AFTER_NAMESPACE(); -#endif // NPSR_TEST_SRC_BIND_INL_H_ diff --git a/test/src/helper-intrins-inl.h b/test/src/helper-intrins-inl.h deleted file mode 100644 index 74e7c83..0000000 --- a/test/src/helper-intrins-inl.h +++ /dev/null @@ -1,71 +0,0 @@ -#include "hwy/base.h" -#if defined(NPSR_TEST_HELPER_INTRINS_INL_H_) == \ - defined(HWY_TARGET_TOGGLE) // NOLINT -#ifdef NPSR_TEST_HELPER_INTRINS_INL_H_ -#undef NPSR_TEST_HELPER_INTRINS_INL_H_ -#else -#define NPSR_TEST_HELPER_INTRINS_INL_H_ -#endif - -#include "intrins-inl.h" - -HWY_BEFORE_NAMESPACE(); -namespace npsr::HWY_NAMESPACE::test { - -namespace hn = hwy::HWY_NAMESPACE; -using hn::DFromV; -using hn::RebindToUnsigned; -using hn::TFromV; - -template , typename D = DFromV, - typename DU = RebindToUnsigned, typename VU = hn::Vec> -HWY_API VU UlpDistance(const V& a, const V& b) { - using namespace hn; - using DI = RebindToSigned; - using VI = Vec; - using MU = Mask; - using TU = MakeUnsigned; - const DU du; - const DI di; - - // Early exit for exact equality - const MU equal = RebindMask(du, Eq(a, b)); - - // Handle special values - const MU a_special = RebindMask(du, Or(IsNaN(a), IsInf(a))); - const MU b_special = RebindMask(du, Or(IsNaN(b), IsInf(b))); - const MU any_special = Or(a_special, b_special); - - const VU a_bits = BitCast(du, a); - const VU b_bits = BitCast(du, b); - - // IEEE 754 to signed integer conversion for ULP arithmetic - const VU sign_bit = Set(du, TU(1) << (sizeof(T) * 8 - 1)); - - auto ieee_to_signed = [&](const VU& bits) -> VU { - const MU is_negative = Ne(And(bits, sign_bit), Zero(du)); - return IfThenElse(is_negative, Not(bits), Xor(bits, sign_bit)); - }; - - const VI a_signed = BitCast(di, ieee_to_signed(a_bits)); - const VI b_signed = BitCast(di, ieee_to_signed(b_bits)); - const VU ulp_diff = BitCast(du, Abs(Sub(a_signed, b_signed))); - - // Return results - const VU max_dist = Set(du, ~TU(0)); - return IfThenElse(equal, Zero(du), - - IfThenElse(any_special, max_dist, ulp_diff)); -} - -template -HWY_ATTR bool BindHelpers(PyObject* m) { - namespace hn = hwy::HWY_NAMESPACE; - bool r = true; - r &= AttachIntrinsic...>(m, "UlpDistance"); - return r; -} -} // namespace npsr::HWY_NAMESPACE::test - -HWY_AFTER_NAMESPACE(); -#endif // NPSR_TEST_HELPER_INTRINS_INL_H_ diff --git a/test/src/intrins-inl.h b/test/src/intrins-inl.h deleted file mode 100644 index fcc7170..0000000 --- a/test/src/intrins-inl.h +++ /dev/null @@ -1,311 +0,0 @@ -#if defined(NPSR_TEST_SRC_INTRINS_INL_H_) == \ - defined(HWY_TARGET_TOGGLE) // NOLINT -#ifdef NPSR_TEST_SRC_INTRINS_INL_H_ -#undef NPSR_TEST_SRC_INTRINS_INL_H_ -#else -#define NPSR_TEST_SRC_INTRINS_INL_H_ -#endif - -#include -#include - -#include -#include -#include -#include - -#include "npsr/npsr.h" - -HWY_BEFORE_NAMESPACE(); -namespace npsr::HWY_NAMESPACE::test { -namespace hn = hwy::HWY_NAMESPACE; - -// Helper to detect if type is instantiation of Precise -template -struct IsPrecise : std::false_type {}; - -template -struct IsPrecise> : std::true_type {}; - -template -static constexpr bool kHasPrecise = IsPrecise::value; - -template -struct FilterPrecise { - using TPrecise = hn::DFromV<_TPrecise>; - using Tags = - std::tuple>...>; -}; -template -struct FilterPrecise { - using Tags = std::tuple>...>; - using TPrecise = _TPrecise; -}; - -// Helper to extract function signature from intrinsic pointer -template -struct IntrinsicOverload; - -// Specialization for function pointers -template -struct IntrinsicOverload { - using _TPrecise = std::remove_reference_t<__TPrecise>; - using Filter = FilterPrecise, _TPrecise, Args...>; - using Tags = typename Filter::Tags; - using TPrecise = typename Filter::TPrecise; - - static constexpr size_t kNumArgs = std::tuple_size_v; - static constexpr bool kEscapePrecise = !kHasPrecise; - - static PyObject *Call(PyObject *self, PyObject *args) { - return CallIs(self, args, std::make_index_sequence{}, Tags{}); - } - - template - static PyObject *CallIs(PyObject *self, PyObject *args, - std::index_sequence, std::tuple) { - Py_ssize_t length = PySequence_Fast_GET_SIZE(args); - if (length != kNumArgs) { - PyErr_Format(PyExc_TypeError, "expected %zu arguments, got %zd", kNumArgs, - length); - return nullptr; - } - using TagsU8 = std::tuple...>; - - PyObject **items = PySequence_Fast_ITEMS(args); - if (!(PyByteArray_Check(items[Is]) && ...)) { - PyErr_Format(PyExc_TypeError, "all arguments must be bytearray"); - return nullptr; - } - - PyByteArrayObject *arrays[] = { - reinterpret_cast(items[Is])...}; - Py_ssize_t sizes[] = {PyByteArray_Size(items[Is])...}; - Py_ssize_t lanes[] = {static_cast( - hn::Lanes(std::tuple_element_t{}))...}; - - // Validate each array individually - if (((sizes[Is] < lanes[Is] || sizes[Is] % lanes[Is] != 0) || ...)) { - PyErr_Format(PyExc_ValueError, - "each array size must be aligned and >= its lane count, %d"); - return nullptr; - } - const hn::Repartition> uddst; - Py_ssize_t dst_lanes = hn::Lanes(uddst); - Py_ssize_t result_size = sizes[0]; - PyObject *dst_obj = PyByteArray_FromStringAndSize(NULL, 0); - if (dst_obj == nullptr) { - return nullptr; - } - if (PyByteArray_Resize(dst_obj, result_size) < 0) { - Py_DECREF(dst_obj); - return nullptr; - } - - uint8_t *src[] = { - reinterpret_cast(PyByteArray_AS_STRING(arrays[Is]))...}; - uint8_t *dst = reinterpret_cast(PyByteArray_AS_STRING(dst_obj)); - - // Track offsets for each source array using parameter pack - // std::array src_offsets{}; - // Py_ssize_t dst_offset = 0; - - TPrecise precise{}; - // Process min_iterations worth of data - for (Py_ssize_t iter = 0; iter < result_size; iter += dst_lanes) { - // Load from each source at its current offset - // clang-format off - VRet ret; - if constexpr (kHasPrecise) { - ret = IntrinPtr( - precise, - hn::BitCast( - std::tuple_element_t{}, - hn::LoadU( - std::tuple_element_t{}, - src[Is] + iter - ) - ) - ...); - } - else { - ret = IntrinPtr( - hn::BitCast( - std::tuple_element_t{}, - hn::LoadU( - std::tuple_element_t{}, - src[Is] + iter - ) - ) - ...); - } - // clang-format on - hn::StoreU(hn::BitCast(uddst, ret), uddst, dst + iter); - } - return dst_obj; - } - - static PyObject *OverloadInfo() { return OverloadInfo_(Tags{}); } - - template - static PyObject *OverloadInfo_(std::tuple) { - constexpr size_t kNumItems = 2 + kNumArgs; - return PyTuple_Pack(kNumItems, GetTagTypeInfo, true>(), - GetPrecise(), GetTagTypeInfo()...); - } - - template - static PyObject *GetTagTypeInfo() { - using T = hn::TFromD; - constexpr std::pair kInfo[] = { - {"kIsRet", static_cast(IS_RET)}, - {"kLanes", hn::Lanes(Tag{})}, - {"kTypeSize", static_cast(sizeof(T))}, - {"kIsUnsigned", std::is_unsigned_v ? 1 : 0}, - {"kIsSigned", std::is_signed_v ? 1 : 0}, - {"kIsFloat", std::is_floating_point_v ? 1 : 0}, - {"kIsInteger", std::is_integral_v ? 1 : 0}, - }; - PyObject *info = PyDict_New(); - if (info == nullptr) { - return nullptr; - } - for (const auto &[key_name, key_val] : kInfo) { - PyObject *py_key = PyUnicode_FromString(key_name); - PyObject *py_val = PyLong_FromLong(key_val); - if (py_key == nullptr || py_val == nullptr || - PyDict_SetItem(info, py_key, py_val) < 0) { - Py_XDECREF(py_key); - Py_XDECREF(py_val); - Py_DECREF(info); - return nullptr; - } - Py_DECREF(py_key); - Py_DECREF(py_val); - } - return info; - } - template - static std::enable_if_t, PyObject *> GetPrecise() { - constexpr std::pair kPreciseOptions[] = { - {true, "kIsPrecise"}, - {TPrec::kLowAccuracy, "kLowAccuracy"}, - {TPrec::kNoLargeArgument, "kNoLargeArgument"}, - {TPrec::kNoSpecialCases, "kNoSpecialCases"}, - {TPrec::kNoExceptions, "kNoExceptions"}, - {TPrec::kRoundForce, "kRoundForce"}, - {TPrec::kRoundNearest, "kRoundNearest"}, - {TPrec::kRoundZero, "kRoundZero"}, - {TPrec::kRoundDown, "kRoundDown"}, - {TPrec::kRoundUp, "kRoundUp"}, - {TPrec::kDAZ, "kDAZ"}, - {TPrec::kFTZ, "kFTZ"}, - {TPrec::kIEEE754, "kIEEE754"}, - }; - PyObject *preciseOptions = PyDict_New(); - if (preciseOptions == nullptr) { - return nullptr; - } - for (const auto &[is_enabled, option_name] : kPreciseOptions) { - PyObject *py_name = PyUnicode_FromString(option_name); - PyObject *py_value = is_enabled ? Py_True : Py_False; - Py_INCREF(py_value); // Increment ref count for Py_True/Py_False - - if (py_name == nullptr || - PyDict_SetItem(preciseOptions, py_name, py_value) < 0) { - Py_XDECREF(py_name); - Py_XDECREF(py_value); - Py_DECREF(preciseOptions); - return nullptr; - } - Py_DECREF(py_name); - Py_DECREF(py_value); - } - return preciseOptions; - } - template - static std::enable_if_t, PyObject *> GetPrecise() { - return Py_None; - } -}; - -template -inline bool AttachIntrinsic(PyObject *m, const char *name) { - // Create static method definitions that persist - static std::string name_storage(name); - static PyMethodDef methods[] = { - {name_storage.c_str(), - static_cast(IntrinsicOverload::Call), - METH_VARARGS, "Intrinsic function overload"}..., - {nullptr, nullptr, 0, nullptr} // Sentinel - }; - - // Check if attribute already exists - PyObject *existing_list = nullptr; - bool is_new_list = true; - - if (PyObject_HasAttrString(m, name)) { - existing_list = PyObject_GetAttrString(m, name); - if (existing_list && PyList_Check(existing_list)) { - is_new_list = false; - } else { - Py_XDECREF(existing_list); - existing_list = nullptr; - } - } - - PyObject *overload_list; - if (is_new_list) { - overload_list = PyList_New(0); - if (!overload_list) { - return false; - } - } else { - overload_list = existing_list; - } - // Create overload info array - PyObject *overloads_info[] = { - IntrinsicOverload::OverloadInfo()..., nullptr}; - // Create functions and tuples - for (size_t i = 0; i < sizeof...(IntrinPtrs); ++i) { - PyObject *func = PyCFunction_New(&methods[i], nullptr); - if (!func) { - goto cleanup_fail; - } - PyObject *tuple = PyTuple_Pack(2, func, overloads_info[i]); - if (!tuple) { - Py_DECREF(func); - goto cleanup_fail; - } - - if (PyList_Append(overload_list, tuple) < 0) { - Py_DECREF(tuple); - goto cleanup_fail; - } - Py_DECREF(tuple); // PyList_Append increments ref count - } - - // Set attribute only for new lists - if (is_new_list) { - if (PyObject_SetAttrString(m, name, overload_list) < 0) { - Py_DECREF(overload_list); - return false; - } - Py_DECREF(overload_list); // Module holds the reference now - } - return true; - -cleanup_fail: - // Clean up any allocated overload info objects - for (size_t i = 0; i < sizeof...(IntrinPtrs); ++i) { - Py_XDECREF(overloads_info[i]); - } - if (is_new_list) { - Py_DECREF(overload_list); - } - return false; -} -} // namespace npsr::HWY_NAMESPACE::test -HWY_AFTER_NAMESPACE(); -#endif // NPSR_TEST_SRC_INTRINS_INL_H_ diff --git a/test/src/module.cpp b/test/src/module.cpp deleted file mode 100644 index 04835e9..0000000 --- a/test/src/module.cpp +++ /dev/null @@ -1,178 +0,0 @@ -#undef HWY_TARGET_INCLUDE -#define HWY_TARGET_INCLUDE "src/module.cpp" - -#include -#include - -#include - -#include "bind-inl.h" -#include "helper-intrins-inl.h" -#include "prec-bind-inl.h" - -HWY_BEFORE_NAMESPACE(); -namespace npsr::HWY_NAMESPACE { -using namespace test; -namespace hn = hwy::HWY_NAMESPACE; - -template -struct TagByWidthHelper { - using type = hn::FixedTag; // Only instantiated when WIDTH != 0 -}; - -template -struct TagByWidthHelper<0, TLane> { - using type = hn::ScalableTag; // Only instantiated when WIDTH == 0 -}; - -template -using TagByWidth = typename TagByWidthHelper::type; -template -using VecsByWidth = std::tuple>...>; - -template -HWY_ATTR bool LoadPreciseIntrinsics(PyObject *m, PreciseTuple, VecTuple); - -template -HWY_ATTR bool LoadPreciseIntrinsics(PyObject *m, std::tuple, - std::tuple) { - bool r = true; - ((r &= PreciseBind(m)), ...); - return r; -} - -template -HWY_ATTR bool LoadIntrinsics(PyObject *m, std::tuple) { - bool r = true; - ((r &= Bind(m)), ...); - return r; -} - -template -HWY_ATTR bool LoadHelpersIntrinsics(PyObject *m, std::tuple) { - bool r = true; - ((r &= BindHelpers(m)), ...); - return r; -} - -template -HWY_ATTR PyObject *Target(bool &escape) { -#if HWY_NATIVE_FMA -#define STRINGIFY(x) #x -#define TOSTRING(x) STRINGIFY(x) - static std::string module_name = "npsr." TOSTRING(HWY_NAMESPACE) + []() { - if constexpr (WIDTH == 0) - return std::string(""); - else - return "_force" + std::to_string(WIDTH); - }(); - - static PyModuleDef defs = { - PyModuleDef_HEAD_INIT, module_name.c_str(), "", -1, nullptr, - }; - - PyObject *m = PyModule_Create(&defs); - if (m == nullptr) { - return nullptr; - } - constexpr std::pair constants[] = { - {"_HAVE_FLOAT16", HWY_HAVE_FLOAT16}, - {"_HAVE_FLOAT64", HWY_HAVE_FLOAT64}, - {"_REGISTER_WIDTH", hn::Lanes(TagByWidth{})}, - }; - for (const auto &[name, value] : constants) { - PyObject *py_value = PyLong_FromLong(value); - if (py_value == nullptr || PyModule_AddObject(m, name, py_value) < 0) { - Py_XDECREF(py_value); - Py_DECREF(m); - return nullptr; - } - } - - using PreciseTypes = - std::tuple; - - // clang-format off - using VecTypes = VecsByWidth; - // clang-format on - - if (!LoadPreciseIntrinsics(m, PreciseTypes{}, VecTypes{})) { - Py_DECREF(m); - return nullptr; - } - if (!LoadIntrinsics(m, VecTypes{})) { - Py_DECREF(m); - return nullptr; - } - if (!LoadHelpersIntrinsics(m, VecTypes{})) { - Py_DECREF(m); - return nullptr; - } - return m; -#else - escape = true; - return nullptr; -#endif -} - -template PyObject *Target<0>(bool &); - -} // namespace npsr::HWY_NAMESPACE -HWY_AFTER_NAMESPACE(); - -#if HWY_ONCE -namespace npsr { - -HWY_EXPORT_T(Target0, Target<0>); - -extern "C" { -PyMODINIT_FUNC PyInit__intrins(void) { - static PyMethodDef methods[] = { - {NULL, NULL, 0, NULL}, - }; - static struct PyModuleDef defs = {PyModuleDef_HEAD_INIT, "npsr", - "NPsr testing framework", -1, methods}; - - PyObject *m = PyModule_Create(&defs); - if (m == NULL) { - return NULL; - } - PyObject *targets = PyDict_New(); - if (targets == NULL) { - goto err; - } - if (PyModule_AddObject(m, "__targets__", targets) < 0) { - Py_DECREF(targets); - goto err; - } - for (uint64_t target : hwy::SupportedAndGeneratedTargets()) { - hwy::SetSupportedTargetsForTest(target); - hwy::GetChosenTarget().Update(hwy::SupportedTargets()); - bool escape = false; - PyObject *target_mod = HWY_DYNAMIC_DISPATCH(Target0)(escape); - if (target_mod == nullptr) { - if (escape) { - // due to fma not being supported - continue; - } - goto err; - } - if (PyDict_SetItemString(targets, hwy::TargetName(target), target_mod) < - 0) { - Py_DECREF(target_mod); - goto err; - } - } - return m; -err: - Py_DECREF(m); - return nullptr; -} -} // namespace npsr -} // namespace npsr -#endif // HWY_ONCE diff --git a/test/src/prec-bind-inl.h b/test/src/prec-bind-inl.h deleted file mode 100644 index f5a3ec6..0000000 --- a/test/src/prec-bind-inl.h +++ /dev/null @@ -1,25 +0,0 @@ -#if defined(NPSR_TEST_SRC_PREC_BIND_INL_H_) == \ - defined(HWY_TARGET_TOGGLE) // NOLINT -#ifdef NPSR_TEST_SRC_PREC_BIND_INL_H_ -#undef NPSR_TEST_SRC_PREC_BIND_INL_H_ -#else -#define NPSR_TEST_SRC_PREC_BIND_INL_H_ -#endif - -#include "intrins-inl.h" -#include "npsr/npsr.h" - -HWY_BEFORE_NAMESPACE(); -namespace npsr::HWY_NAMESPACE::test { - -template -HWY_ATTR bool PreciseBind(PyObject *m) { - bool r = true; - r &= AttachIntrinsic...>(m, "Sin"); - r &= AttachIntrinsic...>(m, "Cos"); - return r; -} - -} // namespace npsr::HWY_NAMESPACE::test -HWY_AFTER_NAMESPACE(); -#endif // NPSR_TEST_SRC_PREC_BIND_INL_H_ diff --git a/test/test/__init__.py b/test/test/__init__.py deleted file mode 100644 index e69de29..0000000 diff --git a/test/test/tests/__init__.py b/test/test/tests/__init__.py deleted file mode 100644 index e69de29..0000000 diff --git a/test/test/tests/test_datatypes.py b/test/test/tests/test_datatypes.py deleted file mode 100644 index 4640904..0000000 --- a/test/test/tests/test_datatypes.py +++ /dev/null @@ -1 +0,0 @@ -# TODO diff --git a/test/utils.py b/test/utils.py deleted file mode 100644 index 4c7cef7..0000000 --- a/test/utils.py +++ /dev/null @@ -1,6 +0,0 @@ -from .datatypes import SRType - - -def bitcast(eltype, value): - tp = SRType.byid(value.container_id, eltype.element_id) - return tp.from_bytes(value.to_bytearray()) diff --git a/test_requirements.txt b/test_requirements.txt deleted file mode 100644 index 2588837..0000000 --- a/test_requirements.txt +++ /dev/null @@ -1,6 +0,0 @@ -meson -meson-python>=0.13.1 -ninja -spin==0.13 -pytest - From ecd1f2ff38227d03510116a149f8dfc59df712c9 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Mon, 28 Jul 2025 20:34:26 +0300 Subject: [PATCH 19/20] refactor: reimplement Sollya generator using only Sollya scripts This patch removes the Python dependency by rewriting the generator using pure Sollya scripting. It also applies general code cleanups and adds support for non-FMA targets. --- npsr/common.h | 26 + npsr/precise.h | 37 +- npsr/trig/data/approx.h | 1563 +++ npsr/trig/data/approx.h.sol | 52 + npsr/trig/data/constants.h | 57 + npsr/trig/data/constants.h.sol | 87 + npsr/trig/data/data.h | 11 + npsr/trig/data/data.h.sol | 10 + npsr/trig/data/high.h | 54 + npsr/trig/data/high.h.sol | 54 + npsr/trig/data/large-aprox.h | 1553 --- npsr/trig/data/large-aprox.h.py | 52 - npsr/trig/data/large-reduction.h | 2316 ---- npsr/trig/data/large-reduction.h.py | 51 - npsr/trig/data/reduction.h | 2320 ++++ npsr/trig/data/reduction.h.sol | 47 + npsr/trig/data/small.h | 25 - npsr/trig/data/small.h.py | 64 - npsr/trig/{large-inl.h => extended-inl.h} | 191 +- npsr/trig/{small-inl.h => high-inl.h} | 195 +- npsr/trig/inl.h | 19 +- npsr/trig/low-inl.h | 151 + npsr/trig/tests/__init__.py | 0 npsr/trig/tests/data/__init__.py | 0 npsr/trig/tests/data/large.py | 12982 -------------------- npsr/trig/tests/data/large.py.py | 46 - npsr/trig/tests/data/large.sollya | 164 - npsr/trig/tests/test_sincos.py | 26 - npsr/utils-inl.h | 5 +- pyproject.toml | 17 - tools/__init__.py | 0 tools/generator.py | 181 - tools/sollya/core.sol | 311 + tools/sollya/generate.py | 89 + 34 files changed, 4985 insertions(+), 17771 deletions(-) create mode 100644 npsr/trig/data/approx.h create mode 100644 npsr/trig/data/approx.h.sol create mode 100644 npsr/trig/data/constants.h create mode 100644 npsr/trig/data/constants.h.sol create mode 100644 npsr/trig/data/data.h create mode 100644 npsr/trig/data/data.h.sol create mode 100644 npsr/trig/data/high.h create mode 100644 npsr/trig/data/high.h.sol delete mode 100644 npsr/trig/data/large-aprox.h delete mode 100644 npsr/trig/data/large-aprox.h.py delete mode 100644 npsr/trig/data/large-reduction.h delete mode 100644 npsr/trig/data/large-reduction.h.py create mode 100644 npsr/trig/data/reduction.h create mode 100644 npsr/trig/data/reduction.h.sol delete mode 100644 npsr/trig/data/small.h delete mode 100644 npsr/trig/data/small.h.py rename npsr/trig/{large-inl.h => extended-inl.h} (70%) rename npsr/trig/{small-inl.h => high-inl.h} (62%) create mode 100644 npsr/trig/low-inl.h delete mode 100644 npsr/trig/tests/__init__.py delete mode 100644 npsr/trig/tests/data/__init__.py delete mode 100644 npsr/trig/tests/data/large.py delete mode 100644 npsr/trig/tests/data/large.py.py delete mode 100644 npsr/trig/tests/data/large.sollya delete mode 100644 npsr/trig/tests/test_sincos.py delete mode 100644 tools/__init__.py delete mode 100644 tools/generator.py create mode 100644 tools/sollya/core.sol create mode 100644 tools/sollya/generate.py diff --git a/npsr/common.h b/npsr/common.h index 05e536e..9674212 100644 --- a/npsr/common.h +++ b/npsr/common.h @@ -9,3 +9,29 @@ #include "precise.h" #endif // NUMPY_SIMD_ROUTINES_NPSR_COMMON_H_ + +#if defined(NUMPY_SIMD_ROUTINES_NPSR_COMMON_FOREACH_H_) == \ + defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NUMPY_SIMD_ROUTINES_NPSR_COMMON_FOREACH_H_ +#undef NUMPY_SIMD_ROUTINES_NPSR_COMMON_FOREACH_H_ +#else +#define NUMPY_SIMD_ROUTINES_NPSR_COMMON_FOREACH_H_ +#endif + +HWY_BEFORE_NAMESPACE(); +namespace npsr::HWY_NAMESPACE { +namespace hn = hwy::HWY_NAMESPACE; +using hn::DFromV; +using hn::MFromD; +using hn::Rebind; +using hn::RebindToUnsigned; +using hn::TFromD; +using hn::TFromV; +using hn::VFromD; +constexpr bool kNativeFMA = HWY_NATIVE_FMA != 0; + +HWY_ATTR void DummyToSuppressUnusedWarning() {} +} // namespace npsr::HWY_NAMESPACE +HWY_AFTER_NAMESPACE(); + +#endif // NUMPY_SIMD_ROUTINES_NPSR_COMMON_FOREACH_H_ diff --git a/npsr/precise.h b/npsr/precise.h index 67bcf99..e229f9f 100644 --- a/npsr/precise.h +++ b/npsr/precise.h @@ -16,27 +16,15 @@ constexpr auto kLowAccuracy = _LowAccuracy{}; struct Round { struct _Force {}; - struct _Nearest {}; - struct _Down {}; - struct _Up {}; - struct _Zero {}; static constexpr auto kForce = _Force{}; - static constexpr auto kNearest = _Nearest{}; -#if 0 // not used yet - static constexpr auto kDown = _Down{}; - static constexpr auto kUp = _Up{}; - static constexpr auto kZero = _Zero{}; -#endif }; struct Subnormal { struct _DAZ {}; struct _FTZ {}; struct _IEEE754 {}; -#if 0 // not used yet static constexpr auto kDAZ = _DAZ{}; static constexpr auto kFTZ = _FTZ{}; -#endif static constexpr auto kIEEE754 = _IEEE754{}; }; @@ -135,19 +123,6 @@ class Precise { static constexpr bool kRoundForce = (std::is_same_v || ...); - static constexpr bool _kRoundNearest = - (std::is_same_v || ...); - static constexpr bool kRoundZero = - (std::is_same_v || ...); - static constexpr bool kRoundDown = - (std::is_same_v || ...); - static constexpr bool kRoundUp = (std::is_same_v || ...); - // only one rounding mode can be set - static_assert((_kRoundNearest + kRoundDown + kRoundUp + kRoundZero) <= 1, - "Only one rounding mode can be set at a time"); - // if no rounding mode is set, default to round nearest - static constexpr bool kRoundNearest = - _kRoundNearest || (!kRoundDown && !kRoundUp && !kRoundZero); static constexpr bool kDAZ = (std::is_same_v || ...); static constexpr bool kFTZ = (std::is_same_v || ...); @@ -160,17 +135,7 @@ class Precise { static constexpr bool kIEEE754 = _kIEEE754 || !(kDAZ || kFTZ); private: - int _NewRoundingMode() const { - if constexpr (kRoundDown) { - return FE_DOWNWARD; - } else if constexpr (kRoundUp) { - return FE_UPWARD; - } else if constexpr (kRoundZero) { - return FE_TOWARDZERO; - } else { - return FE_TONEAREST; - } - } + int _NewRoundingMode() const { return FE_TONEAREST; } int _rounding_mode = 0; bool _retrieve_rounding_mode = false; fexcept_t _exceptions; diff --git a/npsr/trig/data/approx.h b/npsr/trig/data/approx.h new file mode 100644 index 0000000..9b8d717 --- /dev/null +++ b/npsr/trig/data/approx.h @@ -0,0 +1,1563 @@ +// Auto-generated by npsr/trig/data/approx.h.sol +// Use `spin generate -f` to force regeneration +#ifndef NPSR_TRIG_DATA_APPROX_H +#define NPSR_TRIG_DATA_APPROX_H + +namespace npsr::trig::data { +template constexpr char kSinApproxTable[] = {}; +template <> constexpr float kSinApproxTable[] = +{ + 0.0f, 0x1p0f, 0.0f, 0.0f, + -0x1.3bcfbep-12f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, + -0x1.3bc39p-10f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, + -0x1.63253p-9f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, + -0x1.3b92e2p-8f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, + -0x1.ecdc78p-8f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, + -0x1.62aa04p-7f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, + -0x1.e26c16p-7f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, + -0x1.3ad06p-6f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, + -0x1.8e18a8p-6f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, + -0x1.eb0208p-6f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, + -0x1.28bf18p-5f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, + -0x1.60beaap-5f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, + -0x1.9d7714p-5f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, + -0x1.dedefcp-5f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, + -0x1.127624p-4f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, + -0x1.37ca18p-4f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, + -0x1.5f6598p-4f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, + -0x1.894286p-4f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, + -0x1.b55a7p-4f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, + -0x1.e3a688p-4f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, + -0x1.0a0fd4p-3f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, + -0x1.235f2ep-3f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, + -0x1.3dbd6ap-3f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, + -0x1.592676p-3f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, + -0x1.759618p-3f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, + -0x1.9307eep-3f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, + -0x1.b1776ep-3f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, + -0x1.d0dfe6p-3f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, + -0x1.f13c7ep-3f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, + -0x1.09441cp-2f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, + -0x1.1a5efap-2f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, + -0x1.2bec34p-2f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, + -0x1.3de916p-2f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, + -0x1.5052dap-2f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, + -0x1.6326a8p-2f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, + -0x1.76619cp-2f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, + -0x1.8a00bap-2f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, + -0x1.9e01p-2f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, + -0x1.b25f56p-2f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, + -0x1.c71898p-2f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, + -0x1.dc2996p-2f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, + -0x1.f18f0cp-2f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, + -0x1.d16c9p-8f, 0x1p-1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, + -0x1.d4a2c8p-6f, 0x1p-1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, + -0x1.9cc8b4p-5f, 0x1p-1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, + -0x1.28bbfep-4f, 0x1p-1f, 0x1.ced7bp-1f, -0x1.786712p-26f, + -0x1.8421bp-4f, 0x1p-1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, + -0x1.e08756p-4f, 0x1p-1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, + -0x1.1eef5ap-3f, 0x1p-1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, + -0x1.4e0cb2p-3f, 0x1p-1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, + -0x1.7d946ep-3f, 0x1p-1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, + -0x1.ad7f3ap-3f, 0x1p-1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, + -0x1.ddc5b4p-3f, 0x1p-1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, + -0x1.cc0d0ap-8f, 0x1p-2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, + -0x1.fa3ecap-6f, 0x1p-2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, + -0x1.c1d1fp-5f, 0x1p-2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, + -0x1.43bd78p-4f, 0x1p-2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, + -0x1.a6fdf2p-4f, 0x1p-2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, + -0x1.536352p-9f, 0x1p-3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, + -0x1.ba165p-6f, 0x1p-3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, + -0x1.a55beep-5f, 0x1p-3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, + -0x1.b82684p-7f, 0x1p-4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, + -0x1.b7aa82p-8f, 0x1p-5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, + 0.0f, 0.0f, 0x1p0f, 0.0f, + -0x1.003242p5f, 0x1p5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, + -0x1.00c8fcp4f, 0x1p4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, + -0x1.025aa4p3f, 0x1p3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, + -0x1.0322f4p3f, 0x1p3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, + -0x1.03eacap3f, 0x1p3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, + -0x1.096408p2f, 0x1p2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, + -0x1.0af10ap2f, 0x1p2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, + -0x1.0c7c5cp2f, 0x1p2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, + -0x1.0e05c2p2f, 0x1p2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, + -0x1.0f8cfcp2f, 0x1p2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, + -0x1.2223a4p1f, 0x1p1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, + -0x1.25280cp1f, 0x1p1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, + -0x1.2826bap1f, 0x1p1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, + -0x1.2b1f34p1f, 0x1p1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, + -0x1.2e110ap1f, 0x1p1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, + -0x1.30fbc6p1f, 0x1p1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, + -0x1.33def2p1f, 0x1p1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, + -0x1.36ba2p1f, 0x1p1f, 0x1.ced7bp-1f, -0x1.786712p-26f, + -0x1.398cdep1f, 0x1p1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, + -0x1.3c56bap1f, 0x1p1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, + -0x1.3f174ap1f, 0x1p1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, + -0x1.839c3cp0f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, + -0x1.88f59ap0f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, + -0x1.8e39dap0f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, + -0x1.93682ap0f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, + -0x1.987fcp0f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, + -0x1.9d7fd2p0f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, + -0x1.a2679ap0f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, + -0x1.a73656p0f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, + -0x1.abeb4ap0f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, + -0x1.b085bap0f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, + -0x1.b504f4p0f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, + -0x1.b96842p0f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, + -0x1.bdaefap0f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, + -0x1.c1d87p0f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, + -0x1.c5e404p0f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, + -0x1.c9d112p0f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, + -0x1.cd9f02p0f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, + -0x1.d14d3ep0f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, + -0x1.d4db32p0f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, + -0x1.d84852p0f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, + -0x1.db941ap0f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, + -0x1.debe06p0f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, + -0x1.e1c598p0f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, + -0x1.e4aa5ap0f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, + -0x1.e76bd8p0f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, + -0x1.ea09a6p0f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, + -0x1.ec835ep0f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, + -0x1.eed89ep0f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, + -0x1.f10908p0f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, + -0x1.f31448p0f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, + -0x1.f4fa0ap0f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, + -0x1.f6ba08p0f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, + -0x1.f853f8p0f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, + -0x1.f9c79ep0f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, + -0x1.fb14bep0f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, + -0x1.fc3b28p0f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, + -0x1.fd3aacp0f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, + -0x1.fe1324p0f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, + -0x1.fec46ep0f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, + -0x1.ff4e6ep0f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, + -0x1.ffb11p0f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, + -0x1.ffec44p0f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, + -0x1p1f, 0x1p0f, 0.0f, 0.0f, + -0x1.ffec44p0f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, + -0x1.ffb11p0f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, + -0x1.ff4e6ep0f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, + -0x1.fec46ep0f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, + -0x1.fe1324p0f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, + -0x1.fd3aacp0f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, + -0x1.fc3b28p0f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, + -0x1.fb14bep0f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, + -0x1.f9c79ep0f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, + -0x1.f853f8p0f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, + -0x1.f6ba08p0f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, + -0x1.f4fa0ap0f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, + -0x1.f31448p0f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, + -0x1.f10908p0f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, + -0x1.eed89ep0f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, + -0x1.ec835ep0f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, + -0x1.ea09a6p0f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, + -0x1.e76bd8p0f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, + -0x1.e4aa5ap0f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, + -0x1.e1c598p0f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, + -0x1.debe06p0f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, + -0x1.db941ap0f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, + -0x1.d84852p0f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, + -0x1.d4db32p0f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, + -0x1.d14d3ep0f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, + -0x1.cd9f02p0f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, + -0x1.c9d112p0f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, + -0x1.c5e404p0f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, + -0x1.c1d87p0f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, + -0x1.bdaefap0f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, + -0x1.b96842p0f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, + -0x1.b504f4p0f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, + -0x1.b085bap0f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, + -0x1.abeb4ap0f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, + -0x1.a73656p0f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, + -0x1.a2679ap0f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, + -0x1.9d7fd2p0f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, + -0x1.987fcp0f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, + -0x1.93682ap0f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, + -0x1.8e39dap0f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, + -0x1.88f59ap0f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, + -0x1.839c3cp0f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, + -0x1.3f174ap1f, 0x1p1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, + -0x1.3c56bap1f, 0x1p1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, + -0x1.398cdep1f, 0x1p1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, + -0x1.36ba2p1f, 0x1p1f, -0x1.ced7bp-1f, 0x1.786712p-26f, + -0x1.33def2p1f, 0x1p1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, + -0x1.30fbc6p1f, 0x1p1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, + -0x1.2e110ap1f, 0x1p1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, + -0x1.2b1f34p1f, 0x1p1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, + -0x1.2826bap1f, 0x1p1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, + -0x1.25280cp1f, 0x1p1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, + -0x1.2223a4p1f, 0x1p1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, + -0x1.0f8cfcp2f, 0x1p2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, + -0x1.0e05c2p2f, 0x1p2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, + -0x1.0c7c5cp2f, 0x1p2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, + -0x1.0af10ap2f, 0x1p2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, + -0x1.096408p2f, 0x1p2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, + -0x1.03eacap3f, 0x1p3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, + -0x1.0322f4p3f, 0x1p3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, + -0x1.025aa4p3f, 0x1p3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, + -0x1.00c8fcp4f, 0x1p4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, + -0x1.003242p5f, 0x1p5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, + 0.0f, 0.0f, -0x1p0f, 0.0f, + -0x1.b7aa82p-8f, 0x1p-5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, + -0x1.b82684p-7f, 0x1p-4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, + -0x1.a55beep-5f, 0x1p-3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, + -0x1.ba165p-6f, 0x1p-3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, + -0x1.536352p-9f, 0x1p-3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, + -0x1.a6fdf2p-4f, 0x1p-2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, + -0x1.43bd78p-4f, 0x1p-2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, + -0x1.c1d1fp-5f, 0x1p-2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, + -0x1.fa3ecap-6f, 0x1p-2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, + -0x1.cc0d0ap-8f, 0x1p-2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, + -0x1.ddc5b4p-3f, 0x1p-1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, + -0x1.ad7f3ap-3f, 0x1p-1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, + -0x1.7d946ep-3f, 0x1p-1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, + -0x1.4e0cb2p-3f, 0x1p-1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, + -0x1.1eef5ap-3f, 0x1p-1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, + -0x1.e08756p-4f, 0x1p-1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, + -0x1.8421bp-4f, 0x1p-1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, + -0x1.28bbfep-4f, 0x1p-1f, -0x1.ced7bp-1f, 0x1.786712p-26f, + -0x1.9cc8b4p-5f, 0x1p-1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, + -0x1.d4a2c8p-6f, 0x1p-1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, + -0x1.d16c9p-8f, 0x1p-1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, + -0x1.f18f0cp-2f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, + -0x1.dc2996p-2f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, + -0x1.c71898p-2f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, + -0x1.b25f56p-2f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, + -0x1.9e01p-2f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, + -0x1.8a00bap-2f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, + -0x1.76619cp-2f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, + -0x1.6326a8p-2f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, + -0x1.5052dap-2f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, + -0x1.3de916p-2f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, + -0x1.2bec34p-2f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, + -0x1.1a5efap-2f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, + -0x1.09441cp-2f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, + -0x1.f13c7ep-3f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, + -0x1.d0dfe6p-3f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, + -0x1.b1776ep-3f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, + -0x1.9307eep-3f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, + -0x1.759618p-3f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, + -0x1.592676p-3f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, + -0x1.3dbd6ap-3f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, + -0x1.235f2ep-3f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, + -0x1.0a0fd4p-3f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, + -0x1.e3a688p-4f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, + -0x1.b55a7p-4f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, + -0x1.894286p-4f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, + -0x1.5f6598p-4f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, + -0x1.37ca18p-4f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, + -0x1.127624p-4f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, + -0x1.dedefcp-5f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, + -0x1.9d7714p-5f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, + -0x1.60beaap-5f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, + -0x1.28bf18p-5f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, + -0x1.eb0208p-6f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, + -0x1.8e18a8p-6f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, + -0x1.3ad06p-6f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, + -0x1.e26c16p-7f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, + -0x1.62aa04p-7f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, + -0x1.ecdc78p-8f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, + -0x1.3b92e2p-8f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, + -0x1.63253p-9f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, + -0x1.3bc39p-10f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, + -0x1.3bcfbep-12f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, +}; + +template <> constexpr double kSinApproxTable[] = +{ + 0, 0x1p0, 0, 0, + -0x1.3bd2c8da49511p-14, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, + -0x1.3bcfbd9979a27p-12, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, + -0x1.6344004228d8bp-11, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, + -0x1.3bc390d250439p-10, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, + -0x1.ed534e31ca57fp-10, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, + -0x1.63252fe77c5ebp-9, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, + -0x1.e350342a4f6e6p-9, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, + -0x1.3b92e176d6d31p-8, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, + -0x1.8f501492cc296p-8, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, + -0x1.ecdc78f30165cp-8, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, + -0x1.2a1a39a8a2fb7p-7, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, + -0x1.62aa03dd6ba58p-7, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, + -0x1.a01b6cdbd995ep-7, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, + -0x1.e26c163ad15b3p-7, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, + -0x1.14ccb8bdbf114p-6, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, + -0x1.3ad06011469fbp-6, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, + -0x1.633f89e9a1a66p-6, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, + -0x1.8e18a73634ee7p-6, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, + -0x1.bb5a11138a4c9p-6, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, + -0x1.eb0208db9e51bp-6, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, + -0x1.0e875c1b8c3dap-5, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, + -0x1.28bf1897b69ccp-5, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, + -0x1.44273720f48bcp-5, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, + -0x1.60bea939d225ap-5, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, + -0x1.7e8454b32ef34p-5, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, + -0x1.9d7713b71eee1p-5, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, + -0x1.bd95b4d43e819p-5, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, + -0x1.dedefb09791b4p-5, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, + -0x1.00a8cee920eabp-4, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, + -0x1.127624999ee1dp-4, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, + -0x1.24d6cee3afb2ap-4, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, + -0x1.37ca1866b95cfp-4, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, + -0x1.4b4f461b0cbaap-4, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, + -0x1.5f6597591b633p-4, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, + -0x1.740c45e0e512p-4, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, + -0x1.894285e19c468p-4, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, + -0x1.9f07860181d1ep-4, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, + -0x1.b55a6f65f7058p-4, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, + -0x1.cc3a65bbc6327p-4, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, + -0x1.e3a6873fa1279p-4, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, + -0x1.fb9decc6d55b8p-4, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, + -0x1.0a0fd4e41ab5ap-3, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, + -0x1.169566329bcb7p-3, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, + -0x1.235f2eb9a470ap-3, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, + -0x1.306cb042aa3bap-3, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, + -0x1.3dbd69fabf802p-3, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, + -0x1.4b50d8778abbdp-3, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, + -0x1.592675bc57974p-3, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, + -0x1.673db93f41479p-3, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, + -0x1.759617ee761f9p-3, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, + -0x1.842f0435941afp-3, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, + -0x1.9307ee031e2fdp-3, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, + -0x1.a22042ce0a2f9p-3, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, + -0x1.b1776d9b67013p-3, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, + -0x1.c10cd7041afccp-3, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, + -0x1.d0dfe53aba2fdp-3, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, + -0x1.e0effc1174505p-3, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, + -0x1.f13c7d001a249p-3, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, + -0x1.00e263951d11fp-2, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, + -0x1.09441bb2aa0a2p-2, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, + -0x1.11c3141f91b3ep-2, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, + -0x1.1a5ef902000d3p-2, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, + -0x1.23177562aaea3p-2, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, + -0x1.2bec333018867p-2, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, + -0x1.34dcdb41f0f85p-2, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, + -0x1.3de9155c5a642p-2, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, + -0x1.471088335fce7p-2, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, + -0x1.5052d96e626c1p-2, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, + -0x1.59afadab954d4p-2, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, + -0x1.6326a8838342ep-2, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, + -0x1.6cb76c8c9ed8fp-2, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, + -0x1.76619b5edc454p-2, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, + -0x1.8024d59755257p-2, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, + -0x1.8a00badbf5e8ep-2, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, + -0x1.93f4e9df34c1bp-2, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, + -0x1.9e010063d1f96p-2, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, + -0x1.a8249b40a182cp-2, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, + -0x1.b25f56645da43p-2, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, + -0x1.bcb0ccd98294fp-2, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, + -0x1.c71898ca32e6fp-2, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, + -0x1.d19653842496fp-2, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, + -0x1.dc29957c969bbp-2, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, + -0x1.e6d1f6544ece3p-2, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, + -0x1.f18f0cdba0025p-2, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, + -0x1.fc606f1678292p-2, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, + -0x1.d16c901d95181p-8, 0x1p-1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, + -0x1.23e6ad10872a7p-6, 0x1p-1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, + -0x1.d4a2c7f909c4ep-6, 0x1p-1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, + -0x1.4344523c8e3b5p-5, 0x1p-1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, + -0x1.9cc8b3671dd0fp-5, 0x1p-1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, + -0x1.f6db13ff708cbp-5, 0x1p-1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, + -0x1.28bbfd87a8cffp-4, 0x1p-1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, + -0x1.564df524b00dap-4, 0x1p-1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, + -0x1.8421af15c49d7p-4, 0x1p-1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, + -0x1.b2356710db0a3p-4, 0x1p-1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, + -0x1.e087565455a75p-4, 0x1p-1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, + -0x1.078ad9dc46632p-3, 0x1p-1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, + -0x1.1eef59e0b74c3p-3, 0x1p-1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, + -0x1.367044581b074p-3, 0x1p-1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, + -0x1.4e0cb14a9c046p-3, 0x1p-1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, + -0x1.65c3b7b0e312cp-3, 0x1p-1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, + -0x1.7d946d7d133fdp-3, 0x1p-1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, + -0x1.957de7a3cfd5dp-3, 0x1p-1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, + -0x1.ad7f3a254c1f5p-3, 0x1p-1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, + -0x1.c597781664984p-3, 0x1p-1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, + -0x1.ddc5b3a9c1311p-3, 0x1p-1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, + -0x1.f608fe39004a4p-3, 0x1p-1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, + -0x1.cc0d09bd41caap-8, 0x1p-2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, + -0x1.36580d5d5e775p-6, 0x1p-2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, + -0x1.fa3ecac0d84e8p-6, 0x1p-2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, + -0x1.5f57f693feebep-5, 0x1p-2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, + -0x1.c1d1f0e5967d5p-5, 0x1p-2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, + -0x1.1244c435e819dp-4, 0x1p-2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, + -0x1.43bd776e98073p-4, 0x1p-2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, + -0x1.755129dad834cp-4, 0x1p-2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, + -0x1.a6fdf22e33d8cp-4, 0x1p-2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, + -0x1.d8c1e624a1513p-4, 0x1p-2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, + -0x1.536352ad19e39p-9, 0x1p-3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, + -0x1.e43d1c309e958p-7, 0x1p-3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, + -0x1.ba1650f592f5p-6, 0x1p-3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, + -0x1.4125feacab7cep-5, 0x1p-3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, + -0x1.a55beda63cc14p-5, 0x1p-3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, + -0x1.35230c0fbe402p-10, 0x1p-4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, + -0x1.b82683bc89fbp-7, 0x1p-4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, + -0x1.a4f3514d75466p-6, 0x1p-4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, + -0x1.b7aa821726608p-8, 0x1p-5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, + -0x1.b78b80c84e1eep-9, 0x1p-6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, + 0, 0, 0x1p0, 0, + -0x1.000c90e8fe6f6p6, 0x1p6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, + -0x1.003242abef46dp5, 0x1p5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, + -0x1.0096c32baca2bp4, 0x1p4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, + -0x1.00c8fb2f886ecp4, 0x1p4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, + -0x1.00fb2b73cfc1p4, 0x1p4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, + -0x1.025aa41259c34p3, 0x1p3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, + -0x1.02beda0153548p3, 0x1p3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, + -0x1.0322f4d785368p3, 0x1p3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, + -0x1.0386f0b8f3d86p3, 0x1p3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, + -0x1.03eac9cad52e6p3, 0x1p3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, + -0x1.089cf8676d7acp2, 0x1p2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, + -0x1.096408374730ap2, 0x1p2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, + -0x1.0a2abb58949f3p2, 0x1p2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, + -0x1.0af10a22459fep2, 0x1p2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, + -0x1.0bb6ecef285fap2, 0x1p2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, + -0x1.0c7c5c1e34d3p2, 0x1p2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, + -0x1.0d415012d8023p2, 0x1p2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, + -0x1.0e05c1353f27bp2, 0x1p2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, + -0x1.0ec9a7f2a2a19p2, 0x1p2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, + -0x1.0f8cfcbd90af9p2, 0x1p2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, + -0x1.209f701c6ffb6p1, 0x1p1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, + -0x1.2223a4c563ecfp1, 0x1p1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, + -0x1.23a6887e99b68p1, 0x1p1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, + -0x1.25280c5dab3e1p1, 0x1p1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, + -0x1.26a82185c302ap1, 0x1p1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, + -0x1.2826b9282eccp1, 0x1p1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, + -0x1.29a3c484f1cedp1, 0x1p1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, + -0x1.2b1f34eb563fcp1, 0x1p1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, + -0x1.2c98fbba7e4f9p1, 0x1p1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, + -0x1.2e110a61f48b4p1, 0x1p1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, + -0x1.2f8752623b99dp1, 0x1p1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, + -0x1.30fbc54d5d52cp1, 0x1p1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, + -0x1.326e54c77927bp1, 0x1p1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, + -0x1.33def28751db1p1, 0x1p1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, + -0x1.354d9056da7f9p1, 0x1p1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, + -0x1.36ba2013c2b98p1, 0x1p1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, + -0x1.382493b0023ddp1, 0x1p1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, + -0x1.398cdd326388cp1, 0x1p1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, + -0x1.3af2eeb70dc71p1, 0x1p1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, + -0x1.3c56ba700dec7p1, 0x1p1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, + -0x1.3db832a5def1bp1, 0x1p1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, + -0x1.3f1749b7f1357p1, 0x1p1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, + -0x1.80e7e43a61f5bp0, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, + -0x1.839c3cc917ff7p0, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, + -0x1.864b826aec4c7p0, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, + -0x1.88f59aa0da591p0, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, + -0x1.8b9a6b1ef6da4p0, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, + -0x1.8e39d9cd73464p0, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, + -0x1.90d3ccc99f5acp0, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, + -0x1.93682a66e896fp0, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, + -0x1.95f6d92fd79f5p0, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, + -0x1.987fbfe70b81ap0, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, + -0x1.9b02c58832cf9p0, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, + -0x1.9d7fd1490285dp0, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, + -0x1.9ff6ca9a2ab6ap0, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, + -0x1.a267992848eebp0, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, + -0x1.a4d224dcd849cp0, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, + -0x1.a73655df1f2f5p0, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, + -0x1.a99414951aacbp0, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, + -0x1.abeb49a46765p0, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, + -0x1.ae3bddf3280c6p0, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, + -0x1.b085baa8e966fp0, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, + -0x1.b2c8c92f83c1fp0, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, + -0x1.b504f333f9de6p0, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, + -0x1.b73a22a755457p0, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, + -0x1.b96841bf7ffcbp0, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, + -0x1.bb8f3af81b931p0, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, + -0x1.bdaef913557d7p0, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, + -0x1.bfc7671ab8bb8p0, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, + -0x1.c1d8705ffcbb7p0, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, + -0x1.c3e2007dd175fp0, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, + -0x1.c5e40358a8bap0, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, + -0x1.c7de651f7ca06p0, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, + -0x1.c9d1124c931fep0, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, + -0x1.cbbbf7a63eba1p0, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, + -0x1.cd9f023f9c3ap0, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, + -0x1.cf7a1f794d7cap0, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, + -0x1.d14d3d02313c1p0, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, + -0x1.d31848d817d71p0, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, + -0x1.d4db3148750d2p0, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, + -0x1.d695e4f10ea88p0, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, + -0x1.d84852c0a81p0, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, + -0x1.d9f269f7aab89p0, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, + -0x1.db941a28cb71fp0, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, + -0x1.dd2d5339ac869p0, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, + -0x1.debe05637ca95p0, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, + -0x1.e046213392aa5p0, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, + -0x1.e1c5978c05ed8p0, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, + -0x1.e33c59a4439cep0, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, + -0x1.e4aa5909a08fap0, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, + -0x1.e60f879fe7e2ep0, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, + -0x1.e76bd7a1e63b9p0, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, + -0x1.e8bf3ba1f1aeep0, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, + -0x1.ea09a68a6e49dp0, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, + -0x1.eb4b0b9e4f345p0, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, + -0x1.ec835e79946a3p0, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, + -0x1.edb29311c504dp0, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, + -0x1.eed89db66611ep0, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, + -0x1.eff573116df15p0, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, + -0x1.f1090827b4372p0, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, + -0x1.f21352595e0bfp0, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, + -0x1.f314476247089p0, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, + -0x1.f40bdd5a66886p0, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, + -0x1.f4fa0ab6316edp0, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, + -0x1.f5dec646f85bap0, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, + -0x1.f6ba073b424b2p0, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, + -0x1.f78bc51f239e1p0, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, + -0x1.f853f7dc9186cp0, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, + -0x1.f91297bbb1d6dp0, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, + -0x1.f9c79d63272c4p0, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, + -0x1.fa7301d859796p0, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, + -0x1.fb14be7fbae58p0, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, + -0x1.fbaccd1d0903cp0, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, + -0x1.fc3b27d38a5d5p0, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, + -0x1.fcbfc926484cdp0, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, + -0x1.fd3aabf84528bp0, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, + -0x1.fdabcb8caeba1p0, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, + -0x1.fe1323870cfeap0, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, + -0x1.fe70afeb6d33dp0, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, + -0x1.fec46d1e89293p0, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, + -0x1.ff0e57e5ead85p0, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, + -0x1.ff4e6d680c41dp0, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, + -0x1.ff84ab2c738d7p0, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, + -0x1.ffb10f1bcb6bfp0, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, + -0x1.ffd3977ff7baep0, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, + -0x1.ffec430426686p0, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, + -0x1.fffb10b4dc96ep0, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, + -0x1p1, 0x1p0, 0, 0, + -0x1.fffb10b4dc96ep0, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, + -0x1.ffec430426686p0, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, + -0x1.ffd3977ff7baep0, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, + -0x1.ffb10f1bcb6bfp0, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, + -0x1.ff84ab2c738d7p0, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, + -0x1.ff4e6d680c41dp0, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, + -0x1.ff0e57e5ead85p0, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, + -0x1.fec46d1e89293p0, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, + -0x1.fe70afeb6d33dp0, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, + -0x1.fe1323870cfeap0, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, + -0x1.fdabcb8caeba1p0, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, + -0x1.fd3aabf84528bp0, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, + -0x1.fcbfc926484cdp0, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, + -0x1.fc3b27d38a5d5p0, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, + -0x1.fbaccd1d0903cp0, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, + -0x1.fb14be7fbae58p0, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, + -0x1.fa7301d859796p0, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, + -0x1.f9c79d63272c4p0, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, + -0x1.f91297bbb1d6dp0, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, + -0x1.f853f7dc9186cp0, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, + -0x1.f78bc51f239e1p0, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, + -0x1.f6ba073b424b2p0, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, + -0x1.f5dec646f85bap0, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, + -0x1.f4fa0ab6316edp0, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, + -0x1.f40bdd5a66886p0, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, + -0x1.f314476247089p0, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, + -0x1.f21352595e0bfp0, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, + -0x1.f1090827b4372p0, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, + -0x1.eff573116df15p0, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, + -0x1.eed89db66611ep0, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, + -0x1.edb29311c504dp0, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, + -0x1.ec835e79946a3p0, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, + -0x1.eb4b0b9e4f345p0, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, + -0x1.ea09a68a6e49dp0, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, + -0x1.e8bf3ba1f1aeep0, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, + -0x1.e76bd7a1e63b9p0, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, + -0x1.e60f879fe7e2ep0, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, + -0x1.e4aa5909a08fap0, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, + -0x1.e33c59a4439cep0, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, + -0x1.e1c5978c05ed8p0, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, + -0x1.e046213392aa5p0, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, + -0x1.debe05637ca95p0, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, + -0x1.dd2d5339ac869p0, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, + -0x1.db941a28cb71fp0, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, + -0x1.d9f269f7aab89p0, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, + -0x1.d84852c0a81p0, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, + -0x1.d695e4f10ea88p0, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, + -0x1.d4db3148750d2p0, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, + -0x1.d31848d817d71p0, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, + -0x1.d14d3d02313c1p0, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, + -0x1.cf7a1f794d7cap0, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, + -0x1.cd9f023f9c3ap0, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, + -0x1.cbbbf7a63eba1p0, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, + -0x1.c9d1124c931fep0, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, + -0x1.c7de651f7ca06p0, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, + -0x1.c5e40358a8bap0, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, + -0x1.c3e2007dd175fp0, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, + -0x1.c1d8705ffcbb7p0, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, + -0x1.bfc7671ab8bb8p0, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, + -0x1.bdaef913557d7p0, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, + -0x1.bb8f3af81b931p0, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, + -0x1.b96841bf7ffcbp0, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, + -0x1.b73a22a755457p0, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, + -0x1.b504f333f9de6p0, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, + -0x1.b2c8c92f83c1fp0, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, + -0x1.b085baa8e966fp0, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, + -0x1.ae3bddf3280c6p0, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, + -0x1.abeb49a46765p0, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, + -0x1.a99414951aacbp0, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, + -0x1.a73655df1f2f5p0, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, + -0x1.a4d224dcd849cp0, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, + -0x1.a267992848eebp0, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, + -0x1.9ff6ca9a2ab6ap0, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, + -0x1.9d7fd1490285dp0, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, + -0x1.9b02c58832cf9p0, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, + -0x1.987fbfe70b81ap0, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, + -0x1.95f6d92fd79f5p0, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, + -0x1.93682a66e896fp0, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, + -0x1.90d3ccc99f5acp0, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, + -0x1.8e39d9cd73464p0, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, + -0x1.8b9a6b1ef6da4p0, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, + -0x1.88f59aa0da591p0, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, + -0x1.864b826aec4c7p0, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, + -0x1.839c3cc917ff7p0, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, + -0x1.80e7e43a61f5bp0, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, + -0x1.3f1749b7f1357p1, 0x1p1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, + -0x1.3db832a5def1bp1, 0x1p1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, + -0x1.3c56ba700dec7p1, 0x1p1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, + -0x1.3af2eeb70dc71p1, 0x1p1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, + -0x1.398cdd326388cp1, 0x1p1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, + -0x1.382493b0023ddp1, 0x1p1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, + -0x1.36ba2013c2b98p1, 0x1p1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, + -0x1.354d9056da7f9p1, 0x1p1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, + -0x1.33def28751db1p1, 0x1p1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, + -0x1.326e54c77927bp1, 0x1p1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, + -0x1.30fbc54d5d52cp1, 0x1p1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, + -0x1.2f8752623b99dp1, 0x1p1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, + -0x1.2e110a61f48b4p1, 0x1p1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, + -0x1.2c98fbba7e4f9p1, 0x1p1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, + -0x1.2b1f34eb563fcp1, 0x1p1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, + -0x1.29a3c484f1cedp1, 0x1p1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, + -0x1.2826b9282eccp1, 0x1p1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, + -0x1.26a82185c302ap1, 0x1p1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, + -0x1.25280c5dab3e1p1, 0x1p1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, + -0x1.23a6887e99b68p1, 0x1p1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, + -0x1.2223a4c563ecfp1, 0x1p1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, + -0x1.209f701c6ffb6p1, 0x1p1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, + -0x1.0f8cfcbd90af9p2, 0x1p2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, + -0x1.0ec9a7f2a2a19p2, 0x1p2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, + -0x1.0e05c1353f27bp2, 0x1p2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, + -0x1.0d415012d8023p2, 0x1p2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, + -0x1.0c7c5c1e34d3p2, 0x1p2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, + -0x1.0bb6ecef285fap2, 0x1p2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, + -0x1.0af10a22459fep2, 0x1p2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, + -0x1.0a2abb58949f3p2, 0x1p2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, + -0x1.096408374730ap2, 0x1p2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, + -0x1.089cf8676d7acp2, 0x1p2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, + -0x1.03eac9cad52e6p3, 0x1p3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, + -0x1.0386f0b8f3d86p3, 0x1p3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, + -0x1.0322f4d785368p3, 0x1p3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, + -0x1.02beda0153548p3, 0x1p3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, + -0x1.025aa41259c34p3, 0x1p3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, + -0x1.00fb2b73cfc1p4, 0x1p4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, + -0x1.00c8fb2f886ecp4, 0x1p4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, + -0x1.0096c32baca2bp4, 0x1p4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, + -0x1.003242abef46dp5, 0x1p5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, + -0x1.000c90e8fe6f6p6, 0x1p6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, + 0, 0, -0x1p0, 0, + -0x1.b78b80c84e1eep-9, 0x1p-6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, + -0x1.b7aa821726608p-8, 0x1p-5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, + -0x1.a4f3514d75466p-6, 0x1p-4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, + -0x1.b82683bc89fbp-7, 0x1p-4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, + -0x1.35230c0fbe402p-10, 0x1p-4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, + -0x1.a55beda63cc14p-5, 0x1p-3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, + -0x1.4125feacab7cep-5, 0x1p-3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, + -0x1.ba1650f592f5p-6, 0x1p-3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, + -0x1.e43d1c309e958p-7, 0x1p-3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, + -0x1.536352ad19e39p-9, 0x1p-3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, + -0x1.d8c1e624a1513p-4, 0x1p-2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, + -0x1.a6fdf22e33d8cp-4, 0x1p-2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, + -0x1.755129dad834cp-4, 0x1p-2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, + -0x1.43bd776e98073p-4, 0x1p-2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, + -0x1.1244c435e819dp-4, 0x1p-2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, + -0x1.c1d1f0e5967d5p-5, 0x1p-2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, + -0x1.5f57f693feebep-5, 0x1p-2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, + -0x1.fa3ecac0d84e8p-6, 0x1p-2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, + -0x1.36580d5d5e775p-6, 0x1p-2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, + -0x1.cc0d09bd41caap-8, 0x1p-2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, + -0x1.f608fe39004a4p-3, 0x1p-1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, + -0x1.ddc5b3a9c1311p-3, 0x1p-1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, + -0x1.c597781664984p-3, 0x1p-1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, + -0x1.ad7f3a254c1f5p-3, 0x1p-1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, + -0x1.957de7a3cfd5dp-3, 0x1p-1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, + -0x1.7d946d7d133fdp-3, 0x1p-1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, + -0x1.65c3b7b0e312cp-3, 0x1p-1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, + -0x1.4e0cb14a9c046p-3, 0x1p-1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, + -0x1.367044581b074p-3, 0x1p-1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, + -0x1.1eef59e0b74c3p-3, 0x1p-1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, + -0x1.078ad9dc46632p-3, 0x1p-1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, + -0x1.e087565455a75p-4, 0x1p-1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, + -0x1.b2356710db0a3p-4, 0x1p-1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, + -0x1.8421af15c49d7p-4, 0x1p-1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, + -0x1.564df524b00dap-4, 0x1p-1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, + -0x1.28bbfd87a8cffp-4, 0x1p-1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, + -0x1.f6db13ff708cbp-5, 0x1p-1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, + -0x1.9cc8b3671dd0fp-5, 0x1p-1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, + -0x1.4344523c8e3b5p-5, 0x1p-1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, + -0x1.d4a2c7f909c4ep-6, 0x1p-1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, + -0x1.23e6ad10872a7p-6, 0x1p-1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, + -0x1.d16c901d95181p-8, 0x1p-1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, + -0x1.fc606f1678292p-2, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, + -0x1.f18f0cdba0025p-2, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, + -0x1.e6d1f6544ece3p-2, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, + -0x1.dc29957c969bbp-2, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, + -0x1.d19653842496fp-2, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, + -0x1.c71898ca32e6fp-2, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, + -0x1.bcb0ccd98294fp-2, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, + -0x1.b25f56645da43p-2, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, + -0x1.a8249b40a182cp-2, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, + -0x1.9e010063d1f96p-2, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, + -0x1.93f4e9df34c1bp-2, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, + -0x1.8a00badbf5e8ep-2, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, + -0x1.8024d59755257p-2, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, + -0x1.76619b5edc454p-2, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, + -0x1.6cb76c8c9ed8fp-2, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, + -0x1.6326a8838342ep-2, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, + -0x1.59afadab954d4p-2, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, + -0x1.5052d96e626c1p-2, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, + -0x1.471088335fce7p-2, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, + -0x1.3de9155c5a642p-2, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, + -0x1.34dcdb41f0f85p-2, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, + -0x1.2bec333018867p-2, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, + -0x1.23177562aaea3p-2, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, + -0x1.1a5ef902000d3p-2, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, + -0x1.11c3141f91b3ep-2, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, + -0x1.09441bb2aa0a2p-2, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, + -0x1.00e263951d11fp-2, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, + -0x1.f13c7d001a249p-3, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, + -0x1.e0effc1174505p-3, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, + -0x1.d0dfe53aba2fdp-3, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, + -0x1.c10cd7041afccp-3, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, + -0x1.b1776d9b67013p-3, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, + -0x1.a22042ce0a2f9p-3, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, + -0x1.9307ee031e2fdp-3, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, + -0x1.842f0435941afp-3, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, + -0x1.759617ee761f9p-3, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, + -0x1.673db93f41479p-3, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, + -0x1.592675bc57974p-3, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, + -0x1.4b50d8778abbdp-3, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, + -0x1.3dbd69fabf802p-3, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, + -0x1.306cb042aa3bap-3, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, + -0x1.235f2eb9a470ap-3, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, + -0x1.169566329bcb7p-3, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, + -0x1.0a0fd4e41ab5ap-3, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, + -0x1.fb9decc6d55b8p-4, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, + -0x1.e3a6873fa1279p-4, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, + -0x1.cc3a65bbc6327p-4, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, + -0x1.b55a6f65f7058p-4, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, + -0x1.9f07860181d1ep-4, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, + -0x1.894285e19c468p-4, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, + -0x1.740c45e0e512p-4, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, + -0x1.5f6597591b633p-4, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, + -0x1.4b4f461b0cbaap-4, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, + -0x1.37ca1866b95cfp-4, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, + -0x1.24d6cee3afb2ap-4, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, + -0x1.127624999ee1dp-4, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, + -0x1.00a8cee920eabp-4, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, + -0x1.dedefb09791b4p-5, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, + -0x1.bd95b4d43e819p-5, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, + -0x1.9d7713b71eee1p-5, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, + -0x1.7e8454b32ef34p-5, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, + -0x1.60bea939d225ap-5, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, + -0x1.44273720f48bcp-5, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, + -0x1.28bf1897b69ccp-5, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, + -0x1.0e875c1b8c3dap-5, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, + -0x1.eb0208db9e51bp-6, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, + -0x1.bb5a11138a4c9p-6, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, + -0x1.8e18a73634ee7p-6, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, + -0x1.633f89e9a1a66p-6, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, + -0x1.3ad06011469fbp-6, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, + -0x1.14ccb8bdbf114p-6, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, + -0x1.e26c163ad15b3p-7, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, + -0x1.a01b6cdbd995ep-7, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, + -0x1.62aa03dd6ba58p-7, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, + -0x1.2a1a39a8a2fb7p-7, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, + -0x1.ecdc78f30165cp-8, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, + -0x1.8f501492cc296p-8, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, + -0x1.3b92e176d6d31p-8, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, + -0x1.e350342a4f6e6p-9, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, + -0x1.63252fe77c5ebp-9, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, + -0x1.ed534e31ca57fp-10, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, + -0x1.3bc390d250439p-10, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, + -0x1.6344004228d8bp-11, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, + -0x1.3bcfbd9979a27p-12, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, + -0x1.3bd2c8da49511p-14, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, +}; + +template constexpr char kCosApproxTable[] = {}; +template <> constexpr float kCosApproxTable[] = +{ + 0.0f, 0.0f, 0x1p0f, 0.0f, + -0x1.003242p5f, 0x1p5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, + -0x1.00c8fcp4f, 0x1p4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, + -0x1.025aa4p3f, 0x1p3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, + -0x1.0322f4p3f, 0x1p3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, + -0x1.03eacap3f, 0x1p3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, + -0x1.096408p2f, 0x1p2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, + -0x1.0af10ap2f, 0x1p2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, + -0x1.0c7c5cp2f, 0x1p2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, + -0x1.0e05c2p2f, 0x1p2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, + -0x1.0f8cfcp2f, 0x1p2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, + -0x1.2223a4p1f, 0x1p1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, + -0x1.25280cp1f, 0x1p1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, + -0x1.2826bap1f, 0x1p1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, + -0x1.2b1f34p1f, 0x1p1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, + -0x1.2e110ap1f, 0x1p1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, + -0x1.30fbc6p1f, 0x1p1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, + -0x1.33def2p1f, 0x1p1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, + -0x1.36ba2p1f, 0x1p1f, 0x1.ced7bp-1f, -0x1.786712p-26f, + -0x1.398cdep1f, 0x1p1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, + -0x1.3c56bap1f, 0x1p1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, + -0x1.3f174ap1f, 0x1p1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, + -0x1.839c3cp0f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, + -0x1.88f59ap0f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, + -0x1.8e39dap0f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, + -0x1.93682ap0f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, + -0x1.987fcp0f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, + -0x1.9d7fd2p0f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, + -0x1.a2679ap0f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, + -0x1.a73656p0f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, + -0x1.abeb4ap0f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, + -0x1.b085bap0f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, + -0x1.b504f4p0f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, + -0x1.b96842p0f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, + -0x1.bdaefap0f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, + -0x1.c1d87p0f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, + -0x1.c5e404p0f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, + -0x1.c9d112p0f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, + -0x1.cd9f02p0f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, + -0x1.d14d3ep0f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, + -0x1.d4db32p0f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, + -0x1.d84852p0f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, + -0x1.db941ap0f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, + -0x1.debe06p0f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, + -0x1.e1c598p0f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, + -0x1.e4aa5ap0f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, + -0x1.e76bd8p0f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, + -0x1.ea09a6p0f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, + -0x1.ec835ep0f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, + -0x1.eed89ep0f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, + -0x1.f10908p0f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, + -0x1.f31448p0f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, + -0x1.f4fa0ap0f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, + -0x1.f6ba08p0f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, + -0x1.f853f8p0f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, + -0x1.f9c79ep0f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, + -0x1.fb14bep0f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, + -0x1.fc3b28p0f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, + -0x1.fd3aacp0f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, + -0x1.fe1324p0f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, + -0x1.fec46ep0f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, + -0x1.ff4e6ep0f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, + -0x1.ffb11p0f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, + -0x1.ffec44p0f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, + -0x1p1f, 0x1p0f, 0.0f, 0.0f, + -0x1.ffec44p0f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, + -0x1.ffb11p0f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, + -0x1.ff4e6ep0f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, + -0x1.fec46ep0f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, + -0x1.fe1324p0f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, + -0x1.fd3aacp0f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, + -0x1.fc3b28p0f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, + -0x1.fb14bep0f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, + -0x1.f9c79ep0f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, + -0x1.f853f8p0f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, + -0x1.f6ba08p0f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, + -0x1.f4fa0ap0f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, + -0x1.f31448p0f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, + -0x1.f10908p0f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, + -0x1.eed89ep0f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, + -0x1.ec835ep0f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, + -0x1.ea09a6p0f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, + -0x1.e76bd8p0f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, + -0x1.e4aa5ap0f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, + -0x1.e1c598p0f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, + -0x1.debe06p0f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, + -0x1.db941ap0f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, + -0x1.d84852p0f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, + -0x1.d4db32p0f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, + -0x1.d14d3ep0f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, + -0x1.cd9f02p0f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, + -0x1.c9d112p0f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, + -0x1.c5e404p0f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, + -0x1.c1d87p0f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, + -0x1.bdaefap0f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, + -0x1.b96842p0f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, + -0x1.b504f4p0f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, + -0x1.b085bap0f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, + -0x1.abeb4ap0f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, + -0x1.a73656p0f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, + -0x1.a2679ap0f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, + -0x1.9d7fd2p0f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, + -0x1.987fcp0f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, + -0x1.93682ap0f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, + -0x1.8e39dap0f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, + -0x1.88f59ap0f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, + -0x1.839c3cp0f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, + -0x1.3f174ap1f, 0x1p1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, + -0x1.3c56bap1f, 0x1p1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, + -0x1.398cdep1f, 0x1p1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, + -0x1.36ba2p1f, 0x1p1f, -0x1.ced7bp-1f, 0x1.786712p-26f, + -0x1.33def2p1f, 0x1p1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, + -0x1.30fbc6p1f, 0x1p1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, + -0x1.2e110ap1f, 0x1p1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, + -0x1.2b1f34p1f, 0x1p1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, + -0x1.2826bap1f, 0x1p1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, + -0x1.25280cp1f, 0x1p1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, + -0x1.2223a4p1f, 0x1p1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, + -0x1.0f8cfcp2f, 0x1p2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, + -0x1.0e05c2p2f, 0x1p2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, + -0x1.0c7c5cp2f, 0x1p2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, + -0x1.0af10ap2f, 0x1p2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, + -0x1.096408p2f, 0x1p2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, + -0x1.03eacap3f, 0x1p3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, + -0x1.0322f4p3f, 0x1p3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, + -0x1.025aa4p3f, 0x1p3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, + -0x1.00c8fcp4f, 0x1p4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, + -0x1.003242p5f, 0x1p5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, + 0.0f, 0.0f, -0x1p0f, 0.0f, + -0x1.b7aa82p-8f, 0x1p-5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, + -0x1.b82684p-7f, 0x1p-4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, + -0x1.a55beep-5f, 0x1p-3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, + -0x1.ba165p-6f, 0x1p-3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, + -0x1.536352p-9f, 0x1p-3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, + -0x1.a6fdf2p-4f, 0x1p-2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, + -0x1.43bd78p-4f, 0x1p-2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, + -0x1.c1d1fp-5f, 0x1p-2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, + -0x1.fa3ecap-6f, 0x1p-2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, + -0x1.cc0d0ap-8f, 0x1p-2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, + -0x1.ddc5b4p-3f, 0x1p-1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, + -0x1.ad7f3ap-3f, 0x1p-1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, + -0x1.7d946ep-3f, 0x1p-1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, + -0x1.4e0cb2p-3f, 0x1p-1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, + -0x1.1eef5ap-3f, 0x1p-1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, + -0x1.e08756p-4f, 0x1p-1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, + -0x1.8421bp-4f, 0x1p-1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, + -0x1.28bbfep-4f, 0x1p-1f, -0x1.ced7bp-1f, 0x1.786712p-26f, + -0x1.9cc8b4p-5f, 0x1p-1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, + -0x1.d4a2c8p-6f, 0x1p-1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, + -0x1.d16c9p-8f, 0x1p-1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, + -0x1.f18f0cp-2f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, + -0x1.dc2996p-2f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, + -0x1.c71898p-2f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, + -0x1.b25f56p-2f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, + -0x1.9e01p-2f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, + -0x1.8a00bap-2f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, + -0x1.76619cp-2f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, + -0x1.6326a8p-2f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, + -0x1.5052dap-2f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, + -0x1.3de916p-2f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, + -0x1.2bec34p-2f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, + -0x1.1a5efap-2f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, + -0x1.09441cp-2f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, + -0x1.f13c7ep-3f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, + -0x1.d0dfe6p-3f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, + -0x1.b1776ep-3f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, + -0x1.9307eep-3f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, + -0x1.759618p-3f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, + -0x1.592676p-3f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, + -0x1.3dbd6ap-3f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, + -0x1.235f2ep-3f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, + -0x1.0a0fd4p-3f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, + -0x1.e3a688p-4f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, + -0x1.b55a7p-4f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, + -0x1.894286p-4f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, + -0x1.5f6598p-4f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, + -0x1.37ca18p-4f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, + -0x1.127624p-4f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, + -0x1.dedefcp-5f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, + -0x1.9d7714p-5f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, + -0x1.60beaap-5f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, + -0x1.28bf18p-5f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, + -0x1.eb0208p-6f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, + -0x1.8e18a8p-6f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, + -0x1.3ad06p-6f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, + -0x1.e26c16p-7f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, + -0x1.62aa04p-7f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, + -0x1.ecdc78p-8f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, + -0x1.3b92e2p-8f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, + -0x1.63253p-9f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, + -0x1.3bc39p-10f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, + -0x1.3bcfbep-12f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, + 0.0f, 0x1p0f, 0.0f, 0.0f, + -0x1.3bcfbep-12f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, + -0x1.3bc39p-10f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, + -0x1.63253p-9f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, + -0x1.3b92e2p-8f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, + -0x1.ecdc78p-8f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, + -0x1.62aa04p-7f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, + -0x1.e26c16p-7f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, + -0x1.3ad06p-6f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, + -0x1.8e18a8p-6f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, + -0x1.eb0208p-6f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, + -0x1.28bf18p-5f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, + -0x1.60beaap-5f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, + -0x1.9d7714p-5f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, + -0x1.dedefcp-5f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, + -0x1.127624p-4f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, + -0x1.37ca18p-4f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, + -0x1.5f6598p-4f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, + -0x1.894286p-4f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, + -0x1.b55a7p-4f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, + -0x1.e3a688p-4f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, + -0x1.0a0fd4p-3f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, + -0x1.235f2ep-3f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, + -0x1.3dbd6ap-3f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, + -0x1.592676p-3f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, + -0x1.759618p-3f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, + -0x1.9307eep-3f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, + -0x1.b1776ep-3f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, + -0x1.d0dfe6p-3f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, + -0x1.f13c7ep-3f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, + -0x1.09441cp-2f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, + -0x1.1a5efap-2f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, + -0x1.2bec34p-2f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, + -0x1.3de916p-2f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, + -0x1.5052dap-2f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, + -0x1.6326a8p-2f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, + -0x1.76619cp-2f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, + -0x1.8a00bap-2f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, + -0x1.9e01p-2f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, + -0x1.b25f56p-2f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, + -0x1.c71898p-2f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, + -0x1.dc2996p-2f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, + -0x1.f18f0cp-2f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, + -0x1.d16c9p-8f, 0x1p-1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, + -0x1.d4a2c8p-6f, 0x1p-1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, + -0x1.9cc8b4p-5f, 0x1p-1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, + -0x1.28bbfep-4f, 0x1p-1f, 0x1.ced7bp-1f, -0x1.786712p-26f, + -0x1.8421bp-4f, 0x1p-1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, + -0x1.e08756p-4f, 0x1p-1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, + -0x1.1eef5ap-3f, 0x1p-1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, + -0x1.4e0cb2p-3f, 0x1p-1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, + -0x1.7d946ep-3f, 0x1p-1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, + -0x1.ad7f3ap-3f, 0x1p-1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, + -0x1.ddc5b4p-3f, 0x1p-1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, + -0x1.cc0d0ap-8f, 0x1p-2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, + -0x1.fa3ecap-6f, 0x1p-2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, + -0x1.c1d1fp-5f, 0x1p-2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, + -0x1.43bd78p-4f, 0x1p-2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, + -0x1.a6fdf2p-4f, 0x1p-2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, + -0x1.536352p-9f, 0x1p-3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, + -0x1.ba165p-6f, 0x1p-3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, + -0x1.a55beep-5f, 0x1p-3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, + -0x1.b82684p-7f, 0x1p-4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, + -0x1.b7aa82p-8f, 0x1p-5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, +}; + +template <> constexpr double kCosApproxTable[] = +{ + 0, 0, 0x1p0, 0, + -0x1.000c90e8fe6f6p6, 0x1p6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, + -0x1.003242abef46dp5, 0x1p5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, + -0x1.0096c32baca2bp4, 0x1p4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, + -0x1.00c8fb2f886ecp4, 0x1p4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, + -0x1.00fb2b73cfc1p4, 0x1p4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, + -0x1.025aa41259c34p3, 0x1p3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, + -0x1.02beda0153548p3, 0x1p3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, + -0x1.0322f4d785368p3, 0x1p3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, + -0x1.0386f0b8f3d86p3, 0x1p3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, + -0x1.03eac9cad52e6p3, 0x1p3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, + -0x1.089cf8676d7acp2, 0x1p2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, + -0x1.096408374730ap2, 0x1p2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, + -0x1.0a2abb58949f3p2, 0x1p2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, + -0x1.0af10a22459fep2, 0x1p2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, + -0x1.0bb6ecef285fap2, 0x1p2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, + -0x1.0c7c5c1e34d3p2, 0x1p2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, + -0x1.0d415012d8023p2, 0x1p2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, + -0x1.0e05c1353f27bp2, 0x1p2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, + -0x1.0ec9a7f2a2a19p2, 0x1p2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, + -0x1.0f8cfcbd90af9p2, 0x1p2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, + -0x1.209f701c6ffb6p1, 0x1p1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, + -0x1.2223a4c563ecfp1, 0x1p1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, + -0x1.23a6887e99b68p1, 0x1p1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, + -0x1.25280c5dab3e1p1, 0x1p1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, + -0x1.26a82185c302ap1, 0x1p1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, + -0x1.2826b9282eccp1, 0x1p1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, + -0x1.29a3c484f1cedp1, 0x1p1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, + -0x1.2b1f34eb563fcp1, 0x1p1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, + -0x1.2c98fbba7e4f9p1, 0x1p1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, + -0x1.2e110a61f48b4p1, 0x1p1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, + -0x1.2f8752623b99dp1, 0x1p1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, + -0x1.30fbc54d5d52cp1, 0x1p1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, + -0x1.326e54c77927bp1, 0x1p1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, + -0x1.33def28751db1p1, 0x1p1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, + -0x1.354d9056da7f9p1, 0x1p1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, + -0x1.36ba2013c2b98p1, 0x1p1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, + -0x1.382493b0023ddp1, 0x1p1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, + -0x1.398cdd326388cp1, 0x1p1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, + -0x1.3af2eeb70dc71p1, 0x1p1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, + -0x1.3c56ba700dec7p1, 0x1p1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, + -0x1.3db832a5def1bp1, 0x1p1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, + -0x1.3f1749b7f1357p1, 0x1p1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, + -0x1.80e7e43a61f5bp0, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, + -0x1.839c3cc917ff7p0, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, + -0x1.864b826aec4c7p0, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, + -0x1.88f59aa0da591p0, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, + -0x1.8b9a6b1ef6da4p0, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, + -0x1.8e39d9cd73464p0, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, + -0x1.90d3ccc99f5acp0, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, + -0x1.93682a66e896fp0, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, + -0x1.95f6d92fd79f5p0, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, + -0x1.987fbfe70b81ap0, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, + -0x1.9b02c58832cf9p0, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, + -0x1.9d7fd1490285dp0, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, + -0x1.9ff6ca9a2ab6ap0, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, + -0x1.a267992848eebp0, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, + -0x1.a4d224dcd849cp0, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, + -0x1.a73655df1f2f5p0, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, + -0x1.a99414951aacbp0, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, + -0x1.abeb49a46765p0, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, + -0x1.ae3bddf3280c6p0, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, + -0x1.b085baa8e966fp0, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, + -0x1.b2c8c92f83c1fp0, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, + -0x1.b504f333f9de6p0, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, + -0x1.b73a22a755457p0, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, + -0x1.b96841bf7ffcbp0, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, + -0x1.bb8f3af81b931p0, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, + -0x1.bdaef913557d7p0, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, + -0x1.bfc7671ab8bb8p0, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, + -0x1.c1d8705ffcbb7p0, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, + -0x1.c3e2007dd175fp0, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, + -0x1.c5e40358a8bap0, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, + -0x1.c7de651f7ca06p0, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, + -0x1.c9d1124c931fep0, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, + -0x1.cbbbf7a63eba1p0, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, + -0x1.cd9f023f9c3ap0, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, + -0x1.cf7a1f794d7cap0, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, + -0x1.d14d3d02313c1p0, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, + -0x1.d31848d817d71p0, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, + -0x1.d4db3148750d2p0, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, + -0x1.d695e4f10ea88p0, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, + -0x1.d84852c0a81p0, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, + -0x1.d9f269f7aab89p0, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, + -0x1.db941a28cb71fp0, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, + -0x1.dd2d5339ac869p0, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, + -0x1.debe05637ca95p0, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, + -0x1.e046213392aa5p0, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, + -0x1.e1c5978c05ed8p0, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, + -0x1.e33c59a4439cep0, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, + -0x1.e4aa5909a08fap0, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, + -0x1.e60f879fe7e2ep0, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, + -0x1.e76bd7a1e63b9p0, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, + -0x1.e8bf3ba1f1aeep0, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, + -0x1.ea09a68a6e49dp0, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, + -0x1.eb4b0b9e4f345p0, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, + -0x1.ec835e79946a3p0, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, + -0x1.edb29311c504dp0, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, + -0x1.eed89db66611ep0, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, + -0x1.eff573116df15p0, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, + -0x1.f1090827b4372p0, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, + -0x1.f21352595e0bfp0, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, + -0x1.f314476247089p0, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, + -0x1.f40bdd5a66886p0, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, + -0x1.f4fa0ab6316edp0, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, + -0x1.f5dec646f85bap0, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, + -0x1.f6ba073b424b2p0, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, + -0x1.f78bc51f239e1p0, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, + -0x1.f853f7dc9186cp0, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, + -0x1.f91297bbb1d6dp0, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, + -0x1.f9c79d63272c4p0, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, + -0x1.fa7301d859796p0, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, + -0x1.fb14be7fbae58p0, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, + -0x1.fbaccd1d0903cp0, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, + -0x1.fc3b27d38a5d5p0, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, + -0x1.fcbfc926484cdp0, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, + -0x1.fd3aabf84528bp0, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, + -0x1.fdabcb8caeba1p0, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, + -0x1.fe1323870cfeap0, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, + -0x1.fe70afeb6d33dp0, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, + -0x1.fec46d1e89293p0, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, + -0x1.ff0e57e5ead85p0, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, + -0x1.ff4e6d680c41dp0, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, + -0x1.ff84ab2c738d7p0, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, + -0x1.ffb10f1bcb6bfp0, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, + -0x1.ffd3977ff7baep0, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, + -0x1.ffec430426686p0, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, + -0x1.fffb10b4dc96ep0, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, + -0x1p1, 0x1p0, 0, 0, + -0x1.fffb10b4dc96ep0, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, + -0x1.ffec430426686p0, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, + -0x1.ffd3977ff7baep0, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, + -0x1.ffb10f1bcb6bfp0, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, + -0x1.ff84ab2c738d7p0, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, + -0x1.ff4e6d680c41dp0, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, + -0x1.ff0e57e5ead85p0, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, + -0x1.fec46d1e89293p0, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, + -0x1.fe70afeb6d33dp0, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, + -0x1.fe1323870cfeap0, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, + -0x1.fdabcb8caeba1p0, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, + -0x1.fd3aabf84528bp0, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, + -0x1.fcbfc926484cdp0, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, + -0x1.fc3b27d38a5d5p0, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, + -0x1.fbaccd1d0903cp0, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, + -0x1.fb14be7fbae58p0, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, + -0x1.fa7301d859796p0, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, + -0x1.f9c79d63272c4p0, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, + -0x1.f91297bbb1d6dp0, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, + -0x1.f853f7dc9186cp0, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, + -0x1.f78bc51f239e1p0, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, + -0x1.f6ba073b424b2p0, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, + -0x1.f5dec646f85bap0, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, + -0x1.f4fa0ab6316edp0, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, + -0x1.f40bdd5a66886p0, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, + -0x1.f314476247089p0, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, + -0x1.f21352595e0bfp0, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, + -0x1.f1090827b4372p0, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, + -0x1.eff573116df15p0, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, + -0x1.eed89db66611ep0, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, + -0x1.edb29311c504dp0, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, + -0x1.ec835e79946a3p0, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, + -0x1.eb4b0b9e4f345p0, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, + -0x1.ea09a68a6e49dp0, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, + -0x1.e8bf3ba1f1aeep0, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, + -0x1.e76bd7a1e63b9p0, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, + -0x1.e60f879fe7e2ep0, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, + -0x1.e4aa5909a08fap0, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, + -0x1.e33c59a4439cep0, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, + -0x1.e1c5978c05ed8p0, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, + -0x1.e046213392aa5p0, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, + -0x1.debe05637ca95p0, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, + -0x1.dd2d5339ac869p0, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, + -0x1.db941a28cb71fp0, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, + -0x1.d9f269f7aab89p0, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, + -0x1.d84852c0a81p0, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, + -0x1.d695e4f10ea88p0, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, + -0x1.d4db3148750d2p0, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, + -0x1.d31848d817d71p0, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, + -0x1.d14d3d02313c1p0, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, + -0x1.cf7a1f794d7cap0, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, + -0x1.cd9f023f9c3ap0, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, + -0x1.cbbbf7a63eba1p0, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, + -0x1.c9d1124c931fep0, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, + -0x1.c7de651f7ca06p0, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, + -0x1.c5e40358a8bap0, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, + -0x1.c3e2007dd175fp0, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, + -0x1.c1d8705ffcbb7p0, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, + -0x1.bfc7671ab8bb8p0, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, + -0x1.bdaef913557d7p0, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, + -0x1.bb8f3af81b931p0, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, + -0x1.b96841bf7ffcbp0, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, + -0x1.b73a22a755457p0, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, + -0x1.b504f333f9de6p0, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, + -0x1.b2c8c92f83c1fp0, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, + -0x1.b085baa8e966fp0, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, + -0x1.ae3bddf3280c6p0, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, + -0x1.abeb49a46765p0, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, + -0x1.a99414951aacbp0, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, + -0x1.a73655df1f2f5p0, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, + -0x1.a4d224dcd849cp0, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, + -0x1.a267992848eebp0, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, + -0x1.9ff6ca9a2ab6ap0, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, + -0x1.9d7fd1490285dp0, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, + -0x1.9b02c58832cf9p0, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, + -0x1.987fbfe70b81ap0, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, + -0x1.95f6d92fd79f5p0, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, + -0x1.93682a66e896fp0, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, + -0x1.90d3ccc99f5acp0, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, + -0x1.8e39d9cd73464p0, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, + -0x1.8b9a6b1ef6da4p0, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, + -0x1.88f59aa0da591p0, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, + -0x1.864b826aec4c7p0, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, + -0x1.839c3cc917ff7p0, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, + -0x1.80e7e43a61f5bp0, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, + -0x1.3f1749b7f1357p1, 0x1p1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, + -0x1.3db832a5def1bp1, 0x1p1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, + -0x1.3c56ba700dec7p1, 0x1p1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, + -0x1.3af2eeb70dc71p1, 0x1p1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, + -0x1.398cdd326388cp1, 0x1p1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, + -0x1.382493b0023ddp1, 0x1p1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, + -0x1.36ba2013c2b98p1, 0x1p1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, + -0x1.354d9056da7f9p1, 0x1p1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, + -0x1.33def28751db1p1, 0x1p1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, + -0x1.326e54c77927bp1, 0x1p1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, + -0x1.30fbc54d5d52cp1, 0x1p1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, + -0x1.2f8752623b99dp1, 0x1p1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, + -0x1.2e110a61f48b4p1, 0x1p1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, + -0x1.2c98fbba7e4f9p1, 0x1p1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, + -0x1.2b1f34eb563fcp1, 0x1p1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, + -0x1.29a3c484f1cedp1, 0x1p1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, + -0x1.2826b9282eccp1, 0x1p1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, + -0x1.26a82185c302ap1, 0x1p1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, + -0x1.25280c5dab3e1p1, 0x1p1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, + -0x1.23a6887e99b68p1, 0x1p1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, + -0x1.2223a4c563ecfp1, 0x1p1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, + -0x1.209f701c6ffb6p1, 0x1p1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, + -0x1.0f8cfcbd90af9p2, 0x1p2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, + -0x1.0ec9a7f2a2a19p2, 0x1p2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, + -0x1.0e05c1353f27bp2, 0x1p2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, + -0x1.0d415012d8023p2, 0x1p2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, + -0x1.0c7c5c1e34d3p2, 0x1p2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, + -0x1.0bb6ecef285fap2, 0x1p2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, + -0x1.0af10a22459fep2, 0x1p2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, + -0x1.0a2abb58949f3p2, 0x1p2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, + -0x1.096408374730ap2, 0x1p2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, + -0x1.089cf8676d7acp2, 0x1p2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, + -0x1.03eac9cad52e6p3, 0x1p3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, + -0x1.0386f0b8f3d86p3, 0x1p3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, + -0x1.0322f4d785368p3, 0x1p3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, + -0x1.02beda0153548p3, 0x1p3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, + -0x1.025aa41259c34p3, 0x1p3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, + -0x1.00fb2b73cfc1p4, 0x1p4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, + -0x1.00c8fb2f886ecp4, 0x1p4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, + -0x1.0096c32baca2bp4, 0x1p4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, + -0x1.003242abef46dp5, 0x1p5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, + -0x1.000c90e8fe6f6p6, 0x1p6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, + 0, 0, -0x1p0, 0, + -0x1.b78b80c84e1eep-9, 0x1p-6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, + -0x1.b7aa821726608p-8, 0x1p-5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, + -0x1.a4f3514d75466p-6, 0x1p-4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, + -0x1.b82683bc89fbp-7, 0x1p-4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, + -0x1.35230c0fbe402p-10, 0x1p-4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, + -0x1.a55beda63cc14p-5, 0x1p-3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, + -0x1.4125feacab7cep-5, 0x1p-3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, + -0x1.ba1650f592f5p-6, 0x1p-3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, + -0x1.e43d1c309e958p-7, 0x1p-3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, + -0x1.536352ad19e39p-9, 0x1p-3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, + -0x1.d8c1e624a1513p-4, 0x1p-2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, + -0x1.a6fdf22e33d8cp-4, 0x1p-2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, + -0x1.755129dad834cp-4, 0x1p-2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, + -0x1.43bd776e98073p-4, 0x1p-2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, + -0x1.1244c435e819dp-4, 0x1p-2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, + -0x1.c1d1f0e5967d5p-5, 0x1p-2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, + -0x1.5f57f693feebep-5, 0x1p-2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, + -0x1.fa3ecac0d84e8p-6, 0x1p-2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, + -0x1.36580d5d5e775p-6, 0x1p-2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, + -0x1.cc0d09bd41caap-8, 0x1p-2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, + -0x1.f608fe39004a4p-3, 0x1p-1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, + -0x1.ddc5b3a9c1311p-3, 0x1p-1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, + -0x1.c597781664984p-3, 0x1p-1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, + -0x1.ad7f3a254c1f5p-3, 0x1p-1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, + -0x1.957de7a3cfd5dp-3, 0x1p-1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, + -0x1.7d946d7d133fdp-3, 0x1p-1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, + -0x1.65c3b7b0e312cp-3, 0x1p-1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, + -0x1.4e0cb14a9c046p-3, 0x1p-1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, + -0x1.367044581b074p-3, 0x1p-1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, + -0x1.1eef59e0b74c3p-3, 0x1p-1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, + -0x1.078ad9dc46632p-3, 0x1p-1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, + -0x1.e087565455a75p-4, 0x1p-1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, + -0x1.b2356710db0a3p-4, 0x1p-1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, + -0x1.8421af15c49d7p-4, 0x1p-1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, + -0x1.564df524b00dap-4, 0x1p-1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, + -0x1.28bbfd87a8cffp-4, 0x1p-1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, + -0x1.f6db13ff708cbp-5, 0x1p-1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, + -0x1.9cc8b3671dd0fp-5, 0x1p-1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, + -0x1.4344523c8e3b5p-5, 0x1p-1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, + -0x1.d4a2c7f909c4ep-6, 0x1p-1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, + -0x1.23e6ad10872a7p-6, 0x1p-1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, + -0x1.d16c901d95181p-8, 0x1p-1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, + -0x1.fc606f1678292p-2, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, + -0x1.f18f0cdba0025p-2, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, + -0x1.e6d1f6544ece3p-2, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, + -0x1.dc29957c969bbp-2, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, + -0x1.d19653842496fp-2, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, + -0x1.c71898ca32e6fp-2, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, + -0x1.bcb0ccd98294fp-2, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, + -0x1.b25f56645da43p-2, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, + -0x1.a8249b40a182cp-2, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, + -0x1.9e010063d1f96p-2, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, + -0x1.93f4e9df34c1bp-2, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, + -0x1.8a00badbf5e8ep-2, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, + -0x1.8024d59755257p-2, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, + -0x1.76619b5edc454p-2, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, + -0x1.6cb76c8c9ed8fp-2, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, + -0x1.6326a8838342ep-2, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, + -0x1.59afadab954d4p-2, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, + -0x1.5052d96e626c1p-2, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, + -0x1.471088335fce7p-2, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, + -0x1.3de9155c5a642p-2, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, + -0x1.34dcdb41f0f85p-2, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, + -0x1.2bec333018867p-2, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, + -0x1.23177562aaea3p-2, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, + -0x1.1a5ef902000d3p-2, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, + -0x1.11c3141f91b3ep-2, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, + -0x1.09441bb2aa0a2p-2, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, + -0x1.00e263951d11fp-2, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, + -0x1.f13c7d001a249p-3, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, + -0x1.e0effc1174505p-3, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, + -0x1.d0dfe53aba2fdp-3, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, + -0x1.c10cd7041afccp-3, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, + -0x1.b1776d9b67013p-3, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, + -0x1.a22042ce0a2f9p-3, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, + -0x1.9307ee031e2fdp-3, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, + -0x1.842f0435941afp-3, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, + -0x1.759617ee761f9p-3, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, + -0x1.673db93f41479p-3, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, + -0x1.592675bc57974p-3, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, + -0x1.4b50d8778abbdp-3, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, + -0x1.3dbd69fabf802p-3, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, + -0x1.306cb042aa3bap-3, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, + -0x1.235f2eb9a470ap-3, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, + -0x1.169566329bcb7p-3, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, + -0x1.0a0fd4e41ab5ap-3, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, + -0x1.fb9decc6d55b8p-4, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, + -0x1.e3a6873fa1279p-4, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, + -0x1.cc3a65bbc6327p-4, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, + -0x1.b55a6f65f7058p-4, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, + -0x1.9f07860181d1ep-4, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, + -0x1.894285e19c468p-4, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, + -0x1.740c45e0e512p-4, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, + -0x1.5f6597591b633p-4, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, + -0x1.4b4f461b0cbaap-4, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, + -0x1.37ca1866b95cfp-4, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, + -0x1.24d6cee3afb2ap-4, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, + -0x1.127624999ee1dp-4, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, + -0x1.00a8cee920eabp-4, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, + -0x1.dedefb09791b4p-5, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, + -0x1.bd95b4d43e819p-5, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, + -0x1.9d7713b71eee1p-5, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, + -0x1.7e8454b32ef34p-5, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, + -0x1.60bea939d225ap-5, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, + -0x1.44273720f48bcp-5, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, + -0x1.28bf1897b69ccp-5, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, + -0x1.0e875c1b8c3dap-5, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, + -0x1.eb0208db9e51bp-6, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, + -0x1.bb5a11138a4c9p-6, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, + -0x1.8e18a73634ee7p-6, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, + -0x1.633f89e9a1a66p-6, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, + -0x1.3ad06011469fbp-6, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, + -0x1.14ccb8bdbf114p-6, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, + -0x1.e26c163ad15b3p-7, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, + -0x1.a01b6cdbd995ep-7, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, + -0x1.62aa03dd6ba58p-7, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, + -0x1.2a1a39a8a2fb7p-7, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, + -0x1.ecdc78f30165cp-8, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, + -0x1.8f501492cc296p-8, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, + -0x1.3b92e176d6d31p-8, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, + -0x1.e350342a4f6e6p-9, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, + -0x1.63252fe77c5ebp-9, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, + -0x1.ed534e31ca57fp-10, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, + -0x1.3bc390d250439p-10, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, + -0x1.6344004228d8bp-11, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, + -0x1.3bcfbd9979a27p-12, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, + -0x1.3bd2c8da49511p-14, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, + 0, 0x1p0, 0, 0, + -0x1.3bd2c8da49511p-14, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, + -0x1.3bcfbd9979a27p-12, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, + -0x1.6344004228d8bp-11, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, + -0x1.3bc390d250439p-10, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, + -0x1.ed534e31ca57fp-10, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, + -0x1.63252fe77c5ebp-9, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, + -0x1.e350342a4f6e6p-9, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, + -0x1.3b92e176d6d31p-8, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, + -0x1.8f501492cc296p-8, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, + -0x1.ecdc78f30165cp-8, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, + -0x1.2a1a39a8a2fb7p-7, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, + -0x1.62aa03dd6ba58p-7, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, + -0x1.a01b6cdbd995ep-7, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, + -0x1.e26c163ad15b3p-7, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, + -0x1.14ccb8bdbf114p-6, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, + -0x1.3ad06011469fbp-6, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, + -0x1.633f89e9a1a66p-6, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, + -0x1.8e18a73634ee7p-6, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, + -0x1.bb5a11138a4c9p-6, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, + -0x1.eb0208db9e51bp-6, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, + -0x1.0e875c1b8c3dap-5, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, + -0x1.28bf1897b69ccp-5, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, + -0x1.44273720f48bcp-5, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, + -0x1.60bea939d225ap-5, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, + -0x1.7e8454b32ef34p-5, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, + -0x1.9d7713b71eee1p-5, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, + -0x1.bd95b4d43e819p-5, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, + -0x1.dedefb09791b4p-5, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, + -0x1.00a8cee920eabp-4, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, + -0x1.127624999ee1dp-4, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, + -0x1.24d6cee3afb2ap-4, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, + -0x1.37ca1866b95cfp-4, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, + -0x1.4b4f461b0cbaap-4, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, + -0x1.5f6597591b633p-4, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, + -0x1.740c45e0e512p-4, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, + -0x1.894285e19c468p-4, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, + -0x1.9f07860181d1ep-4, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, + -0x1.b55a6f65f7058p-4, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, + -0x1.cc3a65bbc6327p-4, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, + -0x1.e3a6873fa1279p-4, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, + -0x1.fb9decc6d55b8p-4, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, + -0x1.0a0fd4e41ab5ap-3, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, + -0x1.169566329bcb7p-3, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, + -0x1.235f2eb9a470ap-3, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, + -0x1.306cb042aa3bap-3, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, + -0x1.3dbd69fabf802p-3, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, + -0x1.4b50d8778abbdp-3, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, + -0x1.592675bc57974p-3, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, + -0x1.673db93f41479p-3, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, + -0x1.759617ee761f9p-3, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, + -0x1.842f0435941afp-3, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, + -0x1.9307ee031e2fdp-3, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, + -0x1.a22042ce0a2f9p-3, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, + -0x1.b1776d9b67013p-3, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, + -0x1.c10cd7041afccp-3, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, + -0x1.d0dfe53aba2fdp-3, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, + -0x1.e0effc1174505p-3, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, + -0x1.f13c7d001a249p-3, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, + -0x1.00e263951d11fp-2, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, + -0x1.09441bb2aa0a2p-2, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, + -0x1.11c3141f91b3ep-2, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, + -0x1.1a5ef902000d3p-2, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, + -0x1.23177562aaea3p-2, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, + -0x1.2bec333018867p-2, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, + -0x1.34dcdb41f0f85p-2, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, + -0x1.3de9155c5a642p-2, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, + -0x1.471088335fce7p-2, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, + -0x1.5052d96e626c1p-2, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, + -0x1.59afadab954d4p-2, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, + -0x1.6326a8838342ep-2, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, + -0x1.6cb76c8c9ed8fp-2, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, + -0x1.76619b5edc454p-2, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, + -0x1.8024d59755257p-2, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, + -0x1.8a00badbf5e8ep-2, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, + -0x1.93f4e9df34c1bp-2, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, + -0x1.9e010063d1f96p-2, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, + -0x1.a8249b40a182cp-2, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, + -0x1.b25f56645da43p-2, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, + -0x1.bcb0ccd98294fp-2, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, + -0x1.c71898ca32e6fp-2, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, + -0x1.d19653842496fp-2, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, + -0x1.dc29957c969bbp-2, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, + -0x1.e6d1f6544ece3p-2, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, + -0x1.f18f0cdba0025p-2, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, + -0x1.fc606f1678292p-2, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, + -0x1.d16c901d95181p-8, 0x1p-1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, + -0x1.23e6ad10872a7p-6, 0x1p-1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, + -0x1.d4a2c7f909c4ep-6, 0x1p-1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, + -0x1.4344523c8e3b5p-5, 0x1p-1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, + -0x1.9cc8b3671dd0fp-5, 0x1p-1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, + -0x1.f6db13ff708cbp-5, 0x1p-1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, + -0x1.28bbfd87a8cffp-4, 0x1p-1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, + -0x1.564df524b00dap-4, 0x1p-1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, + -0x1.8421af15c49d7p-4, 0x1p-1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, + -0x1.b2356710db0a3p-4, 0x1p-1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, + -0x1.e087565455a75p-4, 0x1p-1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, + -0x1.078ad9dc46632p-3, 0x1p-1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, + -0x1.1eef59e0b74c3p-3, 0x1p-1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, + -0x1.367044581b074p-3, 0x1p-1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, + -0x1.4e0cb14a9c046p-3, 0x1p-1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, + -0x1.65c3b7b0e312cp-3, 0x1p-1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, + -0x1.7d946d7d133fdp-3, 0x1p-1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, + -0x1.957de7a3cfd5dp-3, 0x1p-1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, + -0x1.ad7f3a254c1f5p-3, 0x1p-1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, + -0x1.c597781664984p-3, 0x1p-1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, + -0x1.ddc5b3a9c1311p-3, 0x1p-1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, + -0x1.f608fe39004a4p-3, 0x1p-1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, + -0x1.cc0d09bd41caap-8, 0x1p-2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, + -0x1.36580d5d5e775p-6, 0x1p-2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, + -0x1.fa3ecac0d84e8p-6, 0x1p-2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, + -0x1.5f57f693feebep-5, 0x1p-2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, + -0x1.c1d1f0e5967d5p-5, 0x1p-2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, + -0x1.1244c435e819dp-4, 0x1p-2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, + -0x1.43bd776e98073p-4, 0x1p-2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, + -0x1.755129dad834cp-4, 0x1p-2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, + -0x1.a6fdf22e33d8cp-4, 0x1p-2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, + -0x1.d8c1e624a1513p-4, 0x1p-2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, + -0x1.536352ad19e39p-9, 0x1p-3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, + -0x1.e43d1c309e958p-7, 0x1p-3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, + -0x1.ba1650f592f5p-6, 0x1p-3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, + -0x1.4125feacab7cep-5, 0x1p-3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, + -0x1.a55beda63cc14p-5, 0x1p-3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, + -0x1.35230c0fbe402p-10, 0x1p-4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, + -0x1.b82683bc89fbp-7, 0x1p-4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, + -0x1.a4f3514d75466p-6, 0x1p-4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, + -0x1.b7aa821726608p-8, 0x1p-5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, + -0x1.b78b80c84e1eep-9, 0x1p-6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, +}; + +} // namespace npsr::trig::data + +#endif // NPSR_TRIG_DATA_APPROX_H diff --git a/npsr/trig/data/approx.h.sol b/npsr/trig/data/approx.h.sol new file mode 100644 index 0000000..86693e1 --- /dev/null +++ b/npsr/trig/data/approx.h.sol @@ -0,0 +1,52 @@ +suppressmessage(186, 185, 184); + +procedure ApproxLut4_(pT, pFunc, pFuncDriv) { + var r, i, $; + + $.num_lut = match pT.kSize + with 64: (2^9) + default: (2^8); + + $.low_round = match pT.kSize + with 64: ([|24, RZ|]) + default: ([|pT.kDigits, RN|]); + $.scale = 2.0 * pi / $.num_lut; + + r = [||]; + for i from 0 to $.num_lut - 1 do { + $.angle = i * $.scale; + $.exact = pFunc($.angle); + $.high = pT.kRound($.exact); + $.low = pT.kRound(round($.exact - $.high, $.low_round[0], $.low_round[1])); + + $.deriv_exact = pFuncDriv($.angle); + $.k = ceil(log2(abs($.deriv_exact))); + if ($.deriv_exact < 0) then $.k = -$.k; + + $.sigma = 2.0^$.k; + $.deriv = pT.kRound($.deriv_exact - $.sigma); + r = r @ [|$.deriv, $.sigma, $.high, $.low|]; + }; + return ToStringCArray(r, pT.kCSFX, 4); +}; + +Append( + "template constexpr char kSinApproxTable[] = {};", + "template <> constexpr float kSinApproxTable[] = ", + ApproxLut4_(Float32, sin(x), cos(x)), + "", + "template <> constexpr double kSinApproxTable[] = ", + ApproxLut4_(Float64, sin(x), cos(x)), + "" +); +Append( + "template constexpr char kCosApproxTable[] = {};", + "template <> constexpr float kCosApproxTable[] = ", + ApproxLut4_(Float32, cos(x), -sin(x)), + "", + "template <> constexpr double kCosApproxTable[] = ", + ApproxLut4_(Float64, cos(x), -sin(x)), + "" +); + +WriteCPPHeader("npsr::trig::data"); diff --git a/npsr/trig/data/constants.h b/npsr/trig/data/constants.h new file mode 100644 index 0000000..7161a0e --- /dev/null +++ b/npsr/trig/data/constants.h @@ -0,0 +1,57 @@ +// Auto-generated by npsr/trig/data/constants.h.sol +// Use `spin generate -f` to force regeneration +#ifndef NPSR_TRIG_DATA_CONSTANTS_H +#define NPSR_TRIG_DATA_CONSTANTS_H + +namespace npsr::trig::data { +template constexpr char kPi[] = {}; +template <> constexpr float kPi[] = { + 0x1.921fb6p1f, -0x1.777a5cp-24f, -0x1.ee59dap-49f, +}; +template <> constexpr float kPi[] = { + 0x1.92p1f, 0x1.fb4p-11f, 0x1.444p-23f, 0x1.68c234p-38f, +}; +template <> constexpr double kPi[] = { + 0x1.921fb54442d18p1, 0x1.1a62633145c06p-53, 0x1.c1cd129024e09p-106, +}; +template <> constexpr double kPi[] = { + 0x1.921fb6p1, -0x1.777a5cp-24, -0x1.ee59dap-49, 0x1.98a2e03707345p-76, +}; + +template constexpr double kPiPrec35[] = { + 0x1.921fb5444p1, 0x1.68c234c4c6628p-38, +}; +template <> constexpr double kPiPrec35[] = { + 0x1.921fb6p1, -0x1.777a5cp-24, -0x1.ee59dap-49, +}; + +template constexpr char kPiMul2[] = {}; +template <> constexpr float kPiMul2[] = { + 0x1.921fb6p2f, -0x1.777a5cp-23f, +}; +template <> constexpr double kPiMul2[] = { + 0x1.921fb54442d18p2, 0x1.1a62633145c07p-52, +}; + +template constexpr double kPiDiv16Prec29[] = { + 0x1.921fb54442d18p-3, 0x1.1a62633p-57, 0x1.45c06e0e68948p-89, +}; +template <> constexpr double kPiDiv16Prec29[] = { + 0x1.921fb54p-3, 0x1.a626331p-61, 0x1.1701b839a252p-91, 0x1.10b461p-33, +}; + +template constexpr char kInvPi = '_'; +template <> constexpr float kInvPi = 0x1.45f306p-2f; +template <> constexpr double kInvPi = 0x1.45f306dc9c883p-2; + +template constexpr char kHalfPi = '_'; +template <> constexpr float kHalfPi = 0x1.921fb6p0f; +template <> constexpr double kHalfPi = 0x1.921fb54442d18p0; + +template constexpr char k16DivPi = '_'; +template <> constexpr float k16DivPi = 0x1.45f306p2f; +template <> constexpr double k16DivPi = 0x1.45f306dc9c883p2; + +} // namespace npsr::trig::data + +#endif // NPSR_TRIG_DATA_CONSTANTS_H diff --git a/npsr/trig/data/constants.h.sol b/npsr/trig/data/constants.h.sol new file mode 100644 index 0000000..da78375 --- /dev/null +++ b/npsr/trig/data/constants.h.sol @@ -0,0 +1,87 @@ +procedure ConstantsToArrayF32_(pArgs = ...) { + return ToStringCArray(ConstantsFromArray(pArgs), "f", 4); +}; +procedure ConstantsToArrayF64_(pArgs = ...) { + return ToStringCArray(ConstantsFromArray(pArgs), "", 4); +}; + +Append( + "template constexpr char kPi[] = {};", + + "template <> constexpr float kPi[] = " @ + ConstantsToArrayF32_(pi, [|RN, 24, 24, 24|]), + "template <> constexpr float kPi[] = " @ + ConstantsToArrayF32_(pi, [|RD, 11, 11, 11|], [|RN, 24|]), // no FMA + + + "template <> constexpr double kPi[] = " @ + ConstantsToArrayF64_(pi, [|RN, 53|], [|RD, 53|], [|RU, 53|]), + "template <> constexpr double kPi[] = " @ + ConstantsToArrayF64_(pi, [|RN, 24, 24, 24|], [|RN, 53|]), // no FMA + + "" +); + +Append( + "template constexpr double kPiPrec35[] = " @ + ConstantsToArrayF64_(pi, [|RN, 35|], [|RD, 53|]), + "template <> constexpr double kPiPrec35[] = " @ + ConstantsToArrayF64_(pi, [|RN, 24, 24, 24|]), + "" +); + +Append( + "template constexpr char kPiMul2[] = {};", + + "template <> constexpr float kPiMul2[] = " @ + ConstantsToArrayF32_(pi*2, [|RN, 24, 24|]), + "template <> constexpr double kPiMul2[] = " @ + ConstantsToArrayF64_(pi*2, [|RN, 53, 53|]), + "" +); + +vNFma = Constants(pi/16, [|RN, 27, 27|], [|RN, 29|], [|RN, 53|]); +Append( + "template constexpr double kPiDiv16Prec29[] = " @ + ConstantsToArrayF64_(pi/16, [|RN, 53|], [|RN, 29|], [|RN, 53|]), + "template <> constexpr double kPiDiv16Prec29[] = " @ + ToStringCArray([|vNFma[0], vNFma[2], vNFma[3], vNFma[1]|], "", 4), + "" +); + +Append( + "template constexpr char kInvPi = '_';", + "template <> constexpr float kInvPi = " @ + single(1/pi) @ "f;", + + "template <> constexpr double kInvPi = " @ + double(1/pi) @ ";", + "" +); + +Append( + "template constexpr char kHalfPi = '_';", + + "template <> constexpr float kHalfPi = " @ + single(pi/2) @ "f;", + + "template <> constexpr double kHalfPi = " @ + double(pi/2) @ ";", + "" +); + +Append( + "template constexpr char k16DivPi = '_';", + + "template <> constexpr float k16DivPi = " @ + single(16/pi) @ "f;", + + "template <> constexpr double k16DivPi = " @ + double(16/pi) @ ";", + "" +); + +// Dump(); + +WriteCPPHeader("npsr::trig::data"); + diff --git a/npsr/trig/data/data.h b/npsr/trig/data/data.h new file mode 100644 index 0000000..658dd51 --- /dev/null +++ b/npsr/trig/data/data.h @@ -0,0 +1,11 @@ +// Auto-generated by npsr/trig/data/data.h.sol +// Use `spin generate -f` to force regeneration +#ifndef NPSR_TRIG_DATA_DATA_H +#define NPSR_TRIG_DATA_DATA_H + +#include "npsr/trig/data/constants.h" +#include "npsr/trig/data/high.h" +#include "npsr/trig/data/approx.h" +#include "npsr/trig/data/reduction.h" + +#endif // NPSR_TRIG_DATA_DATA_H diff --git a/npsr/trig/data/data.h.sol b/npsr/trig/data/data.h.sol new file mode 100644 index 0000000..3c393fc --- /dev/null +++ b/npsr/trig/data/data.h.sol @@ -0,0 +1,10 @@ +var header; +for header in [|"constants", "high", "approx", "reduction"|] do { + Append( + "#include \"npsr/trig/data/" @ header @ ".h\"" + ); +}; + +WriteCPPHeader(); + + diff --git a/npsr/trig/data/high.h b/npsr/trig/data/high.h new file mode 100644 index 0000000..211a908 --- /dev/null +++ b/npsr/trig/data/high.h @@ -0,0 +1,54 @@ +// Auto-generated by npsr/trig/data/high.h.sol +// Use `spin generate -f` to force regeneration +#ifndef NPSR_TRIG_DATA_HIGH_H +#define NPSR_TRIG_DATA_HIGH_H + +namespace npsr::trig::data { +constexpr double kHiSinKPi16Table[] = { + 0, + 0x1.8f8b83c69a60bp-3, + 0x1.87de2a6aea963p-2, + 0x1.1c73b39ae68c8p-1, + 0x1.6a09e667f3bcdp-1, + 0x1.a9b66290ea1a3p-1, + 0x1.d906bcf328d46p-1, + 0x1.f6297cff75cbp-1, + 0x1p0, + 0x1.f6297cff75cbp-1, + 0x1.d906bcf328d46p-1, + 0x1.a9b66290ea1a3p-1, + 0x1.6a09e667f3bcdp-1, + 0x1.1c73b39ae68c8p-1, + 0x1.87de2a6aea963p-2, + 0x1.8f8b83c69a60bp-3, +}; + +constexpr double kHiCosKPi16Table[] = { + 0x1p0, + 0x1.f6297cff75cbp-1, + 0x1.d906bcf328d46p-1, + 0x1.a9b66290ea1a3p-1, + 0x1.6a09e667f3bcdp-1, + 0x1.1c73b39ae68c8p-1, + 0x1.87de2a6aea963p-2, + 0x1.8f8b83c69a60bp-3, + 0, + -0x1.8f8b83c69a60bp-3, + -0x1.87de2a6aea963p-2, + -0x1.1c73b39ae68c8p-1, + -0x1.6a09e667f3bcdp-1, + -0x1.a9b66290ea1a3p-1, + -0x1.d906bcf328d46p-1, + -0x1.f6297cff75cbp-1, +}; + +constexpr double kPackedLowSinCosKPi16Table[] = { + 0, 0x1.56217bc626d19p-56, 0x1.457e6bc672cedp-56, 0x1.9f6303c8b25ddp-60, + -0x1.bdd34bc8bdd34p-55, 0x1.b25dd3c39f63p-55, -0x1.72ced3c7457e6p-57, -0x1.26d193c756217p-57, + 0, 0x1.26d193c756217p-57, 0x1.72ced3c7457e6p-57, -0x1.b25dd3c39f63p-55, + 0x1.bdd34bc8bdd34p-55, -0x1.9f6303c8b25ddp-60, -0x1.457e6bc672cedp-56, -0x1.56217bc626d19p-56, +}; + +} // namespace npsr::trig::data + +#endif // NPSR_TRIG_DATA_HIGH_H diff --git a/npsr/trig/data/high.h.sol b/npsr/trig/data/high.h.sol new file mode 100644 index 0000000..d29151a --- /dev/null +++ b/npsr/trig/data/high.h.sol @@ -0,0 +1,54 @@ +procedure PiDivTable_(pT, pFunc, pBy) { + var r, i, pi_by; + pi_by = pi / pBy; + r = [||]; + for i from 0 to pBy - 1 do { + r = r :. pT.kRound(pFunc(i * pi_by)); + }; + return ToStringCArray(r, pT.kCSFX, 1); +}; + +procedure PiDivPackLowTable_(pT, pFunc0, pFunc1, pBy) { + var r, i, digits, $; + $.pi_by = pi / pBy; + r = [||]; + for i from 0 to pBy - 1 do { + $.hi0 = pT.kRound(pFunc0(i * $.pi_by)); + $.hi1 = pT.kRound(pFunc1(i * $.pi_by)); + $.hi0_low = pT.kRound(pFunc0(i * $.pi_by) - $.hi0); + $.hi1_low = pT.kRound(pFunc1(i * $.pi_by) - $.hi1); + r = r @ [|$.hi0_low, $.hi1_low|]; + }; + digits = ToDigits(pT, r); + $.half_size = pT.kSize / 2; + $.lower_bits = 2^$.half_size; + r = [||]; + for i from 0 to length(digits) - 1 by 2 do { + $.hi0 = digits[i]; + $.hi1 = digits[i + 1]; + // F64: (hi1 & 0xFFFFFFFF00000000) | ((hi0 >> 32) & 0xFFFFFFFF) + $.pack = mod(RightShift($.hi0, $.half_size), $.lower_bits); + $.pack = $.pack + $.hi1 - mod($.hi1, $.lower_bits); + r = r :. $.pack; + }; + r = FromDigits(pT, r); + return ToStringCArray(r, "", 4); +}; + +Append( + "constexpr double kHiSinKPi16Table[] = " @ + PiDivTable_(Float64, sin(x), 16), + "", + "constexpr double kHiCosKPi16Table[] = " @ + PiDivTable_(Float64, cos(x), 16), + "" +); + +Append( + "constexpr double kPackedLowSinCosKPi16Table[] = " @ + PiDivPackLowTable_(Float64, sin(x), cos(x), 16), + "" +); + +// Dump(); +WriteCPPHeader("npsr::trig::data"); diff --git a/npsr/trig/data/large-aprox.h b/npsr/trig/data/large-aprox.h deleted file mode 100644 index eab5a45..0000000 --- a/npsr/trig/data/large-aprox.h +++ /dev/null @@ -1,1553 +0,0 @@ -// Do not edit this file, it is generated by npsr/trig/data/large-aprox.h.py -// use `spin generate -f` to force regeneration -#ifndef NPSR_TRIG_DATA_LARGE_APROX_H_PY -#define NPSR_TRIG_DATA_LARGE_APROX_H_PY -namespace npsr::trig::data { namespace { -template constexpr T kSinApproxTable[] = {}; -template constexpr T kCosApproxTable[] = {}; -template <> constexpr float kSinApproxTable[] = { - 0.0f, 0x1p0f, 0.0f, 0.0f, - -0x1.3bcfbep-12f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, - -0x1.3bc39p-10f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, - -0x1.63253p-9f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, - -0x1.3b92e2p-8f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, - -0x1.ecdc78p-8f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, - -0x1.62aa04p-7f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, - -0x1.e26c16p-7f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, - -0x1.3ad06p-6f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, - -0x1.8e18a8p-6f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, - -0x1.eb0208p-6f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, - -0x1.28bf18p-5f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, - -0x1.60beaap-5f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, - -0x1.9d7714p-5f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, - -0x1.dedefcp-5f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, - -0x1.127624p-4f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, - -0x1.37ca18p-4f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, - -0x1.5f6598p-4f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, - -0x1.894286p-4f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, - -0x1.b55a7p-4f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, - -0x1.e3a688p-4f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, - -0x1.0a0fd4p-3f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, - -0x1.235f2ep-3f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, - -0x1.3dbd6ap-3f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, - -0x1.592676p-3f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, - -0x1.759618p-3f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, - -0x1.9307eep-3f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, - -0x1.b1776ep-3f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, - -0x1.d0dfe6p-3f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, - -0x1.f13c7ep-3f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, - -0x1.09441cp-2f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, - -0x1.1a5efap-2f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, - -0x1.2bec34p-2f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, - -0x1.3de916p-2f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, - -0x1.5052dap-2f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, - -0x1.6326a8p-2f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, - -0x1.76619cp-2f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, - -0x1.8a00bap-2f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, - -0x1.9e01p-2f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, - -0x1.b25f56p-2f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, - -0x1.c71898p-2f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, - -0x1.dc2996p-2f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, - -0x1.f18f0cp-2f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, - -0x1.d16c9p-8f, 0x1p-1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, - -0x1.d4a2c8p-6f, 0x1p-1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, - -0x1.9cc8b4p-5f, 0x1p-1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, - -0x1.28bbfep-4f, 0x1p-1f, 0x1.ced7bp-1f, -0x1.786712p-26f, - -0x1.8421bp-4f, 0x1p-1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, - -0x1.e08756p-4f, 0x1p-1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, - -0x1.1eef5ap-3f, 0x1p-1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, - -0x1.4e0cb2p-3f, 0x1p-1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, - -0x1.7d946ep-3f, 0x1p-1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, - -0x1.ad7f3ap-3f, 0x1p-1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, - -0x1.ddc5b4p-3f, 0x1p-1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, - -0x1.cc0d0ap-8f, 0x1p-2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, - -0x1.fa3ecap-6f, 0x1p-2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, - -0x1.c1d1fp-5f, 0x1p-2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, - -0x1.43bd78p-4f, 0x1p-2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, - -0x1.a6fdf2p-4f, 0x1p-2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, - -0x1.536352p-9f, 0x1p-3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, - -0x1.ba165p-6f, 0x1p-3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, - -0x1.a55beep-5f, 0x1p-3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, - -0x1.b82684p-7f, 0x1p-4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, - -0x1.b7aa82p-8f, 0x1p-5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, - 0.0f, 0.0f, 0x1p0f, 0.0f, - -0x1.003242p5f, 0x1p5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, - -0x1.00c8fcp4f, 0x1p4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, - -0x1.025aa4p3f, 0x1p3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, - -0x1.0322f4p3f, 0x1p3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, - -0x1.03eacap3f, 0x1p3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, - -0x1.096408p2f, 0x1p2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, - -0x1.0af10ap2f, 0x1p2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, - -0x1.0c7c5cp2f, 0x1p2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, - -0x1.0e05c2p2f, 0x1p2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, - -0x1.0f8cfcp2f, 0x1p2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, - -0x1.2223a4p1f, 0x1p1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, - -0x1.25280cp1f, 0x1p1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, - -0x1.2826bap1f, 0x1p1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, - -0x1.2b1f34p1f, 0x1p1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, - -0x1.2e110ap1f, 0x1p1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, - -0x1.30fbc6p1f, 0x1p1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, - -0x1.33def2p1f, 0x1p1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, - -0x1.36ba2p1f, 0x1p1f, 0x1.ced7bp-1f, -0x1.786712p-26f, - -0x1.398cdep1f, 0x1p1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, - -0x1.3c56bap1f, 0x1p1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, - -0x1.3f174ap1f, 0x1p1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, - -0x1.839c3cp0f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, - -0x1.88f59ap0f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, - -0x1.8e39dap0f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, - -0x1.93682ap0f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, - -0x1.987fcp0f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, - -0x1.9d7fd2p0f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, - -0x1.a2679ap0f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, - -0x1.a73656p0f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, - -0x1.abeb4ap0f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, - -0x1.b085bap0f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, - -0x1.b504f4p0f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, - -0x1.b96842p0f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, - -0x1.bdaefap0f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, - -0x1.c1d87p0f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, - -0x1.c5e404p0f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, - -0x1.c9d112p0f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, - -0x1.cd9f02p0f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, - -0x1.d14d3ep0f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, - -0x1.d4db32p0f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, - -0x1.d84852p0f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, - -0x1.db941ap0f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, - -0x1.debe06p0f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, - -0x1.e1c598p0f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, - -0x1.e4aa5ap0f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, - -0x1.e76bd8p0f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, - -0x1.ea09a6p0f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, - -0x1.ec835ep0f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, - -0x1.eed89ep0f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, - -0x1.f10908p0f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, - -0x1.f31448p0f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, - -0x1.f4fa0ap0f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, - -0x1.f6ba08p0f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, - -0x1.f853f8p0f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, - -0x1.f9c79ep0f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, - -0x1.fb14bep0f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, - -0x1.fc3b28p0f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, - -0x1.fd3aacp0f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, - -0x1.fe1324p0f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, - -0x1.fec46ep0f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, - -0x1.ff4e6ep0f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, - -0x1.ffb11p0f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, - -0x1.ffec44p0f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, - -0x1p1f, 0x1p0f, 0.0f, 0.0f, - -0x1.ffec44p0f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, - -0x1.ffb11p0f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, - -0x1.ff4e6ep0f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, - -0x1.fec46ep0f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, - -0x1.fe1324p0f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, - -0x1.fd3aacp0f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, - -0x1.fc3b28p0f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, - -0x1.fb14bep0f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, - -0x1.f9c79ep0f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, - -0x1.f853f8p0f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, - -0x1.f6ba08p0f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, - -0x1.f4fa0ap0f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, - -0x1.f31448p0f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, - -0x1.f10908p0f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, - -0x1.eed89ep0f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, - -0x1.ec835ep0f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, - -0x1.ea09a6p0f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, - -0x1.e76bd8p0f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, - -0x1.e4aa5ap0f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, - -0x1.e1c598p0f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, - -0x1.debe06p0f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, - -0x1.db941ap0f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, - -0x1.d84852p0f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, - -0x1.d4db32p0f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, - -0x1.d14d3ep0f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, - -0x1.cd9f02p0f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, - -0x1.c9d112p0f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, - -0x1.c5e404p0f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, - -0x1.c1d87p0f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, - -0x1.bdaefap0f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, - -0x1.b96842p0f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, - -0x1.b504f4p0f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, - -0x1.b085bap0f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, - -0x1.abeb4ap0f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, - -0x1.a73656p0f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, - -0x1.a2679ap0f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, - -0x1.9d7fd2p0f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, - -0x1.987fcp0f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, - -0x1.93682ap0f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, - -0x1.8e39dap0f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, - -0x1.88f59ap0f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, - -0x1.839c3cp0f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, - -0x1.3f174ap1f, 0x1p1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, - -0x1.3c56bap1f, 0x1p1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, - -0x1.398cdep1f, 0x1p1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, - -0x1.36ba2p1f, 0x1p1f, -0x1.ced7bp-1f, 0x1.786712p-26f, - -0x1.33def2p1f, 0x1p1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, - -0x1.30fbc6p1f, 0x1p1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, - -0x1.2e110ap1f, 0x1p1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, - -0x1.2b1f34p1f, 0x1p1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, - -0x1.2826bap1f, 0x1p1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, - -0x1.25280cp1f, 0x1p1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, - -0x1.2223a4p1f, 0x1p1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, - -0x1.0f8cfcp2f, 0x1p2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, - -0x1.0e05c2p2f, 0x1p2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, - -0x1.0c7c5cp2f, 0x1p2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, - -0x1.0af10ap2f, 0x1p2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, - -0x1.096408p2f, 0x1p2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, - -0x1.03eacap3f, 0x1p3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, - -0x1.0322f4p3f, 0x1p3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, - -0x1.025aa4p3f, 0x1p3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, - -0x1.00c8fcp4f, 0x1p4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, - -0x1.003242p5f, 0x1p5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, - 0.0f, 0.0f, -0x1p0f, 0.0f, - -0x1.b7aa82p-8f, 0x1p-5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, - -0x1.b82684p-7f, 0x1p-4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, - -0x1.a55beep-5f, 0x1p-3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, - -0x1.ba165p-6f, 0x1p-3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, - -0x1.536352p-9f, 0x1p-3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, - -0x1.a6fdf2p-4f, 0x1p-2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, - -0x1.43bd78p-4f, 0x1p-2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, - -0x1.c1d1fp-5f, 0x1p-2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, - -0x1.fa3ecap-6f, 0x1p-2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, - -0x1.cc0d0ap-8f, 0x1p-2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, - -0x1.ddc5b4p-3f, 0x1p-1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, - -0x1.ad7f3ap-3f, 0x1p-1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, - -0x1.7d946ep-3f, 0x1p-1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, - -0x1.4e0cb2p-3f, 0x1p-1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, - -0x1.1eef5ap-3f, 0x1p-1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, - -0x1.e08756p-4f, 0x1p-1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, - -0x1.8421bp-4f, 0x1p-1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, - -0x1.28bbfep-4f, 0x1p-1f, -0x1.ced7bp-1f, 0x1.786712p-26f, - -0x1.9cc8b4p-5f, 0x1p-1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, - -0x1.d4a2c8p-6f, 0x1p-1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, - -0x1.d16c9p-8f, 0x1p-1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, - -0x1.f18f0cp-2f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, - -0x1.dc2996p-2f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, - -0x1.c71898p-2f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, - -0x1.b25f56p-2f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, - -0x1.9e01p-2f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, - -0x1.8a00bap-2f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, - -0x1.76619cp-2f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, - -0x1.6326a8p-2f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, - -0x1.5052dap-2f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, - -0x1.3de916p-2f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, - -0x1.2bec34p-2f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, - -0x1.1a5efap-2f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, - -0x1.09441cp-2f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, - -0x1.f13c7ep-3f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, - -0x1.d0dfe6p-3f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, - -0x1.b1776ep-3f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, - -0x1.9307eep-3f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, - -0x1.759618p-3f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, - -0x1.592676p-3f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, - -0x1.3dbd6ap-3f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, - -0x1.235f2ep-3f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, - -0x1.0a0fd4p-3f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, - -0x1.e3a688p-4f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, - -0x1.b55a7p-4f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, - -0x1.894286p-4f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, - -0x1.5f6598p-4f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, - -0x1.37ca18p-4f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, - -0x1.127624p-4f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, - -0x1.dedefcp-5f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, - -0x1.9d7714p-5f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, - -0x1.60beaap-5f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, - -0x1.28bf18p-5f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, - -0x1.eb0208p-6f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, - -0x1.8e18a8p-6f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, - -0x1.3ad06p-6f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, - -0x1.e26c16p-7f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, - -0x1.62aa04p-7f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, - -0x1.ecdc78p-8f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, - -0x1.3b92e2p-8f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, - -0x1.63253p-9f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, - -0x1.3bc39p-10f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, - -0x1.3bcfbep-12f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, -}; -template <> constexpr float kCosApproxTable[] = { - 0.0f, 0.0f, 0x1p0f, 0.0f, - -0x1.003242p5f, 0x1p5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, - -0x1.00c8fcp4f, 0x1p4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, - -0x1.025aa4p3f, 0x1p3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, - -0x1.0322f4p3f, 0x1p3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, - -0x1.03eacap3f, 0x1p3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, - -0x1.096408p2f, 0x1p2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, - -0x1.0af10ap2f, 0x1p2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, - -0x1.0c7c5cp2f, 0x1p2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, - -0x1.0e05c2p2f, 0x1p2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, - -0x1.0f8cfcp2f, 0x1p2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, - -0x1.2223a4p1f, 0x1p1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, - -0x1.25280cp1f, 0x1p1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, - -0x1.2826bap1f, 0x1p1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, - -0x1.2b1f34p1f, 0x1p1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, - -0x1.2e110ap1f, 0x1p1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, - -0x1.30fbc6p1f, 0x1p1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, - -0x1.33def2p1f, 0x1p1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, - -0x1.36ba2p1f, 0x1p1f, 0x1.ced7bp-1f, -0x1.786712p-26f, - -0x1.398cdep1f, 0x1p1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, - -0x1.3c56bap1f, 0x1p1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, - -0x1.3f174ap1f, 0x1p1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, - -0x1.839c3cp0f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, - -0x1.88f59ap0f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, - -0x1.8e39dap0f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, - -0x1.93682ap0f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, - -0x1.987fcp0f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, - -0x1.9d7fd2p0f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, - -0x1.a2679ap0f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, - -0x1.a73656p0f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, - -0x1.abeb4ap0f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, - -0x1.b085bap0f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, - -0x1.b504f4p0f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, - -0x1.b96842p0f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, - -0x1.bdaefap0f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, - -0x1.c1d87p0f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, - -0x1.c5e404p0f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, - -0x1.c9d112p0f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, - -0x1.cd9f02p0f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, - -0x1.d14d3ep0f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, - -0x1.d4db32p0f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, - -0x1.d84852p0f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, - -0x1.db941ap0f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, - -0x1.debe06p0f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, - -0x1.e1c598p0f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, - -0x1.e4aa5ap0f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, - -0x1.e76bd8p0f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, - -0x1.ea09a6p0f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, - -0x1.ec835ep0f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, - -0x1.eed89ep0f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, - -0x1.f10908p0f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, - -0x1.f31448p0f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, - -0x1.f4fa0ap0f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, - -0x1.f6ba08p0f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, - -0x1.f853f8p0f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, - -0x1.f9c79ep0f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, - -0x1.fb14bep0f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, - -0x1.fc3b28p0f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, - -0x1.fd3aacp0f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, - -0x1.fe1324p0f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, - -0x1.fec46ep0f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, - -0x1.ff4e6ep0f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, - -0x1.ffb11p0f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, - -0x1.ffec44p0f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, - -0x1p1f, 0x1p0f, 0.0f, 0.0f, - -0x1.ffec44p0f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, - -0x1.ffb11p0f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, - -0x1.ff4e6ep0f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, - -0x1.fec46ep0f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, - -0x1.fe1324p0f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, - -0x1.fd3aacp0f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, - -0x1.fc3b28p0f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, - -0x1.fb14bep0f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, - -0x1.f9c79ep0f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, - -0x1.f853f8p0f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, - -0x1.f6ba08p0f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, - -0x1.f4fa0ap0f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, - -0x1.f31448p0f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, - -0x1.f10908p0f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, - -0x1.eed89ep0f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, - -0x1.ec835ep0f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, - -0x1.ea09a6p0f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, - -0x1.e76bd8p0f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, - -0x1.e4aa5ap0f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, - -0x1.e1c598p0f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, - -0x1.debe06p0f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, - -0x1.db941ap0f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, - -0x1.d84852p0f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, - -0x1.d4db32p0f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, - -0x1.d14d3ep0f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, - -0x1.cd9f02p0f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, - -0x1.c9d112p0f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, - -0x1.c5e404p0f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, - -0x1.c1d87p0f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, - -0x1.bdaefap0f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, - -0x1.b96842p0f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, - -0x1.b504f4p0f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, - -0x1.b085bap0f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, - -0x1.abeb4ap0f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, - -0x1.a73656p0f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, - -0x1.a2679ap0f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, - -0x1.9d7fd2p0f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, - -0x1.987fcp0f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, - -0x1.93682ap0f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, - -0x1.8e39dap0f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, - -0x1.88f59ap0f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, - -0x1.839c3cp0f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, - -0x1.3f174ap1f, 0x1p1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, - -0x1.3c56bap1f, 0x1p1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, - -0x1.398cdep1f, 0x1p1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, - -0x1.36ba2p1f, 0x1p1f, -0x1.ced7bp-1f, 0x1.786712p-26f, - -0x1.33def2p1f, 0x1p1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, - -0x1.30fbc6p1f, 0x1p1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, - -0x1.2e110ap1f, 0x1p1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, - -0x1.2b1f34p1f, 0x1p1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, - -0x1.2826bap1f, 0x1p1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, - -0x1.25280cp1f, 0x1p1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, - -0x1.2223a4p1f, 0x1p1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, - -0x1.0f8cfcp2f, 0x1p2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, - -0x1.0e05c2p2f, 0x1p2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, - -0x1.0c7c5cp2f, 0x1p2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, - -0x1.0af10ap2f, 0x1p2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, - -0x1.096408p2f, 0x1p2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, - -0x1.03eacap3f, 0x1p3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, - -0x1.0322f4p3f, 0x1p3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, - -0x1.025aa4p3f, 0x1p3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, - -0x1.00c8fcp4f, 0x1p4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, - -0x1.003242p5f, 0x1p5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, - 0.0f, 0.0f, -0x1p0f, 0.0f, - -0x1.b7aa82p-8f, 0x1p-5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, - -0x1.b82684p-7f, 0x1p-4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, - -0x1.a55beep-5f, 0x1p-3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, - -0x1.ba165p-6f, 0x1p-3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, - -0x1.536352p-9f, 0x1p-3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, - -0x1.a6fdf2p-4f, 0x1p-2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, - -0x1.43bd78p-4f, 0x1p-2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, - -0x1.c1d1fp-5f, 0x1p-2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, - -0x1.fa3ecap-6f, 0x1p-2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, - -0x1.cc0d0ap-8f, 0x1p-2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, - -0x1.ddc5b4p-3f, 0x1p-1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, - -0x1.ad7f3ap-3f, 0x1p-1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, - -0x1.7d946ep-3f, 0x1p-1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, - -0x1.4e0cb2p-3f, 0x1p-1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, - -0x1.1eef5ap-3f, 0x1p-1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, - -0x1.e08756p-4f, 0x1p-1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, - -0x1.8421bp-4f, 0x1p-1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, - -0x1.28bbfep-4f, 0x1p-1f, -0x1.ced7bp-1f, 0x1.786712p-26f, - -0x1.9cc8b4p-5f, 0x1p-1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, - -0x1.d4a2c8p-6f, 0x1p-1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, - -0x1.d16c9p-8f, 0x1p-1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, - -0x1.f18f0cp-2f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, - -0x1.dc2996p-2f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, - -0x1.c71898p-2f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, - -0x1.b25f56p-2f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, - -0x1.9e01p-2f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, - -0x1.8a00bap-2f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, - -0x1.76619cp-2f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, - -0x1.6326a8p-2f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, - -0x1.5052dap-2f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, - -0x1.3de916p-2f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, - -0x1.2bec34p-2f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, - -0x1.1a5efap-2f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, - -0x1.09441cp-2f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, - -0x1.f13c7ep-3f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, - -0x1.d0dfe6p-3f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, - -0x1.b1776ep-3f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, - -0x1.9307eep-3f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, - -0x1.759618p-3f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, - -0x1.592676p-3f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, - -0x1.3dbd6ap-3f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, - -0x1.235f2ep-3f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, - -0x1.0a0fd4p-3f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, - -0x1.e3a688p-4f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, - -0x1.b55a7p-4f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, - -0x1.894286p-4f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, - -0x1.5f6598p-4f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, - -0x1.37ca18p-4f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, - -0x1.127624p-4f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, - -0x1.dedefcp-5f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, - -0x1.9d7714p-5f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, - -0x1.60beaap-5f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, - -0x1.28bf18p-5f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, - -0x1.eb0208p-6f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, - -0x1.8e18a8p-6f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, - -0x1.3ad06p-6f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, - -0x1.e26c16p-7f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, - -0x1.62aa04p-7f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, - -0x1.ecdc78p-8f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, - -0x1.3b92e2p-8f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, - -0x1.63253p-9f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, - -0x1.3bc39p-10f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, - -0x1.3bcfbep-12f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, - 0.0f, 0x1p0f, 0.0f, 0.0f, - -0x1.3bcfbep-12f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, - -0x1.3bc39p-10f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, - -0x1.63253p-9f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, - -0x1.3b92e2p-8f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, - -0x1.ecdc78p-8f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, - -0x1.62aa04p-7f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, - -0x1.e26c16p-7f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, - -0x1.3ad06p-6f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, - -0x1.8e18a8p-6f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, - -0x1.eb0208p-6f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, - -0x1.28bf18p-5f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, - -0x1.60beaap-5f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, - -0x1.9d7714p-5f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, - -0x1.dedefcp-5f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, - -0x1.127624p-4f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, - -0x1.37ca18p-4f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, - -0x1.5f6598p-4f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, - -0x1.894286p-4f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, - -0x1.b55a7p-4f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, - -0x1.e3a688p-4f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, - -0x1.0a0fd4p-3f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, - -0x1.235f2ep-3f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, - -0x1.3dbd6ap-3f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, - -0x1.592676p-3f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, - -0x1.759618p-3f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, - -0x1.9307eep-3f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, - -0x1.b1776ep-3f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, - -0x1.d0dfe6p-3f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, - -0x1.f13c7ep-3f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, - -0x1.09441cp-2f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, - -0x1.1a5efap-2f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, - -0x1.2bec34p-2f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, - -0x1.3de916p-2f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, - -0x1.5052dap-2f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, - -0x1.6326a8p-2f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, - -0x1.76619cp-2f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, - -0x1.8a00bap-2f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, - -0x1.9e01p-2f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, - -0x1.b25f56p-2f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, - -0x1.c71898p-2f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, - -0x1.dc2996p-2f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, - -0x1.f18f0cp-2f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, - -0x1.d16c9p-8f, 0x1p-1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, - -0x1.d4a2c8p-6f, 0x1p-1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, - -0x1.9cc8b4p-5f, 0x1p-1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, - -0x1.28bbfep-4f, 0x1p-1f, 0x1.ced7bp-1f, -0x1.786712p-26f, - -0x1.8421bp-4f, 0x1p-1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, - -0x1.e08756p-4f, 0x1p-1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, - -0x1.1eef5ap-3f, 0x1p-1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, - -0x1.4e0cb2p-3f, 0x1p-1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, - -0x1.7d946ep-3f, 0x1p-1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, - -0x1.ad7f3ap-3f, 0x1p-1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, - -0x1.ddc5b4p-3f, 0x1p-1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, - -0x1.cc0d0ap-8f, 0x1p-2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, - -0x1.fa3ecap-6f, 0x1p-2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, - -0x1.c1d1fp-5f, 0x1p-2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, - -0x1.43bd78p-4f, 0x1p-2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, - -0x1.a6fdf2p-4f, 0x1p-2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, - -0x1.536352p-9f, 0x1p-3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, - -0x1.ba165p-6f, 0x1p-3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, - -0x1.a55beep-5f, 0x1p-3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, - -0x1.b82684p-7f, 0x1p-4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, - -0x1.b7aa82p-8f, 0x1p-5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, -}; -template <> constexpr double kSinApproxTable[] = { - 0, 0x1p0, 0, 0, - -0x1.3bd2c8da49511p-14, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, - -0x1.3bcfbd9979a27p-12, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, - -0x1.6344004228d8bp-11, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, - -0x1.3bc390d250439p-10, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, - -0x1.ed534e31ca57fp-10, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, - -0x1.63252fe77c5ebp-9, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, - -0x1.e350342a4f6e6p-9, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, - -0x1.3b92e176d6d31p-8, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, - -0x1.8f501492cc296p-8, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, - -0x1.ecdc78f30165cp-8, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, - -0x1.2a1a39a8a2fb7p-7, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, - -0x1.62aa03dd6ba58p-7, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, - -0x1.a01b6cdbd995ep-7, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, - -0x1.e26c163ad15b3p-7, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, - -0x1.14ccb8bdbf114p-6, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, - -0x1.3ad06011469fbp-6, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, - -0x1.633f89e9a1a66p-6, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, - -0x1.8e18a73634ee7p-6, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, - -0x1.bb5a11138a4c9p-6, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, - -0x1.eb0208db9e51bp-6, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, - -0x1.0e875c1b8c3dap-5, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, - -0x1.28bf1897b69ccp-5, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, - -0x1.44273720f48bcp-5, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, - -0x1.60bea939d225ap-5, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, - -0x1.7e8454b32ef34p-5, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, - -0x1.9d7713b71eee1p-5, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, - -0x1.bd95b4d43e819p-5, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, - -0x1.dedefb09791b4p-5, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, - -0x1.00a8cee920eabp-4, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, - -0x1.127624999ee1dp-4, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, - -0x1.24d6cee3afb2ap-4, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, - -0x1.37ca1866b95cfp-4, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, - -0x1.4b4f461b0cbaap-4, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, - -0x1.5f6597591b633p-4, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, - -0x1.740c45e0e512p-4, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, - -0x1.894285e19c468p-4, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, - -0x1.9f07860181d1ep-4, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, - -0x1.b55a6f65f7058p-4, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, - -0x1.cc3a65bbc6327p-4, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, - -0x1.e3a6873fa1279p-4, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, - -0x1.fb9decc6d55b8p-4, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, - -0x1.0a0fd4e41ab5ap-3, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, - -0x1.169566329bcb7p-3, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, - -0x1.235f2eb9a470ap-3, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, - -0x1.306cb042aa3bap-3, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, - -0x1.3dbd69fabf802p-3, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, - -0x1.4b50d8778abbdp-3, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, - -0x1.592675bc57974p-3, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, - -0x1.673db93f41479p-3, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, - -0x1.759617ee761f9p-3, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, - -0x1.842f0435941afp-3, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, - -0x1.9307ee031e2fdp-3, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, - -0x1.a22042ce0a2f9p-3, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, - -0x1.b1776d9b67013p-3, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, - -0x1.c10cd7041afccp-3, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, - -0x1.d0dfe53aba2fdp-3, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, - -0x1.e0effc1174505p-3, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, - -0x1.f13c7d001a249p-3, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, - -0x1.00e263951d11fp-2, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, - -0x1.09441bb2aa0a2p-2, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, - -0x1.11c3141f91b3ep-2, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, - -0x1.1a5ef902000d3p-2, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, - -0x1.23177562aaea3p-2, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, - -0x1.2bec333018867p-2, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, - -0x1.34dcdb41f0f85p-2, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, - -0x1.3de9155c5a642p-2, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, - -0x1.471088335fce7p-2, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, - -0x1.5052d96e626c1p-2, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, - -0x1.59afadab954d4p-2, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, - -0x1.6326a8838342ep-2, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, - -0x1.6cb76c8c9ed8fp-2, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, - -0x1.76619b5edc454p-2, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, - -0x1.8024d59755257p-2, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, - -0x1.8a00badbf5e8ep-2, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, - -0x1.93f4e9df34c1bp-2, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, - -0x1.9e010063d1f96p-2, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, - -0x1.a8249b40a182cp-2, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, - -0x1.b25f56645da43p-2, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, - -0x1.bcb0ccd98294fp-2, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, - -0x1.c71898ca32e6fp-2, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, - -0x1.d19653842496fp-2, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, - -0x1.dc29957c969bbp-2, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, - -0x1.e6d1f6544ece3p-2, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, - -0x1.f18f0cdba0025p-2, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, - -0x1.fc606f1678292p-2, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, - -0x1.d16c901d95181p-8, 0x1p-1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, - -0x1.23e6ad10872a7p-6, 0x1p-1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, - -0x1.d4a2c7f909c4ep-6, 0x1p-1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, - -0x1.4344523c8e3b5p-5, 0x1p-1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, - -0x1.9cc8b3671dd0fp-5, 0x1p-1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, - -0x1.f6db13ff708cbp-5, 0x1p-1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, - -0x1.28bbfd87a8cffp-4, 0x1p-1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, - -0x1.564df524b00dap-4, 0x1p-1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, - -0x1.8421af15c49d7p-4, 0x1p-1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, - -0x1.b2356710db0a3p-4, 0x1p-1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, - -0x1.e087565455a75p-4, 0x1p-1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, - -0x1.078ad9dc46632p-3, 0x1p-1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, - -0x1.1eef59e0b74c3p-3, 0x1p-1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, - -0x1.367044581b074p-3, 0x1p-1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, - -0x1.4e0cb14a9c046p-3, 0x1p-1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, - -0x1.65c3b7b0e312cp-3, 0x1p-1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, - -0x1.7d946d7d133fdp-3, 0x1p-1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, - -0x1.957de7a3cfd5dp-3, 0x1p-1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, - -0x1.ad7f3a254c1f5p-3, 0x1p-1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, - -0x1.c597781664984p-3, 0x1p-1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, - -0x1.ddc5b3a9c1311p-3, 0x1p-1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, - -0x1.f608fe39004a4p-3, 0x1p-1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, - -0x1.cc0d09bd41caap-8, 0x1p-2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, - -0x1.36580d5d5e775p-6, 0x1p-2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, - -0x1.fa3ecac0d84e8p-6, 0x1p-2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, - -0x1.5f57f693feebep-5, 0x1p-2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, - -0x1.c1d1f0e5967d5p-5, 0x1p-2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, - -0x1.1244c435e819dp-4, 0x1p-2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, - -0x1.43bd776e98073p-4, 0x1p-2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, - -0x1.755129dad834cp-4, 0x1p-2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, - -0x1.a6fdf22e33d8cp-4, 0x1p-2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, - -0x1.d8c1e624a1513p-4, 0x1p-2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, - -0x1.536352ad19e39p-9, 0x1p-3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, - -0x1.e43d1c309e958p-7, 0x1p-3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, - -0x1.ba1650f592f5p-6, 0x1p-3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, - -0x1.4125feacab7cep-5, 0x1p-3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, - -0x1.a55beda63cc14p-5, 0x1p-3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, - -0x1.35230c0fbe402p-10, 0x1p-4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, - -0x1.b82683bc89fbp-7, 0x1p-4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, - -0x1.a4f3514d75466p-6, 0x1p-4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, - -0x1.b7aa821726608p-8, 0x1p-5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, - -0x1.b78b80c84e1eep-9, 0x1p-6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, - 0, 0, 0x1p0, 0, - -0x1.000c90e8fe6f6p6, 0x1p6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, - -0x1.003242abef46dp5, 0x1p5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, - -0x1.0096c32baca2bp4, 0x1p4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, - -0x1.00c8fb2f886ecp4, 0x1p4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, - -0x1.00fb2b73cfc1p4, 0x1p4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, - -0x1.025aa41259c34p3, 0x1p3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, - -0x1.02beda0153548p3, 0x1p3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, - -0x1.0322f4d785368p3, 0x1p3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, - -0x1.0386f0b8f3d86p3, 0x1p3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, - -0x1.03eac9cad52e6p3, 0x1p3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, - -0x1.089cf8676d7acp2, 0x1p2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, - -0x1.096408374730ap2, 0x1p2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, - -0x1.0a2abb58949f3p2, 0x1p2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, - -0x1.0af10a22459fep2, 0x1p2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, - -0x1.0bb6ecef285fap2, 0x1p2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, - -0x1.0c7c5c1e34d3p2, 0x1p2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, - -0x1.0d415012d8023p2, 0x1p2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, - -0x1.0e05c1353f27bp2, 0x1p2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, - -0x1.0ec9a7f2a2a19p2, 0x1p2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, - -0x1.0f8cfcbd90af9p2, 0x1p2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, - -0x1.209f701c6ffb6p1, 0x1p1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, - -0x1.2223a4c563ecfp1, 0x1p1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, - -0x1.23a6887e99b68p1, 0x1p1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, - -0x1.25280c5dab3e1p1, 0x1p1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, - -0x1.26a82185c302ap1, 0x1p1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, - -0x1.2826b9282eccp1, 0x1p1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, - -0x1.29a3c484f1cedp1, 0x1p1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, - -0x1.2b1f34eb563fcp1, 0x1p1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, - -0x1.2c98fbba7e4f9p1, 0x1p1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, - -0x1.2e110a61f48b4p1, 0x1p1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, - -0x1.2f8752623b99dp1, 0x1p1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, - -0x1.30fbc54d5d52cp1, 0x1p1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, - -0x1.326e54c77927bp1, 0x1p1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, - -0x1.33def28751db1p1, 0x1p1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, - -0x1.354d9056da7f9p1, 0x1p1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, - -0x1.36ba2013c2b98p1, 0x1p1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, - -0x1.382493b0023ddp1, 0x1p1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, - -0x1.398cdd326388cp1, 0x1p1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, - -0x1.3af2eeb70dc71p1, 0x1p1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, - -0x1.3c56ba700dec7p1, 0x1p1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, - -0x1.3db832a5def1bp1, 0x1p1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, - -0x1.3f1749b7f1357p1, 0x1p1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, - -0x1.80e7e43a61f5bp0, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, - -0x1.839c3cc917ff7p0, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, - -0x1.864b826aec4c7p0, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, - -0x1.88f59aa0da591p0, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, - -0x1.8b9a6b1ef6da4p0, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, - -0x1.8e39d9cd73464p0, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, - -0x1.90d3ccc99f5acp0, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, - -0x1.93682a66e896fp0, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, - -0x1.95f6d92fd79f5p0, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, - -0x1.987fbfe70b81ap0, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, - -0x1.9b02c58832cf9p0, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, - -0x1.9d7fd1490285dp0, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, - -0x1.9ff6ca9a2ab6ap0, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, - -0x1.a267992848eebp0, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, - -0x1.a4d224dcd849cp0, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, - -0x1.a73655df1f2f5p0, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, - -0x1.a99414951aacbp0, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, - -0x1.abeb49a46765p0, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, - -0x1.ae3bddf3280c6p0, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, - -0x1.b085baa8e966fp0, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, - -0x1.b2c8c92f83c1fp0, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, - -0x1.b504f333f9de6p0, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, - -0x1.b73a22a755457p0, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, - -0x1.b96841bf7ffcbp0, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, - -0x1.bb8f3af81b931p0, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, - -0x1.bdaef913557d7p0, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, - -0x1.bfc7671ab8bb8p0, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, - -0x1.c1d8705ffcbb7p0, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, - -0x1.c3e2007dd175fp0, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, - -0x1.c5e40358a8bap0, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, - -0x1.c7de651f7ca06p0, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, - -0x1.c9d1124c931fep0, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, - -0x1.cbbbf7a63eba1p0, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, - -0x1.cd9f023f9c3ap0, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, - -0x1.cf7a1f794d7cap0, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, - -0x1.d14d3d02313c1p0, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, - -0x1.d31848d817d71p0, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, - -0x1.d4db3148750d2p0, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, - -0x1.d695e4f10ea88p0, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, - -0x1.d84852c0a81p0, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, - -0x1.d9f269f7aab89p0, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, - -0x1.db941a28cb71fp0, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, - -0x1.dd2d5339ac869p0, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, - -0x1.debe05637ca95p0, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, - -0x1.e046213392aa5p0, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, - -0x1.e1c5978c05ed8p0, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, - -0x1.e33c59a4439cep0, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, - -0x1.e4aa5909a08fap0, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, - -0x1.e60f879fe7e2ep0, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, - -0x1.e76bd7a1e63b9p0, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, - -0x1.e8bf3ba1f1aeep0, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, - -0x1.ea09a68a6e49dp0, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, - -0x1.eb4b0b9e4f345p0, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, - -0x1.ec835e79946a3p0, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, - -0x1.edb29311c504dp0, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, - -0x1.eed89db66611ep0, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, - -0x1.eff573116df15p0, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, - -0x1.f1090827b4372p0, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, - -0x1.f21352595e0bfp0, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, - -0x1.f314476247089p0, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, - -0x1.f40bdd5a66886p0, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, - -0x1.f4fa0ab6316edp0, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, - -0x1.f5dec646f85bap0, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, - -0x1.f6ba073b424b2p0, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, - -0x1.f78bc51f239e1p0, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, - -0x1.f853f7dc9186cp0, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, - -0x1.f91297bbb1d6dp0, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, - -0x1.f9c79d63272c4p0, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, - -0x1.fa7301d859796p0, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, - -0x1.fb14be7fbae58p0, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, - -0x1.fbaccd1d0903cp0, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, - -0x1.fc3b27d38a5d5p0, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, - -0x1.fcbfc926484cdp0, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, - -0x1.fd3aabf84528bp0, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, - -0x1.fdabcb8caeba1p0, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, - -0x1.fe1323870cfeap0, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, - -0x1.fe70afeb6d33dp0, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, - -0x1.fec46d1e89293p0, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, - -0x1.ff0e57e5ead85p0, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, - -0x1.ff4e6d680c41dp0, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, - -0x1.ff84ab2c738d7p0, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, - -0x1.ffb10f1bcb6bfp0, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, - -0x1.ffd3977ff7baep0, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, - -0x1.ffec430426686p0, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, - -0x1.fffb10b4dc96ep0, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, - -0x1p1, 0x1p0, 0, 0, - -0x1.fffb10b4dc96ep0, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, - -0x1.ffec430426686p0, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, - -0x1.ffd3977ff7baep0, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, - -0x1.ffb10f1bcb6bfp0, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, - -0x1.ff84ab2c738d7p0, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, - -0x1.ff4e6d680c41dp0, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, - -0x1.ff0e57e5ead85p0, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, - -0x1.fec46d1e89293p0, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, - -0x1.fe70afeb6d33dp0, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, - -0x1.fe1323870cfeap0, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, - -0x1.fdabcb8caeba1p0, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, - -0x1.fd3aabf84528bp0, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, - -0x1.fcbfc926484cdp0, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, - -0x1.fc3b27d38a5d5p0, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, - -0x1.fbaccd1d0903cp0, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, - -0x1.fb14be7fbae58p0, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, - -0x1.fa7301d859796p0, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, - -0x1.f9c79d63272c4p0, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, - -0x1.f91297bbb1d6dp0, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, - -0x1.f853f7dc9186cp0, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, - -0x1.f78bc51f239e1p0, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, - -0x1.f6ba073b424b2p0, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, - -0x1.f5dec646f85bap0, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, - -0x1.f4fa0ab6316edp0, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, - -0x1.f40bdd5a66886p0, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, - -0x1.f314476247089p0, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, - -0x1.f21352595e0bfp0, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, - -0x1.f1090827b4372p0, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, - -0x1.eff573116df15p0, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, - -0x1.eed89db66611ep0, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, - -0x1.edb29311c504dp0, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, - -0x1.ec835e79946a3p0, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, - -0x1.eb4b0b9e4f345p0, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, - -0x1.ea09a68a6e49dp0, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, - -0x1.e8bf3ba1f1aeep0, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, - -0x1.e76bd7a1e63b9p0, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, - -0x1.e60f879fe7e2ep0, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, - -0x1.e4aa5909a08fap0, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, - -0x1.e33c59a4439cep0, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, - -0x1.e1c5978c05ed8p0, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, - -0x1.e046213392aa5p0, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, - -0x1.debe05637ca95p0, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, - -0x1.dd2d5339ac869p0, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, - -0x1.db941a28cb71fp0, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, - -0x1.d9f269f7aab89p0, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, - -0x1.d84852c0a81p0, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, - -0x1.d695e4f10ea88p0, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, - -0x1.d4db3148750d2p0, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, - -0x1.d31848d817d71p0, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, - -0x1.d14d3d02313c1p0, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, - -0x1.cf7a1f794d7cap0, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, - -0x1.cd9f023f9c3ap0, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, - -0x1.cbbbf7a63eba1p0, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, - -0x1.c9d1124c931fep0, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, - -0x1.c7de651f7ca06p0, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, - -0x1.c5e40358a8bap0, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, - -0x1.c3e2007dd175fp0, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, - -0x1.c1d8705ffcbb7p0, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, - -0x1.bfc7671ab8bb8p0, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, - -0x1.bdaef913557d7p0, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, - -0x1.bb8f3af81b931p0, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, - -0x1.b96841bf7ffcbp0, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, - -0x1.b73a22a755457p0, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, - -0x1.b504f333f9de6p0, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, - -0x1.b2c8c92f83c1fp0, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, - -0x1.b085baa8e966fp0, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, - -0x1.ae3bddf3280c6p0, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, - -0x1.abeb49a46765p0, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, - -0x1.a99414951aacbp0, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, - -0x1.a73655df1f2f5p0, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, - -0x1.a4d224dcd849cp0, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, - -0x1.a267992848eebp0, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, - -0x1.9ff6ca9a2ab6ap0, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, - -0x1.9d7fd1490285dp0, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, - -0x1.9b02c58832cf9p0, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, - -0x1.987fbfe70b81ap0, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, - -0x1.95f6d92fd79f5p0, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, - -0x1.93682a66e896fp0, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, - -0x1.90d3ccc99f5acp0, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, - -0x1.8e39d9cd73464p0, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, - -0x1.8b9a6b1ef6da4p0, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, - -0x1.88f59aa0da591p0, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, - -0x1.864b826aec4c7p0, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, - -0x1.839c3cc917ff7p0, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, - -0x1.80e7e43a61f5bp0, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, - -0x1.3f1749b7f1357p1, 0x1p1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, - -0x1.3db832a5def1bp1, 0x1p1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, - -0x1.3c56ba700dec7p1, 0x1p1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, - -0x1.3af2eeb70dc71p1, 0x1p1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, - -0x1.398cdd326388cp1, 0x1p1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, - -0x1.382493b0023ddp1, 0x1p1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, - -0x1.36ba2013c2b98p1, 0x1p1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, - -0x1.354d9056da7f9p1, 0x1p1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, - -0x1.33def28751db1p1, 0x1p1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, - -0x1.326e54c77927bp1, 0x1p1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, - -0x1.30fbc54d5d52cp1, 0x1p1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, - -0x1.2f8752623b99dp1, 0x1p1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, - -0x1.2e110a61f48b4p1, 0x1p1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, - -0x1.2c98fbba7e4f9p1, 0x1p1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, - -0x1.2b1f34eb563fcp1, 0x1p1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, - -0x1.29a3c484f1cedp1, 0x1p1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, - -0x1.2826b9282eccp1, 0x1p1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, - -0x1.26a82185c302ap1, 0x1p1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, - -0x1.25280c5dab3e1p1, 0x1p1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, - -0x1.23a6887e99b68p1, 0x1p1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, - -0x1.2223a4c563ecfp1, 0x1p1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, - -0x1.209f701c6ffb6p1, 0x1p1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, - -0x1.0f8cfcbd90af9p2, 0x1p2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, - -0x1.0ec9a7f2a2a19p2, 0x1p2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, - -0x1.0e05c1353f27bp2, 0x1p2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, - -0x1.0d415012d8023p2, 0x1p2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, - -0x1.0c7c5c1e34d3p2, 0x1p2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, - -0x1.0bb6ecef285fap2, 0x1p2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, - -0x1.0af10a22459fep2, 0x1p2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, - -0x1.0a2abb58949f3p2, 0x1p2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, - -0x1.096408374730ap2, 0x1p2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, - -0x1.089cf8676d7acp2, 0x1p2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, - -0x1.03eac9cad52e6p3, 0x1p3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, - -0x1.0386f0b8f3d86p3, 0x1p3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, - -0x1.0322f4d785368p3, 0x1p3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, - -0x1.02beda0153548p3, 0x1p3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, - -0x1.025aa41259c34p3, 0x1p3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, - -0x1.00fb2b73cfc1p4, 0x1p4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, - -0x1.00c8fb2f886ecp4, 0x1p4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, - -0x1.0096c32baca2bp4, 0x1p4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, - -0x1.003242abef46dp5, 0x1p5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, - -0x1.000c90e8fe6f6p6, 0x1p6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, - 0, 0, -0x1p0, 0, - -0x1.b78b80c84e1eep-9, 0x1p-6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, - -0x1.b7aa821726608p-8, 0x1p-5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, - -0x1.a4f3514d75466p-6, 0x1p-4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, - -0x1.b82683bc89fbp-7, 0x1p-4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, - -0x1.35230c0fbe402p-10, 0x1p-4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, - -0x1.a55beda63cc14p-5, 0x1p-3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, - -0x1.4125feacab7cep-5, 0x1p-3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, - -0x1.ba1650f592f5p-6, 0x1p-3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, - -0x1.e43d1c309e958p-7, 0x1p-3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, - -0x1.536352ad19e39p-9, 0x1p-3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, - -0x1.d8c1e624a1513p-4, 0x1p-2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, - -0x1.a6fdf22e33d8cp-4, 0x1p-2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, - -0x1.755129dad834cp-4, 0x1p-2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, - -0x1.43bd776e98073p-4, 0x1p-2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, - -0x1.1244c435e819dp-4, 0x1p-2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, - -0x1.c1d1f0e5967d5p-5, 0x1p-2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, - -0x1.5f57f693feebep-5, 0x1p-2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, - -0x1.fa3ecac0d84e8p-6, 0x1p-2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, - -0x1.36580d5d5e775p-6, 0x1p-2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, - -0x1.cc0d09bd41caap-8, 0x1p-2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, - -0x1.f608fe39004a4p-3, 0x1p-1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, - -0x1.ddc5b3a9c1311p-3, 0x1p-1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, - -0x1.c597781664984p-3, 0x1p-1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, - -0x1.ad7f3a254c1f5p-3, 0x1p-1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, - -0x1.957de7a3cfd5dp-3, 0x1p-1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, - -0x1.7d946d7d133fdp-3, 0x1p-1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, - -0x1.65c3b7b0e312cp-3, 0x1p-1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, - -0x1.4e0cb14a9c046p-3, 0x1p-1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, - -0x1.367044581b074p-3, 0x1p-1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, - -0x1.1eef59e0b74c3p-3, 0x1p-1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, - -0x1.078ad9dc46632p-3, 0x1p-1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, - -0x1.e087565455a75p-4, 0x1p-1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, - -0x1.b2356710db0a3p-4, 0x1p-1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, - -0x1.8421af15c49d7p-4, 0x1p-1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, - -0x1.564df524b00dap-4, 0x1p-1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, - -0x1.28bbfd87a8cffp-4, 0x1p-1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, - -0x1.f6db13ff708cbp-5, 0x1p-1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, - -0x1.9cc8b3671dd0fp-5, 0x1p-1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, - -0x1.4344523c8e3b5p-5, 0x1p-1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, - -0x1.d4a2c7f909c4ep-6, 0x1p-1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, - -0x1.23e6ad10872a7p-6, 0x1p-1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, - -0x1.d16c901d95181p-8, 0x1p-1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, - -0x1.fc606f1678292p-2, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, - -0x1.f18f0cdba0025p-2, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, - -0x1.e6d1f6544ece3p-2, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, - -0x1.dc29957c969bbp-2, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, - -0x1.d19653842496fp-2, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, - -0x1.c71898ca32e6fp-2, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, - -0x1.bcb0ccd98294fp-2, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, - -0x1.b25f56645da43p-2, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, - -0x1.a8249b40a182cp-2, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, - -0x1.9e010063d1f96p-2, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, - -0x1.93f4e9df34c1bp-2, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, - -0x1.8a00badbf5e8ep-2, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, - -0x1.8024d59755257p-2, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, - -0x1.76619b5edc454p-2, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, - -0x1.6cb76c8c9ed8fp-2, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, - -0x1.6326a8838342ep-2, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, - -0x1.59afadab954d4p-2, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, - -0x1.5052d96e626c1p-2, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, - -0x1.471088335fce7p-2, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, - -0x1.3de9155c5a642p-2, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, - -0x1.34dcdb41f0f85p-2, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, - -0x1.2bec333018867p-2, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, - -0x1.23177562aaea3p-2, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, - -0x1.1a5ef902000d3p-2, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, - -0x1.11c3141f91b3ep-2, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, - -0x1.09441bb2aa0a2p-2, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, - -0x1.00e263951d11fp-2, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, - -0x1.f13c7d001a249p-3, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, - -0x1.e0effc1174505p-3, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, - -0x1.d0dfe53aba2fdp-3, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, - -0x1.c10cd7041afccp-3, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, - -0x1.b1776d9b67013p-3, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, - -0x1.a22042ce0a2f9p-3, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, - -0x1.9307ee031e2fdp-3, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, - -0x1.842f0435941afp-3, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, - -0x1.759617ee761f9p-3, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, - -0x1.673db93f41479p-3, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, - -0x1.592675bc57974p-3, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, - -0x1.4b50d8778abbdp-3, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, - -0x1.3dbd69fabf802p-3, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, - -0x1.306cb042aa3bap-3, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, - -0x1.235f2eb9a470ap-3, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, - -0x1.169566329bcb7p-3, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, - -0x1.0a0fd4e41ab5ap-3, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, - -0x1.fb9decc6d55b8p-4, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, - -0x1.e3a6873fa1279p-4, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, - -0x1.cc3a65bbc6327p-4, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, - -0x1.b55a6f65f7058p-4, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, - -0x1.9f07860181d1ep-4, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, - -0x1.894285e19c468p-4, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, - -0x1.740c45e0e512p-4, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, - -0x1.5f6597591b633p-4, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, - -0x1.4b4f461b0cbaap-4, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, - -0x1.37ca1866b95cfp-4, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, - -0x1.24d6cee3afb2ap-4, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, - -0x1.127624999ee1dp-4, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, - -0x1.00a8cee920eabp-4, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, - -0x1.dedefb09791b4p-5, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, - -0x1.bd95b4d43e819p-5, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, - -0x1.9d7713b71eee1p-5, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, - -0x1.7e8454b32ef34p-5, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, - -0x1.60bea939d225ap-5, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, - -0x1.44273720f48bcp-5, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, - -0x1.28bf1897b69ccp-5, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, - -0x1.0e875c1b8c3dap-5, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, - -0x1.eb0208db9e51bp-6, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, - -0x1.bb5a11138a4c9p-6, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, - -0x1.8e18a73634ee7p-6, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, - -0x1.633f89e9a1a66p-6, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, - -0x1.3ad06011469fbp-6, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, - -0x1.14ccb8bdbf114p-6, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, - -0x1.e26c163ad15b3p-7, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, - -0x1.a01b6cdbd995ep-7, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, - -0x1.62aa03dd6ba58p-7, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, - -0x1.2a1a39a8a2fb7p-7, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, - -0x1.ecdc78f30165cp-8, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, - -0x1.8f501492cc296p-8, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, - -0x1.3b92e176d6d31p-8, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, - -0x1.e350342a4f6e6p-9, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, - -0x1.63252fe77c5ebp-9, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, - -0x1.ed534e31ca57fp-10, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, - -0x1.3bc390d250439p-10, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, - -0x1.6344004228d8bp-11, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, - -0x1.3bcfbd9979a27p-12, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, - -0x1.3bd2c8da49511p-14, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, -}; -template <> constexpr double kCosApproxTable[] = { - 0, 0, 0x1p0, 0, - -0x1.000c90e8fe6f6p6, 0x1p6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, - -0x1.003242abef46dp5, 0x1p5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, - -0x1.0096c32baca2bp4, 0x1p4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, - -0x1.00c8fb2f886ecp4, 0x1p4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, - -0x1.00fb2b73cfc1p4, 0x1p4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, - -0x1.025aa41259c34p3, 0x1p3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, - -0x1.02beda0153548p3, 0x1p3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, - -0x1.0322f4d785368p3, 0x1p3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, - -0x1.0386f0b8f3d86p3, 0x1p3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, - -0x1.03eac9cad52e6p3, 0x1p3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, - -0x1.089cf8676d7acp2, 0x1p2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, - -0x1.096408374730ap2, 0x1p2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, - -0x1.0a2abb58949f3p2, 0x1p2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, - -0x1.0af10a22459fep2, 0x1p2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, - -0x1.0bb6ecef285fap2, 0x1p2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, - -0x1.0c7c5c1e34d3p2, 0x1p2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, - -0x1.0d415012d8023p2, 0x1p2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, - -0x1.0e05c1353f27bp2, 0x1p2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, - -0x1.0ec9a7f2a2a19p2, 0x1p2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, - -0x1.0f8cfcbd90af9p2, 0x1p2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, - -0x1.209f701c6ffb6p1, 0x1p1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, - -0x1.2223a4c563ecfp1, 0x1p1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, - -0x1.23a6887e99b68p1, 0x1p1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, - -0x1.25280c5dab3e1p1, 0x1p1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, - -0x1.26a82185c302ap1, 0x1p1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, - -0x1.2826b9282eccp1, 0x1p1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, - -0x1.29a3c484f1cedp1, 0x1p1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, - -0x1.2b1f34eb563fcp1, 0x1p1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, - -0x1.2c98fbba7e4f9p1, 0x1p1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, - -0x1.2e110a61f48b4p1, 0x1p1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, - -0x1.2f8752623b99dp1, 0x1p1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, - -0x1.30fbc54d5d52cp1, 0x1p1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, - -0x1.326e54c77927bp1, 0x1p1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, - -0x1.33def28751db1p1, 0x1p1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, - -0x1.354d9056da7f9p1, 0x1p1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, - -0x1.36ba2013c2b98p1, 0x1p1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, - -0x1.382493b0023ddp1, 0x1p1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, - -0x1.398cdd326388cp1, 0x1p1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, - -0x1.3af2eeb70dc71p1, 0x1p1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, - -0x1.3c56ba700dec7p1, 0x1p1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, - -0x1.3db832a5def1bp1, 0x1p1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, - -0x1.3f1749b7f1357p1, 0x1p1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, - -0x1.80e7e43a61f5bp0, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, - -0x1.839c3cc917ff7p0, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, - -0x1.864b826aec4c7p0, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, - -0x1.88f59aa0da591p0, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, - -0x1.8b9a6b1ef6da4p0, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, - -0x1.8e39d9cd73464p0, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, - -0x1.90d3ccc99f5acp0, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, - -0x1.93682a66e896fp0, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, - -0x1.95f6d92fd79f5p0, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, - -0x1.987fbfe70b81ap0, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, - -0x1.9b02c58832cf9p0, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, - -0x1.9d7fd1490285dp0, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, - -0x1.9ff6ca9a2ab6ap0, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, - -0x1.a267992848eebp0, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, - -0x1.a4d224dcd849cp0, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, - -0x1.a73655df1f2f5p0, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, - -0x1.a99414951aacbp0, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, - -0x1.abeb49a46765p0, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, - -0x1.ae3bddf3280c6p0, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, - -0x1.b085baa8e966fp0, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, - -0x1.b2c8c92f83c1fp0, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, - -0x1.b504f333f9de6p0, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, - -0x1.b73a22a755457p0, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, - -0x1.b96841bf7ffcbp0, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, - -0x1.bb8f3af81b931p0, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, - -0x1.bdaef913557d7p0, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, - -0x1.bfc7671ab8bb8p0, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, - -0x1.c1d8705ffcbb7p0, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, - -0x1.c3e2007dd175fp0, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, - -0x1.c5e40358a8bap0, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, - -0x1.c7de651f7ca06p0, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, - -0x1.c9d1124c931fep0, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, - -0x1.cbbbf7a63eba1p0, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, - -0x1.cd9f023f9c3ap0, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, - -0x1.cf7a1f794d7cap0, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, - -0x1.d14d3d02313c1p0, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, - -0x1.d31848d817d71p0, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, - -0x1.d4db3148750d2p0, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, - -0x1.d695e4f10ea88p0, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, - -0x1.d84852c0a81p0, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, - -0x1.d9f269f7aab89p0, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, - -0x1.db941a28cb71fp0, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, - -0x1.dd2d5339ac869p0, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, - -0x1.debe05637ca95p0, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, - -0x1.e046213392aa5p0, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, - -0x1.e1c5978c05ed8p0, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, - -0x1.e33c59a4439cep0, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, - -0x1.e4aa5909a08fap0, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, - -0x1.e60f879fe7e2ep0, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, - -0x1.e76bd7a1e63b9p0, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, - -0x1.e8bf3ba1f1aeep0, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, - -0x1.ea09a68a6e49dp0, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, - -0x1.eb4b0b9e4f345p0, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, - -0x1.ec835e79946a3p0, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, - -0x1.edb29311c504dp0, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, - -0x1.eed89db66611ep0, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, - -0x1.eff573116df15p0, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, - -0x1.f1090827b4372p0, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, - -0x1.f21352595e0bfp0, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, - -0x1.f314476247089p0, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, - -0x1.f40bdd5a66886p0, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, - -0x1.f4fa0ab6316edp0, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, - -0x1.f5dec646f85bap0, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, - -0x1.f6ba073b424b2p0, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, - -0x1.f78bc51f239e1p0, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, - -0x1.f853f7dc9186cp0, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, - -0x1.f91297bbb1d6dp0, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, - -0x1.f9c79d63272c4p0, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, - -0x1.fa7301d859796p0, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, - -0x1.fb14be7fbae58p0, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, - -0x1.fbaccd1d0903cp0, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, - -0x1.fc3b27d38a5d5p0, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, - -0x1.fcbfc926484cdp0, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, - -0x1.fd3aabf84528bp0, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, - -0x1.fdabcb8caeba1p0, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, - -0x1.fe1323870cfeap0, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, - -0x1.fe70afeb6d33dp0, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, - -0x1.fec46d1e89293p0, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, - -0x1.ff0e57e5ead85p0, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, - -0x1.ff4e6d680c41dp0, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, - -0x1.ff84ab2c738d7p0, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, - -0x1.ffb10f1bcb6bfp0, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, - -0x1.ffd3977ff7baep0, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, - -0x1.ffec430426686p0, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, - -0x1.fffb10b4dc96ep0, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, - -0x1p1, 0x1p0, 0, 0, - -0x1.fffb10b4dc96ep0, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, - -0x1.ffec430426686p0, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, - -0x1.ffd3977ff7baep0, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, - -0x1.ffb10f1bcb6bfp0, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, - -0x1.ff84ab2c738d7p0, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, - -0x1.ff4e6d680c41dp0, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, - -0x1.ff0e57e5ead85p0, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, - -0x1.fec46d1e89293p0, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, - -0x1.fe70afeb6d33dp0, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, - -0x1.fe1323870cfeap0, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, - -0x1.fdabcb8caeba1p0, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, - -0x1.fd3aabf84528bp0, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, - -0x1.fcbfc926484cdp0, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, - -0x1.fc3b27d38a5d5p0, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, - -0x1.fbaccd1d0903cp0, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, - -0x1.fb14be7fbae58p0, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, - -0x1.fa7301d859796p0, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, - -0x1.f9c79d63272c4p0, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, - -0x1.f91297bbb1d6dp0, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, - -0x1.f853f7dc9186cp0, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, - -0x1.f78bc51f239e1p0, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, - -0x1.f6ba073b424b2p0, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, - -0x1.f5dec646f85bap0, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, - -0x1.f4fa0ab6316edp0, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, - -0x1.f40bdd5a66886p0, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, - -0x1.f314476247089p0, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, - -0x1.f21352595e0bfp0, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, - -0x1.f1090827b4372p0, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, - -0x1.eff573116df15p0, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, - -0x1.eed89db66611ep0, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, - -0x1.edb29311c504dp0, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, - -0x1.ec835e79946a3p0, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, - -0x1.eb4b0b9e4f345p0, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, - -0x1.ea09a68a6e49dp0, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, - -0x1.e8bf3ba1f1aeep0, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, - -0x1.e76bd7a1e63b9p0, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, - -0x1.e60f879fe7e2ep0, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, - -0x1.e4aa5909a08fap0, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, - -0x1.e33c59a4439cep0, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, - -0x1.e1c5978c05ed8p0, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, - -0x1.e046213392aa5p0, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, - -0x1.debe05637ca95p0, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, - -0x1.dd2d5339ac869p0, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, - -0x1.db941a28cb71fp0, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, - -0x1.d9f269f7aab89p0, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, - -0x1.d84852c0a81p0, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, - -0x1.d695e4f10ea88p0, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, - -0x1.d4db3148750d2p0, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, - -0x1.d31848d817d71p0, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, - -0x1.d14d3d02313c1p0, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, - -0x1.cf7a1f794d7cap0, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, - -0x1.cd9f023f9c3ap0, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, - -0x1.cbbbf7a63eba1p0, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, - -0x1.c9d1124c931fep0, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, - -0x1.c7de651f7ca06p0, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, - -0x1.c5e40358a8bap0, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, - -0x1.c3e2007dd175fp0, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, - -0x1.c1d8705ffcbb7p0, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, - -0x1.bfc7671ab8bb8p0, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, - -0x1.bdaef913557d7p0, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, - -0x1.bb8f3af81b931p0, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, - -0x1.b96841bf7ffcbp0, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, - -0x1.b73a22a755457p0, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, - -0x1.b504f333f9de6p0, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, - -0x1.b2c8c92f83c1fp0, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, - -0x1.b085baa8e966fp0, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, - -0x1.ae3bddf3280c6p0, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, - -0x1.abeb49a46765p0, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, - -0x1.a99414951aacbp0, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, - -0x1.a73655df1f2f5p0, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, - -0x1.a4d224dcd849cp0, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, - -0x1.a267992848eebp0, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, - -0x1.9ff6ca9a2ab6ap0, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, - -0x1.9d7fd1490285dp0, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, - -0x1.9b02c58832cf9p0, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, - -0x1.987fbfe70b81ap0, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, - -0x1.95f6d92fd79f5p0, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, - -0x1.93682a66e896fp0, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, - -0x1.90d3ccc99f5acp0, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, - -0x1.8e39d9cd73464p0, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, - -0x1.8b9a6b1ef6da4p0, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, - -0x1.88f59aa0da591p0, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, - -0x1.864b826aec4c7p0, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, - -0x1.839c3cc917ff7p0, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, - -0x1.80e7e43a61f5bp0, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, - -0x1.3f1749b7f1357p1, 0x1p1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, - -0x1.3db832a5def1bp1, 0x1p1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, - -0x1.3c56ba700dec7p1, 0x1p1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, - -0x1.3af2eeb70dc71p1, 0x1p1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, - -0x1.398cdd326388cp1, 0x1p1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, - -0x1.382493b0023ddp1, 0x1p1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, - -0x1.36ba2013c2b98p1, 0x1p1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, - -0x1.354d9056da7f9p1, 0x1p1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, - -0x1.33def28751db1p1, 0x1p1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, - -0x1.326e54c77927bp1, 0x1p1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, - -0x1.30fbc54d5d52cp1, 0x1p1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, - -0x1.2f8752623b99dp1, 0x1p1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, - -0x1.2e110a61f48b4p1, 0x1p1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, - -0x1.2c98fbba7e4f9p1, 0x1p1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, - -0x1.2b1f34eb563fcp1, 0x1p1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, - -0x1.29a3c484f1cedp1, 0x1p1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, - -0x1.2826b9282eccp1, 0x1p1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, - -0x1.26a82185c302ap1, 0x1p1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, - -0x1.25280c5dab3e1p1, 0x1p1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, - -0x1.23a6887e99b68p1, 0x1p1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, - -0x1.2223a4c563ecfp1, 0x1p1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, - -0x1.209f701c6ffb6p1, 0x1p1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, - -0x1.0f8cfcbd90af9p2, 0x1p2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, - -0x1.0ec9a7f2a2a19p2, 0x1p2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, - -0x1.0e05c1353f27bp2, 0x1p2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, - -0x1.0d415012d8023p2, 0x1p2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, - -0x1.0c7c5c1e34d3p2, 0x1p2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, - -0x1.0bb6ecef285fap2, 0x1p2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, - -0x1.0af10a22459fep2, 0x1p2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, - -0x1.0a2abb58949f3p2, 0x1p2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, - -0x1.096408374730ap2, 0x1p2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, - -0x1.089cf8676d7acp2, 0x1p2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, - -0x1.03eac9cad52e6p3, 0x1p3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, - -0x1.0386f0b8f3d86p3, 0x1p3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, - -0x1.0322f4d785368p3, 0x1p3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, - -0x1.02beda0153548p3, 0x1p3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, - -0x1.025aa41259c34p3, 0x1p3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, - -0x1.00fb2b73cfc1p4, 0x1p4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, - -0x1.00c8fb2f886ecp4, 0x1p4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, - -0x1.0096c32baca2bp4, 0x1p4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, - -0x1.003242abef46dp5, 0x1p5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, - -0x1.000c90e8fe6f6p6, 0x1p6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, - 0, 0, -0x1p0, 0, - -0x1.b78b80c84e1eep-9, 0x1p-6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, - -0x1.b7aa821726608p-8, 0x1p-5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, - -0x1.a4f3514d75466p-6, 0x1p-4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, - -0x1.b82683bc89fbp-7, 0x1p-4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, - -0x1.35230c0fbe402p-10, 0x1p-4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, - -0x1.a55beda63cc14p-5, 0x1p-3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, - -0x1.4125feacab7cep-5, 0x1p-3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, - -0x1.ba1650f592f5p-6, 0x1p-3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, - -0x1.e43d1c309e958p-7, 0x1p-3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, - -0x1.536352ad19e39p-9, 0x1p-3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, - -0x1.d8c1e624a1513p-4, 0x1p-2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, - -0x1.a6fdf22e33d8cp-4, 0x1p-2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, - -0x1.755129dad834cp-4, 0x1p-2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, - -0x1.43bd776e98073p-4, 0x1p-2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, - -0x1.1244c435e819dp-4, 0x1p-2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, - -0x1.c1d1f0e5967d5p-5, 0x1p-2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, - -0x1.5f57f693feebep-5, 0x1p-2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, - -0x1.fa3ecac0d84e8p-6, 0x1p-2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, - -0x1.36580d5d5e775p-6, 0x1p-2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, - -0x1.cc0d09bd41caap-8, 0x1p-2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, - -0x1.f608fe39004a4p-3, 0x1p-1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, - -0x1.ddc5b3a9c1311p-3, 0x1p-1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, - -0x1.c597781664984p-3, 0x1p-1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, - -0x1.ad7f3a254c1f5p-3, 0x1p-1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, - -0x1.957de7a3cfd5dp-3, 0x1p-1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, - -0x1.7d946d7d133fdp-3, 0x1p-1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, - -0x1.65c3b7b0e312cp-3, 0x1p-1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, - -0x1.4e0cb14a9c046p-3, 0x1p-1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, - -0x1.367044581b074p-3, 0x1p-1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, - -0x1.1eef59e0b74c3p-3, 0x1p-1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, - -0x1.078ad9dc46632p-3, 0x1p-1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, - -0x1.e087565455a75p-4, 0x1p-1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, - -0x1.b2356710db0a3p-4, 0x1p-1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, - -0x1.8421af15c49d7p-4, 0x1p-1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, - -0x1.564df524b00dap-4, 0x1p-1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, - -0x1.28bbfd87a8cffp-4, 0x1p-1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, - -0x1.f6db13ff708cbp-5, 0x1p-1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, - -0x1.9cc8b3671dd0fp-5, 0x1p-1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, - -0x1.4344523c8e3b5p-5, 0x1p-1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, - -0x1.d4a2c7f909c4ep-6, 0x1p-1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, - -0x1.23e6ad10872a7p-6, 0x1p-1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, - -0x1.d16c901d95181p-8, 0x1p-1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, - -0x1.fc606f1678292p-2, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, - -0x1.f18f0cdba0025p-2, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, - -0x1.e6d1f6544ece3p-2, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, - -0x1.dc29957c969bbp-2, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, - -0x1.d19653842496fp-2, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, - -0x1.c71898ca32e6fp-2, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, - -0x1.bcb0ccd98294fp-2, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, - -0x1.b25f56645da43p-2, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, - -0x1.a8249b40a182cp-2, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, - -0x1.9e010063d1f96p-2, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, - -0x1.93f4e9df34c1bp-2, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, - -0x1.8a00badbf5e8ep-2, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, - -0x1.8024d59755257p-2, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, - -0x1.76619b5edc454p-2, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, - -0x1.6cb76c8c9ed8fp-2, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, - -0x1.6326a8838342ep-2, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, - -0x1.59afadab954d4p-2, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, - -0x1.5052d96e626c1p-2, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, - -0x1.471088335fce7p-2, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, - -0x1.3de9155c5a642p-2, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, - -0x1.34dcdb41f0f85p-2, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, - -0x1.2bec333018867p-2, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, - -0x1.23177562aaea3p-2, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, - -0x1.1a5ef902000d3p-2, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, - -0x1.11c3141f91b3ep-2, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, - -0x1.09441bb2aa0a2p-2, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, - -0x1.00e263951d11fp-2, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, - -0x1.f13c7d001a249p-3, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, - -0x1.e0effc1174505p-3, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, - -0x1.d0dfe53aba2fdp-3, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, - -0x1.c10cd7041afccp-3, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, - -0x1.b1776d9b67013p-3, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, - -0x1.a22042ce0a2f9p-3, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, - -0x1.9307ee031e2fdp-3, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, - -0x1.842f0435941afp-3, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, - -0x1.759617ee761f9p-3, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, - -0x1.673db93f41479p-3, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, - -0x1.592675bc57974p-3, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, - -0x1.4b50d8778abbdp-3, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, - -0x1.3dbd69fabf802p-3, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, - -0x1.306cb042aa3bap-3, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, - -0x1.235f2eb9a470ap-3, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, - -0x1.169566329bcb7p-3, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, - -0x1.0a0fd4e41ab5ap-3, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, - -0x1.fb9decc6d55b8p-4, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, - -0x1.e3a6873fa1279p-4, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, - -0x1.cc3a65bbc6327p-4, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, - -0x1.b55a6f65f7058p-4, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, - -0x1.9f07860181d1ep-4, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, - -0x1.894285e19c468p-4, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, - -0x1.740c45e0e512p-4, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, - -0x1.5f6597591b633p-4, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, - -0x1.4b4f461b0cbaap-4, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, - -0x1.37ca1866b95cfp-4, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, - -0x1.24d6cee3afb2ap-4, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, - -0x1.127624999ee1dp-4, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, - -0x1.00a8cee920eabp-4, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, - -0x1.dedefb09791b4p-5, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, - -0x1.bd95b4d43e819p-5, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, - -0x1.9d7713b71eee1p-5, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, - -0x1.7e8454b32ef34p-5, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, - -0x1.60bea939d225ap-5, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, - -0x1.44273720f48bcp-5, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, - -0x1.28bf1897b69ccp-5, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, - -0x1.0e875c1b8c3dap-5, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, - -0x1.eb0208db9e51bp-6, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, - -0x1.bb5a11138a4c9p-6, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, - -0x1.8e18a73634ee7p-6, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, - -0x1.633f89e9a1a66p-6, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, - -0x1.3ad06011469fbp-6, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, - -0x1.14ccb8bdbf114p-6, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, - -0x1.e26c163ad15b3p-7, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, - -0x1.a01b6cdbd995ep-7, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, - -0x1.62aa03dd6ba58p-7, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, - -0x1.2a1a39a8a2fb7p-7, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, - -0x1.ecdc78f30165cp-8, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, - -0x1.8f501492cc296p-8, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, - -0x1.3b92e176d6d31p-8, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, - -0x1.e350342a4f6e6p-9, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, - -0x1.63252fe77c5ebp-9, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, - -0x1.ed534e31ca57fp-10, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, - -0x1.3bc390d250439p-10, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, - -0x1.6344004228d8bp-11, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, - -0x1.3bcfbd9979a27p-12, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, - -0x1.3bd2c8da49511p-14, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, - 0, 0x1p0, 0, 0, - -0x1.3bd2c8da49511p-14, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, - -0x1.3bcfbd9979a27p-12, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, - -0x1.6344004228d8bp-11, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, - -0x1.3bc390d250439p-10, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, - -0x1.ed534e31ca57fp-10, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, - -0x1.63252fe77c5ebp-9, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, - -0x1.e350342a4f6e6p-9, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, - -0x1.3b92e176d6d31p-8, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, - -0x1.8f501492cc296p-8, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, - -0x1.ecdc78f30165cp-8, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, - -0x1.2a1a39a8a2fb7p-7, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, - -0x1.62aa03dd6ba58p-7, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, - -0x1.a01b6cdbd995ep-7, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, - -0x1.e26c163ad15b3p-7, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, - -0x1.14ccb8bdbf114p-6, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, - -0x1.3ad06011469fbp-6, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, - -0x1.633f89e9a1a66p-6, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, - -0x1.8e18a73634ee7p-6, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, - -0x1.bb5a11138a4c9p-6, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, - -0x1.eb0208db9e51bp-6, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, - -0x1.0e875c1b8c3dap-5, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, - -0x1.28bf1897b69ccp-5, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, - -0x1.44273720f48bcp-5, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, - -0x1.60bea939d225ap-5, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, - -0x1.7e8454b32ef34p-5, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, - -0x1.9d7713b71eee1p-5, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, - -0x1.bd95b4d43e819p-5, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, - -0x1.dedefb09791b4p-5, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, - -0x1.00a8cee920eabp-4, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, - -0x1.127624999ee1dp-4, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, - -0x1.24d6cee3afb2ap-4, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, - -0x1.37ca1866b95cfp-4, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, - -0x1.4b4f461b0cbaap-4, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, - -0x1.5f6597591b633p-4, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, - -0x1.740c45e0e512p-4, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, - -0x1.894285e19c468p-4, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, - -0x1.9f07860181d1ep-4, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, - -0x1.b55a6f65f7058p-4, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, - -0x1.cc3a65bbc6327p-4, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, - -0x1.e3a6873fa1279p-4, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, - -0x1.fb9decc6d55b8p-4, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, - -0x1.0a0fd4e41ab5ap-3, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, - -0x1.169566329bcb7p-3, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, - -0x1.235f2eb9a470ap-3, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, - -0x1.306cb042aa3bap-3, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, - -0x1.3dbd69fabf802p-3, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, - -0x1.4b50d8778abbdp-3, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, - -0x1.592675bc57974p-3, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, - -0x1.673db93f41479p-3, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, - -0x1.759617ee761f9p-3, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, - -0x1.842f0435941afp-3, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, - -0x1.9307ee031e2fdp-3, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, - -0x1.a22042ce0a2f9p-3, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, - -0x1.b1776d9b67013p-3, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, - -0x1.c10cd7041afccp-3, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, - -0x1.d0dfe53aba2fdp-3, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, - -0x1.e0effc1174505p-3, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, - -0x1.f13c7d001a249p-3, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, - -0x1.00e263951d11fp-2, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, - -0x1.09441bb2aa0a2p-2, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, - -0x1.11c3141f91b3ep-2, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, - -0x1.1a5ef902000d3p-2, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, - -0x1.23177562aaea3p-2, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, - -0x1.2bec333018867p-2, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, - -0x1.34dcdb41f0f85p-2, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, - -0x1.3de9155c5a642p-2, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, - -0x1.471088335fce7p-2, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, - -0x1.5052d96e626c1p-2, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, - -0x1.59afadab954d4p-2, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, - -0x1.6326a8838342ep-2, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, - -0x1.6cb76c8c9ed8fp-2, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, - -0x1.76619b5edc454p-2, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, - -0x1.8024d59755257p-2, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, - -0x1.8a00badbf5e8ep-2, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, - -0x1.93f4e9df34c1bp-2, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, - -0x1.9e010063d1f96p-2, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, - -0x1.a8249b40a182cp-2, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, - -0x1.b25f56645da43p-2, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, - -0x1.bcb0ccd98294fp-2, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, - -0x1.c71898ca32e6fp-2, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, - -0x1.d19653842496fp-2, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, - -0x1.dc29957c969bbp-2, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, - -0x1.e6d1f6544ece3p-2, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, - -0x1.f18f0cdba0025p-2, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, - -0x1.fc606f1678292p-2, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, - -0x1.d16c901d95181p-8, 0x1p-1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, - -0x1.23e6ad10872a7p-6, 0x1p-1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, - -0x1.d4a2c7f909c4ep-6, 0x1p-1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, - -0x1.4344523c8e3b5p-5, 0x1p-1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, - -0x1.9cc8b3671dd0fp-5, 0x1p-1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, - -0x1.f6db13ff708cbp-5, 0x1p-1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, - -0x1.28bbfd87a8cffp-4, 0x1p-1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, - -0x1.564df524b00dap-4, 0x1p-1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, - -0x1.8421af15c49d7p-4, 0x1p-1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, - -0x1.b2356710db0a3p-4, 0x1p-1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, - -0x1.e087565455a75p-4, 0x1p-1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, - -0x1.078ad9dc46632p-3, 0x1p-1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, - -0x1.1eef59e0b74c3p-3, 0x1p-1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, - -0x1.367044581b074p-3, 0x1p-1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, - -0x1.4e0cb14a9c046p-3, 0x1p-1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, - -0x1.65c3b7b0e312cp-3, 0x1p-1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, - -0x1.7d946d7d133fdp-3, 0x1p-1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, - -0x1.957de7a3cfd5dp-3, 0x1p-1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, - -0x1.ad7f3a254c1f5p-3, 0x1p-1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, - -0x1.c597781664984p-3, 0x1p-1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, - -0x1.ddc5b3a9c1311p-3, 0x1p-1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, - -0x1.f608fe39004a4p-3, 0x1p-1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, - -0x1.cc0d09bd41caap-8, 0x1p-2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, - -0x1.36580d5d5e775p-6, 0x1p-2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, - -0x1.fa3ecac0d84e8p-6, 0x1p-2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, - -0x1.5f57f693feebep-5, 0x1p-2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, - -0x1.c1d1f0e5967d5p-5, 0x1p-2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, - -0x1.1244c435e819dp-4, 0x1p-2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, - -0x1.43bd776e98073p-4, 0x1p-2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, - -0x1.755129dad834cp-4, 0x1p-2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, - -0x1.a6fdf22e33d8cp-4, 0x1p-2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, - -0x1.d8c1e624a1513p-4, 0x1p-2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, - -0x1.536352ad19e39p-9, 0x1p-3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, - -0x1.e43d1c309e958p-7, 0x1p-3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, - -0x1.ba1650f592f5p-6, 0x1p-3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, - -0x1.4125feacab7cep-5, 0x1p-3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, - -0x1.a55beda63cc14p-5, 0x1p-3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, - -0x1.35230c0fbe402p-10, 0x1p-4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, - -0x1.b82683bc89fbp-7, 0x1p-4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, - -0x1.a4f3514d75466p-6, 0x1p-4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, - -0x1.b7aa821726608p-8, 0x1p-5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, - -0x1.b78b80c84e1eep-9, 0x1p-6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, -}; -}} // namespace {namespace} -#endif // NPSR_TRIG_DATA_LARGE_APROX_H_PY diff --git a/npsr/trig/data/large-aprox.h.py b/npsr/trig/data/large-aprox.h.py deleted file mode 100644 index 5b271bd..0000000 --- a/npsr/trig/data/large-aprox.h.py +++ /dev/null @@ -1,52 +0,0 @@ -from itertools import chain -from generator import c_array, c_header, sollya - - -def gen_approx(float_size, func, func_driv): - n = 1 << (8 if float_size == 32 else 9) - trunc_upper, cast = ( - ("p2", "single") if float_size == 32 else ("round(p2, 24, RZ)", "double") - ) - return sollya( - f""" - prec = {float_size*4}; - display = hexadecimal; - cast = {cast}(x); - func = {func}(x); - scale = 2.0 * pi / {n}; - for e from 0 to {n - 1} do {{ - theta = e * scale; - p1 = cast(func(theta)); - p2 = cast(func(theta) - p1); - p2 = {trunc_upper}; - deriv = {func_driv}(theta); - k = ceil(log2(abs(deriv))); - if (deriv < 0) then {{ - k = -k; - }}; - p3 = 2.0^k; - p0 = cast(deriv - p3); - p0;p3;p1;p2; - }}; - """ - ) - - -print( - c_header( - "template constexpr T kSinApproxTable[] = {};", - "template constexpr T kCosApproxTable[] = {};", - *chain.from_iterable( - [ - ( - f"template <> constexpr {T} kSinApproxTable<{T}>[] = " - + c_array(gen_approx(size, "sin", "cos"), col=4, sfx=sfx), - f"template <> constexpr {T} kCosApproxTable<{T}>[] = " - + c_array(gen_approx(size, "cos", "-sin"), col=4, sfx=sfx), - ) - for size, T, sfx in [(32, "float", "f"), (64, "double", "")] - ] - ), - namespace="npsr::trig::data", - ) -) diff --git a/npsr/trig/data/large-reduction.h b/npsr/trig/data/large-reduction.h deleted file mode 100644 index 758f079..0000000 --- a/npsr/trig/data/large-reduction.h +++ /dev/null @@ -1,2316 +0,0 @@ -// Do not edit this file, it is generated by npsr/trig/data/large-reduction.h.py -// use `spin generate -f` to force regeneration -#ifndef NPSR_TRIG_DATA_LARGE_REDUCTION_H_PY -#define NPSR_TRIG_DATA_LARGE_REDUCTION_H_PY -namespace npsr::trig::data { namespace { -template constexpr T kLargeReductionTable[] = {}; -template <> constexpr uint32_t kLargeReductionTable[] = { - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x0U, - 0x0U, 0x0U, 0x1U, - 0x0U, 0x0U, 0x2U, - 0x0U, 0x0U, 0x5U, - 0x0U, 0x0U, 0xaU, - 0x0U, 0x0U, 0x14U, - 0x0U, 0x0U, 0x28U, - 0x0U, 0x0U, 0x51U, - 0x0U, 0x0U, 0xa2U, - 0x0U, 0x0U, 0x145U, - 0x0U, 0x0U, 0x28bU, - 0x0U, 0x0U, 0x517U, - 0x0U, 0x0U, 0xa2fU, - 0x0U, 0x0U, 0x145fU, - 0x0U, 0x0U, 0x28beU, - 0x0U, 0x0U, 0x517cU, - 0x0U, 0x0U, 0xa2f9U, - 0x0U, 0x0U, 0x145f3U, - 0x0U, 0x0U, 0x28be6U, - 0x0U, 0x0U, 0x517ccU, - 0x0U, 0x0U, 0xa2f98U, - 0x0U, 0x0U, 0x145f30U, - 0x0U, 0x0U, 0x28be60U, - 0x0U, 0x0U, 0x517cc1U, - 0x0U, 0x0U, 0xa2f983U, - 0x0U, 0x0U, 0x145f306U, - 0x0U, 0x0U, 0x28be60dU, - 0x0U, 0x0U, 0x517cc1bU, - 0x0U, 0x0U, 0xa2f9836U, - 0x0U, 0x0U, 0x145f306dU, - 0x0U, 0x0U, 0x28be60dbU, - 0x0U, 0x0U, 0x517cc1b7U, - 0x0U, 0x0U, 0xa2f9836eU, - 0x0U, 0x1U, 0x45f306dcU, - 0x0U, 0x2U, 0x8be60db9U, - 0x0U, 0x5U, 0x17cc1b72U, - 0x0U, 0xaU, 0x2f9836e4U, - 0x0U, 0x14U, 0x5f306dc9U, - 0x0U, 0x28U, 0xbe60db93U, - 0x0U, 0x51U, 0x7cc1b727U, - 0x0U, 0xa2U, 0xf9836e4eU, - 0x0U, 0x145U, 0xf306dc9cU, - 0x0U, 0x28bU, 0xe60db939U, - 0x0U, 0x517U, 0xcc1b7272U, - 0x0U, 0xa2fU, 0x9836e4e4U, - 0x0U, 0x145fU, 0x306dc9c8U, - 0x0U, 0x28beU, 0x60db9391U, - 0x0U, 0x517cU, 0xc1b72722U, - 0x0U, 0xa2f9U, 0x836e4e44U, - 0x0U, 0x145f3U, 0x6dc9c88U, - 0x0U, 0x28be6U, 0xdb93910U, - 0x0U, 0x517ccU, 0x1b727220U, - 0x0U, 0xa2f98U, 0x36e4e441U, - 0x0U, 0x145f30U, 0x6dc9c882U, - 0x0U, 0x28be60U, 0xdb939105U, - 0x0U, 0x517cc1U, 0xb727220aU, - 0x0U, 0xa2f983U, 0x6e4e4415U, - 0x0U, 0x145f306U, 0xdc9c882aU, - 0x0U, 0x28be60dU, 0xb9391054U, - 0x0U, 0x517cc1bU, 0x727220a9U, - 0x0U, 0xa2f9836U, 0xe4e44152U, - 0x0U, 0x145f306dU, 0xc9c882a5U, - 0x0U, 0x28be60dbU, 0x9391054aU, - 0x0U, 0x517cc1b7U, 0x27220a94U, - 0x0U, 0xa2f9836eU, 0x4e441529U, - 0x1U, 0x45f306dcU, 0x9c882a53U, - 0x2U, 0x8be60db9U, 0x391054a7U, - 0x5U, 0x17cc1b72U, 0x7220a94fU, - 0xaU, 0x2f9836e4U, 0xe441529fU, - 0x14U, 0x5f306dc9U, 0xc882a53fU, - 0x28U, 0xbe60db93U, 0x91054a7fU, - 0x51U, 0x7cc1b727U, 0x220a94feU, - 0xa2U, 0xf9836e4eU, 0x441529fcU, - 0x145U, 0xf306dc9cU, 0x882a53f8U, - 0x28bU, 0xe60db939U, 0x1054a7f0U, - 0x517U, 0xcc1b7272U, 0x20a94fe1U, - 0xa2fU, 0x9836e4e4U, 0x41529fc2U, - 0x145fU, 0x306dc9c8U, 0x82a53f84U, - 0x28beU, 0x60db9391U, 0x54a7f09U, - 0x517cU, 0xc1b72722U, 0xa94fe13U, - 0xa2f9U, 0x836e4e44U, 0x1529fc27U, - 0x145f3U, 0x6dc9c88U, 0x2a53f84eU, - 0x28be6U, 0xdb93910U, 0x54a7f09dU, - 0x517ccU, 0x1b727220U, 0xa94fe13aU, - 0xa2f98U, 0x36e4e441U, 0x529fc275U, - 0x145f30U, 0x6dc9c882U, 0xa53f84eaU, - 0x28be60U, 0xdb939105U, 0x4a7f09d5U, - 0x517cc1U, 0xb727220aU, 0x94fe13abU, - 0xa2f983U, 0x6e4e4415U, 0x29fc2757U, - 0x145f306U, 0xdc9c882aU, 0x53f84eafU, - 0x28be60dU, 0xb9391054U, 0xa7f09d5fU, - 0x517cc1bU, 0x727220a9U, 0x4fe13abeU, - 0xa2f9836U, 0xe4e44152U, 0x9fc2757dU, - 0x145f306dU, 0xc9c882a5U, 0x3f84eafaU, - 0x28be60dbU, 0x9391054aU, 0x7f09d5f4U, - 0x517cc1b7U, 0x27220a94U, 0xfe13abe8U, - 0xa2f9836eU, 0x4e441529U, 0xfc2757d1U, - 0x45f306dcU, 0x9c882a53U, 0xf84eafa3U, - 0x8be60db9U, 0x391054a7U, 0xf09d5f47U, - 0x17cc1b72U, 0x7220a94fU, 0xe13abe8fU, - 0x2f9836e4U, 0xe441529fU, 0xc2757d1fU, - 0x5f306dc9U, 0xc882a53fU, 0x84eafa3eU, - 0xbe60db93U, 0x91054a7fU, 0x9d5f47dU, - 0x7cc1b727U, 0x220a94feU, 0x13abe8faU, - 0xf9836e4eU, 0x441529fcU, 0x2757d1f5U, - 0xf306dc9cU, 0x882a53f8U, 0x4eafa3eaU, - 0xe60db939U, 0x1054a7f0U, 0x9d5f47d4U, - 0xcc1b7272U, 0x20a94fe1U, 0x3abe8fa9U, - 0x9836e4e4U, 0x41529fc2U, 0x757d1f53U, - 0x306dc9c8U, 0x82a53f84U, 0xeafa3ea6U, - 0x60db9391U, 0x54a7f09U, 0xd5f47d4dU, - 0xc1b72722U, 0xa94fe13U, 0xabe8fa9aU, - 0x836e4e44U, 0x1529fc27U, 0x57d1f534U, - 0x6dc9c88U, 0x2a53f84eU, 0xafa3ea69U, - 0xdb93910U, 0x54a7f09dU, 0x5f47d4d3U, - 0x1b727220U, 0xa94fe13aU, 0xbe8fa9a6U, - 0x36e4e441U, 0x529fc275U, 0x7d1f534dU, - 0x6dc9c882U, 0xa53f84eaU, 0xfa3ea69bU, - 0xdb939105U, 0x4a7f09d5U, 0xf47d4d37U, - 0xb727220aU, 0x94fe13abU, 0xe8fa9a6eU, - 0x6e4e4415U, 0x29fc2757U, 0xd1f534ddU, - 0xdc9c882aU, 0x53f84eafU, 0xa3ea69bbU, - 0xb9391054U, 0xa7f09d5fU, 0x47d4d377U, - 0x727220a9U, 0x4fe13abeU, 0x8fa9a6eeU, - 0xe4e44152U, 0x9fc2757dU, 0x1f534ddcU, - 0xc9c882a5U, 0x3f84eafaU, 0x3ea69bb8U, - 0x9391054aU, 0x7f09d5f4U, 0x7d4d3770U, - 0x27220a94U, 0xfe13abe8U, 0xfa9a6ee0U, - 0x4e441529U, 0xfc2757d1U, 0xf534ddc0U, - 0x9c882a53U, 0xf84eafa3U, 0xea69bb81U, - 0x391054a7U, 0xf09d5f47U, 0xd4d37703U, - 0x7220a94fU, 0xe13abe8fU, 0xa9a6ee06U, - 0xe441529fU, 0xc2757d1fU, 0x534ddc0dU, - 0xc882a53fU, 0x84eafa3eU, 0xa69bb81bU, - 0x91054a7fU, 0x9d5f47dU, 0x4d377036U, - 0x220a94feU, 0x13abe8faU, 0x9a6ee06dU, - 0x441529fcU, 0x2757d1f5U, 0x34ddc0dbU, - 0x882a53f8U, 0x4eafa3eaU, 0x69bb81b6U, - 0x1054a7f0U, 0x9d5f47d4U, 0xd377036dU, - 0x20a94fe1U, 0x3abe8fa9U, 0xa6ee06dbU, - 0x41529fc2U, 0x757d1f53U, 0x4ddc0db6U, - 0x82a53f84U, 0xeafa3ea6U, 0x9bb81b6cU, - 0x54a7f09U, 0xd5f47d4dU, 0x377036d8U, - 0xa94fe13U, 0xabe8fa9aU, 0x6ee06db1U, - 0x1529fc27U, 0x57d1f534U, 0xddc0db62U, - 0x2a53f84eU, 0xafa3ea69U, 0xbb81b6c5U, - 0x54a7f09dU, 0x5f47d4d3U, 0x77036d8aU, - 0xa94fe13aU, 0xbe8fa9a6U, 0xee06db14U, - 0x529fc275U, 0x7d1f534dU, 0xdc0db629U, - 0xa53f84eaU, 0xfa3ea69bU, 0xb81b6c52U, - 0x4a7f09d5U, 0xf47d4d37U, 0x7036d8a5U, - 0x94fe13abU, 0xe8fa9a6eU, 0xe06db14aU, - 0x29fc2757U, 0xd1f534ddU, 0xc0db6295U, - 0x53f84eafU, 0xa3ea69bbU, 0x81b6c52bU, - 0xa7f09d5fU, 0x47d4d377U, 0x36d8a56U, - 0x4fe13abeU, 0x8fa9a6eeU, 0x6db14acU, - 0x9fc2757dU, 0x1f534ddcU, 0xdb62959U, - 0x3f84eafaU, 0x3ea69bb8U, 0x1b6c52b3U, - 0x7f09d5f4U, 0x7d4d3770U, 0x36d8a566U, - 0xfe13abe8U, 0xfa9a6ee0U, 0x6db14accU, - 0xfc2757d1U, 0xf534ddc0U, 0xdb629599U, - 0xf84eafa3U, 0xea69bb81U, 0xb6c52b32U, - 0xf09d5f47U, 0xd4d37703U, 0x6d8a5664U, - 0xe13abe8fU, 0xa9a6ee06U, 0xdb14acc9U, - 0xc2757d1fU, 0x534ddc0dU, 0xb6295993U, - 0x84eafa3eU, 0xa69bb81bU, 0x6c52b327U, - 0x9d5f47dU, 0x4d377036U, 0xd8a5664fU, - 0x13abe8faU, 0x9a6ee06dU, 0xb14acc9eU, - 0x2757d1f5U, 0x34ddc0dbU, 0x6295993cU, - 0x4eafa3eaU, 0x69bb81b6U, 0xc52b3278U, - 0x9d5f47d4U, 0xd377036dU, 0x8a5664f1U, - 0x3abe8fa9U, 0xa6ee06dbU, 0x14acc9e2U, - 0x757d1f53U, 0x4ddc0db6U, 0x295993c4U, - 0xeafa3ea6U, 0x9bb81b6cU, 0x52b32788U, - 0xd5f47d4dU, 0x377036d8U, 0xa5664f10U, - 0xabe8fa9aU, 0x6ee06db1U, 0x4acc9e21U, - 0x57d1f534U, 0xddc0db62U, 0x95993c43U, - 0xafa3ea69U, 0xbb81b6c5U, 0x2b327887U, - 0x5f47d4d3U, 0x77036d8aU, 0x5664f10eU, - 0xbe8fa9a6U, 0xee06db14U, 0xacc9e21cU, - 0x7d1f534dU, 0xdc0db629U, 0x5993c439U, - 0xfa3ea69bU, 0xb81b6c52U, 0xb3278872U, - 0xf47d4d37U, 0x7036d8a5U, 0x664f10e4U, - 0xe8fa9a6eU, 0xe06db14aU, 0xcc9e21c8U, - 0xd1f534ddU, 0xc0db6295U, 0x993c4390U, - 0xa3ea69bbU, 0x81b6c52bU, 0x32788720U, - 0x47d4d377U, 0x36d8a56U, 0x64f10e41U, - 0x8fa9a6eeU, 0x6db14acU, 0xc9e21c82U, - 0x1f534ddcU, 0xdb62959U, 0x93c43904U, - 0x3ea69bb8U, 0x1b6c52b3U, 0x27887208U, - 0x7d4d3770U, 0x36d8a566U, 0x4f10e410U, - 0xfa9a6ee0U, 0x6db14accU, 0x9e21c820U, - 0xf534ddc0U, 0xdb629599U, 0x3c439041U, - 0xea69bb81U, 0xb6c52b32U, 0x78872083U, - 0xd4d37703U, 0x6d8a5664U, 0xf10e4107U, - 0xa9a6ee06U, 0xdb14acc9U, 0xe21c820fU, - 0x534ddc0dU, 0xb6295993U, 0xc439041fU, - 0xa69bb81bU, 0x6c52b327U, 0x8872083fU, - 0x4d377036U, 0xd8a5664fU, 0x10e4107fU, - 0x9a6ee06dU, 0xb14acc9eU, 0x21c82100U, -}; -template <> constexpr uint64_t kLargeReductionTable[] = { - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x0ULL, - 0x0ULL, 0x0ULL, 0x1ULL, - 0x0ULL, 0x0ULL, 0x2ULL, - 0x0ULL, 0x0ULL, 0x5ULL, - 0x0ULL, 0x0ULL, 0xaULL, - 0x0ULL, 0x0ULL, 0x14ULL, - 0x0ULL, 0x0ULL, 0x28ULL, - 0x0ULL, 0x0ULL, 0x51ULL, - 0x0ULL, 0x0ULL, 0xa2ULL, - 0x0ULL, 0x0ULL, 0x145ULL, - 0x0ULL, 0x0ULL, 0x28bULL, - 0x0ULL, 0x0ULL, 0x517ULL, - 0x0ULL, 0x0ULL, 0xa2fULL, - 0x0ULL, 0x0ULL, 0x145fULL, - 0x0ULL, 0x0ULL, 0x28beULL, - 0x0ULL, 0x0ULL, 0x517cULL, - 0x0ULL, 0x0ULL, 0xa2f9ULL, - 0x0ULL, 0x0ULL, 0x145f3ULL, - 0x0ULL, 0x0ULL, 0x28be6ULL, - 0x0ULL, 0x0ULL, 0x517ccULL, - 0x0ULL, 0x0ULL, 0xa2f98ULL, - 0x0ULL, 0x0ULL, 0x145f30ULL, - 0x0ULL, 0x0ULL, 0x28be60ULL, - 0x0ULL, 0x0ULL, 0x517cc1ULL, - 0x0ULL, 0x0ULL, 0xa2f983ULL, - 0x0ULL, 0x0ULL, 0x145f306ULL, - 0x0ULL, 0x0ULL, 0x28be60dULL, - 0x0ULL, 0x0ULL, 0x517cc1bULL, - 0x0ULL, 0x0ULL, 0xa2f9836ULL, - 0x0ULL, 0x0ULL, 0x145f306dULL, - 0x0ULL, 0x0ULL, 0x28be60dbULL, - 0x0ULL, 0x0ULL, 0x517cc1b7ULL, - 0x0ULL, 0x0ULL, 0xa2f9836eULL, - 0x0ULL, 0x0ULL, 0x145f306dcULL, - 0x0ULL, 0x0ULL, 0x28be60db9ULL, - 0x0ULL, 0x0ULL, 0x517cc1b72ULL, - 0x0ULL, 0x0ULL, 0xa2f9836e4ULL, - 0x0ULL, 0x0ULL, 0x145f306dc9ULL, - 0x0ULL, 0x0ULL, 0x28be60db93ULL, - 0x0ULL, 0x0ULL, 0x517cc1b727ULL, - 0x0ULL, 0x0ULL, 0xa2f9836e4eULL, - 0x0ULL, 0x0ULL, 0x145f306dc9cULL, - 0x0ULL, 0x0ULL, 0x28be60db939ULL, - 0x0ULL, 0x0ULL, 0x517cc1b7272ULL, - 0x0ULL, 0x0ULL, 0xa2f9836e4e4ULL, - 0x0ULL, 0x0ULL, 0x145f306dc9c8ULL, - 0x0ULL, 0x0ULL, 0x28be60db9391ULL, - 0x0ULL, 0x0ULL, 0x517cc1b72722ULL, - 0x0ULL, 0x0ULL, 0xa2f9836e4e44ULL, - 0x0ULL, 0x0ULL, 0x145f306dc9c88ULL, - 0x0ULL, 0x0ULL, 0x28be60db93910ULL, - 0x0ULL, 0x0ULL, 0x517cc1b727220ULL, - 0x0ULL, 0x0ULL, 0xa2f9836e4e441ULL, - 0x0ULL, 0x0ULL, 0x145f306dc9c882ULL, - 0x0ULL, 0x0ULL, 0x28be60db939105ULL, - 0x0ULL, 0x0ULL, 0x517cc1b727220aULL, - 0x0ULL, 0x0ULL, 0xa2f9836e4e4415ULL, - 0x0ULL, 0x0ULL, 0x145f306dc9c882aULL, - 0x0ULL, 0x0ULL, 0x28be60db9391054ULL, - 0x0ULL, 0x0ULL, 0x517cc1b727220a9ULL, - 0x0ULL, 0x0ULL, 0xa2f9836e4e44152ULL, - 0x0ULL, 0x0ULL, 0x145f306dc9c882a5ULL, - 0x0ULL, 0x0ULL, 0x28be60db9391054aULL, - 0x0ULL, 0x0ULL, 0x517cc1b727220a94ULL, - 0x0ULL, 0x0ULL, 0xa2f9836e4e441529ULL, - 0x0ULL, 0x1ULL, 0x45f306dc9c882a53ULL, - 0x0ULL, 0x2ULL, 0x8be60db9391054a7ULL, - 0x0ULL, 0x5ULL, 0x17cc1b727220a94fULL, - 0x0ULL, 0xaULL, 0x2f9836e4e441529fULL, - 0x0ULL, 0x14ULL, 0x5f306dc9c882a53fULL, - 0x0ULL, 0x28ULL, 0xbe60db9391054a7fULL, - 0x0ULL, 0x51ULL, 0x7cc1b727220a94feULL, - 0x0ULL, 0xa2ULL, 0xf9836e4e441529fcULL, - 0x0ULL, 0x145ULL, 0xf306dc9c882a53f8ULL, - 0x0ULL, 0x28bULL, 0xe60db9391054a7f0ULL, - 0x0ULL, 0x517ULL, 0xcc1b727220a94fe1ULL, - 0x0ULL, 0xa2fULL, 0x9836e4e441529fc2ULL, - 0x0ULL, 0x145fULL, 0x306dc9c882a53f84ULL, - 0x0ULL, 0x28beULL, 0x60db9391054a7f09ULL, - 0x0ULL, 0x517cULL, 0xc1b727220a94fe13ULL, - 0x0ULL, 0xa2f9ULL, 0x836e4e441529fc27ULL, - 0x0ULL, 0x145f3ULL, 0x6dc9c882a53f84eULL, - 0x0ULL, 0x28be6ULL, 0xdb9391054a7f09dULL, - 0x0ULL, 0x517ccULL, 0x1b727220a94fe13aULL, - 0x0ULL, 0xa2f98ULL, 0x36e4e441529fc275ULL, - 0x0ULL, 0x145f30ULL, 0x6dc9c882a53f84eaULL, - 0x0ULL, 0x28be60ULL, 0xdb9391054a7f09d5ULL, - 0x0ULL, 0x517cc1ULL, 0xb727220a94fe13abULL, - 0x0ULL, 0xa2f983ULL, 0x6e4e441529fc2757ULL, - 0x0ULL, 0x145f306ULL, 0xdc9c882a53f84eafULL, - 0x0ULL, 0x28be60dULL, 0xb9391054a7f09d5fULL, - 0x0ULL, 0x517cc1bULL, 0x727220a94fe13abeULL, - 0x0ULL, 0xa2f9836ULL, 0xe4e441529fc2757dULL, - 0x0ULL, 0x145f306dULL, 0xc9c882a53f84eafaULL, - 0x0ULL, 0x28be60dbULL, 0x9391054a7f09d5f4ULL, - 0x0ULL, 0x517cc1b7ULL, 0x27220a94fe13abe8ULL, - 0x0ULL, 0xa2f9836eULL, 0x4e441529fc2757d1ULL, - 0x0ULL, 0x145f306dcULL, 0x9c882a53f84eafa3ULL, - 0x0ULL, 0x28be60db9ULL, 0x391054a7f09d5f47ULL, - 0x0ULL, 0x517cc1b72ULL, 0x7220a94fe13abe8fULL, - 0x0ULL, 0xa2f9836e4ULL, 0xe441529fc2757d1fULL, - 0x0ULL, 0x145f306dc9ULL, 0xc882a53f84eafa3eULL, - 0x0ULL, 0x28be60db93ULL, 0x91054a7f09d5f47dULL, - 0x0ULL, 0x517cc1b727ULL, 0x220a94fe13abe8faULL, - 0x0ULL, 0xa2f9836e4eULL, 0x441529fc2757d1f5ULL, - 0x0ULL, 0x145f306dc9cULL, 0x882a53f84eafa3eaULL, - 0x0ULL, 0x28be60db939ULL, 0x1054a7f09d5f47d4ULL, - 0x0ULL, 0x517cc1b7272ULL, 0x20a94fe13abe8fa9ULL, - 0x0ULL, 0xa2f9836e4e4ULL, 0x41529fc2757d1f53ULL, - 0x0ULL, 0x145f306dc9c8ULL, 0x82a53f84eafa3ea6ULL, - 0x0ULL, 0x28be60db9391ULL, 0x54a7f09d5f47d4dULL, - 0x0ULL, 0x517cc1b72722ULL, 0xa94fe13abe8fa9aULL, - 0x0ULL, 0xa2f9836e4e44ULL, 0x1529fc2757d1f534ULL, - 0x0ULL, 0x145f306dc9c88ULL, 0x2a53f84eafa3ea69ULL, - 0x0ULL, 0x28be60db93910ULL, 0x54a7f09d5f47d4d3ULL, - 0x0ULL, 0x517cc1b727220ULL, 0xa94fe13abe8fa9a6ULL, - 0x0ULL, 0xa2f9836e4e441ULL, 0x529fc2757d1f534dULL, - 0x0ULL, 0x145f306dc9c882ULL, 0xa53f84eafa3ea69bULL, - 0x0ULL, 0x28be60db939105ULL, 0x4a7f09d5f47d4d37ULL, - 0x0ULL, 0x517cc1b727220aULL, 0x94fe13abe8fa9a6eULL, - 0x0ULL, 0xa2f9836e4e4415ULL, 0x29fc2757d1f534ddULL, - 0x0ULL, 0x145f306dc9c882aULL, 0x53f84eafa3ea69bbULL, - 0x0ULL, 0x28be60db9391054ULL, 0xa7f09d5f47d4d377ULL, - 0x0ULL, 0x517cc1b727220a9ULL, 0x4fe13abe8fa9a6eeULL, - 0x0ULL, 0xa2f9836e4e44152ULL, 0x9fc2757d1f534ddcULL, - 0x0ULL, 0x145f306dc9c882a5ULL, 0x3f84eafa3ea69bb8ULL, - 0x0ULL, 0x28be60db9391054aULL, 0x7f09d5f47d4d3770ULL, - 0x0ULL, 0x517cc1b727220a94ULL, 0xfe13abe8fa9a6ee0ULL, - 0x0ULL, 0xa2f9836e4e441529ULL, 0xfc2757d1f534ddc0ULL, - 0x1ULL, 0x45f306dc9c882a53ULL, 0xf84eafa3ea69bb81ULL, - 0x2ULL, 0x8be60db9391054a7ULL, 0xf09d5f47d4d37703ULL, - 0x5ULL, 0x17cc1b727220a94fULL, 0xe13abe8fa9a6ee06ULL, - 0xaULL, 0x2f9836e4e441529fULL, 0xc2757d1f534ddc0dULL, - 0x14ULL, 0x5f306dc9c882a53fULL, 0x84eafa3ea69bb81bULL, - 0x28ULL, 0xbe60db9391054a7fULL, 0x9d5f47d4d377036ULL, - 0x51ULL, 0x7cc1b727220a94feULL, 0x13abe8fa9a6ee06dULL, - 0xa2ULL, 0xf9836e4e441529fcULL, 0x2757d1f534ddc0dbULL, - 0x145ULL, 0xf306dc9c882a53f8ULL, 0x4eafa3ea69bb81b6ULL, - 0x28bULL, 0xe60db9391054a7f0ULL, 0x9d5f47d4d377036dULL, - 0x517ULL, 0xcc1b727220a94fe1ULL, 0x3abe8fa9a6ee06dbULL, - 0xa2fULL, 0x9836e4e441529fc2ULL, 0x757d1f534ddc0db6ULL, - 0x145fULL, 0x306dc9c882a53f84ULL, 0xeafa3ea69bb81b6cULL, - 0x28beULL, 0x60db9391054a7f09ULL, 0xd5f47d4d377036d8ULL, - 0x517cULL, 0xc1b727220a94fe13ULL, 0xabe8fa9a6ee06db1ULL, - 0xa2f9ULL, 0x836e4e441529fc27ULL, 0x57d1f534ddc0db62ULL, - 0x145f3ULL, 0x6dc9c882a53f84eULL, 0xafa3ea69bb81b6c5ULL, - 0x28be6ULL, 0xdb9391054a7f09dULL, 0x5f47d4d377036d8aULL, - 0x517ccULL, 0x1b727220a94fe13aULL, 0xbe8fa9a6ee06db14ULL, - 0xa2f98ULL, 0x36e4e441529fc275ULL, 0x7d1f534ddc0db629ULL, - 0x145f30ULL, 0x6dc9c882a53f84eaULL, 0xfa3ea69bb81b6c52ULL, - 0x28be60ULL, 0xdb9391054a7f09d5ULL, 0xf47d4d377036d8a5ULL, - 0x517cc1ULL, 0xb727220a94fe13abULL, 0xe8fa9a6ee06db14aULL, - 0xa2f983ULL, 0x6e4e441529fc2757ULL, 0xd1f534ddc0db6295ULL, - 0x145f306ULL, 0xdc9c882a53f84eafULL, 0xa3ea69bb81b6c52bULL, - 0x28be60dULL, 0xb9391054a7f09d5fULL, 0x47d4d377036d8a56ULL, - 0x517cc1bULL, 0x727220a94fe13abeULL, 0x8fa9a6ee06db14acULL, - 0xa2f9836ULL, 0xe4e441529fc2757dULL, 0x1f534ddc0db62959ULL, - 0x145f306dULL, 0xc9c882a53f84eafaULL, 0x3ea69bb81b6c52b3ULL, - 0x28be60dbULL, 0x9391054a7f09d5f4ULL, 0x7d4d377036d8a566ULL, - 0x517cc1b7ULL, 0x27220a94fe13abe8ULL, 0xfa9a6ee06db14accULL, - 0xa2f9836eULL, 0x4e441529fc2757d1ULL, 0xf534ddc0db629599ULL, - 0x145f306dcULL, 0x9c882a53f84eafa3ULL, 0xea69bb81b6c52b32ULL, - 0x28be60db9ULL, 0x391054a7f09d5f47ULL, 0xd4d377036d8a5664ULL, - 0x517cc1b72ULL, 0x7220a94fe13abe8fULL, 0xa9a6ee06db14acc9ULL, - 0xa2f9836e4ULL, 0xe441529fc2757d1fULL, 0x534ddc0db6295993ULL, - 0x145f306dc9ULL, 0xc882a53f84eafa3eULL, 0xa69bb81b6c52b327ULL, - 0x28be60db93ULL, 0x91054a7f09d5f47dULL, 0x4d377036d8a5664fULL, - 0x517cc1b727ULL, 0x220a94fe13abe8faULL, 0x9a6ee06db14acc9eULL, - 0xa2f9836e4eULL, 0x441529fc2757d1f5ULL, 0x34ddc0db6295993cULL, - 0x145f306dc9cULL, 0x882a53f84eafa3eaULL, 0x69bb81b6c52b3278ULL, - 0x28be60db939ULL, 0x1054a7f09d5f47d4ULL, 0xd377036d8a5664f1ULL, - 0x517cc1b7272ULL, 0x20a94fe13abe8fa9ULL, 0xa6ee06db14acc9e2ULL, - 0xa2f9836e4e4ULL, 0x41529fc2757d1f53ULL, 0x4ddc0db6295993c4ULL, - 0x145f306dc9c8ULL, 0x82a53f84eafa3ea6ULL, 0x9bb81b6c52b32788ULL, - 0x28be60db9391ULL, 0x54a7f09d5f47d4dULL, 0x377036d8a5664f10ULL, - 0x517cc1b72722ULL, 0xa94fe13abe8fa9aULL, 0x6ee06db14acc9e21ULL, - 0xa2f9836e4e44ULL, 0x1529fc2757d1f534ULL, 0xddc0db6295993c43ULL, - 0x145f306dc9c88ULL, 0x2a53f84eafa3ea69ULL, 0xbb81b6c52b327887ULL, - 0x28be60db93910ULL, 0x54a7f09d5f47d4d3ULL, 0x77036d8a5664f10eULL, - 0x517cc1b727220ULL, 0xa94fe13abe8fa9a6ULL, 0xee06db14acc9e21cULL, - 0xa2f9836e4e441ULL, 0x529fc2757d1f534dULL, 0xdc0db6295993c439ULL, - 0x145f306dc9c882ULL, 0xa53f84eafa3ea69bULL, 0xb81b6c52b3278872ULL, - 0x28be60db939105ULL, 0x4a7f09d5f47d4d37ULL, 0x7036d8a5664f10e4ULL, - 0x517cc1b727220aULL, 0x94fe13abe8fa9a6eULL, 0xe06db14acc9e21c8ULL, - 0xa2f9836e4e4415ULL, 0x29fc2757d1f534ddULL, 0xc0db6295993c4390ULL, - 0x145f306dc9c882aULL, 0x53f84eafa3ea69bbULL, 0x81b6c52b32788720ULL, - 0x28be60db9391054ULL, 0xa7f09d5f47d4d377ULL, 0x36d8a5664f10e41ULL, - 0x517cc1b727220a9ULL, 0x4fe13abe8fa9a6eeULL, 0x6db14acc9e21c82ULL, - 0xa2f9836e4e44152ULL, 0x9fc2757d1f534ddcULL, 0xdb6295993c43904ULL, - 0x145f306dc9c882a5ULL, 0x3f84eafa3ea69bb8ULL, 0x1b6c52b327887208ULL, - 0x28be60db9391054aULL, 0x7f09d5f47d4d3770ULL, 0x36d8a5664f10e410ULL, - 0x517cc1b727220a94ULL, 0xfe13abe8fa9a6ee0ULL, 0x6db14acc9e21c820ULL, - 0xa2f9836e4e441529ULL, 0xfc2757d1f534ddc0ULL, 0xdb6295993c439041ULL, - 0x45f306dc9c882a53ULL, 0xf84eafa3ea69bb81ULL, 0xb6c52b3278872083ULL, - 0x8be60db9391054a7ULL, 0xf09d5f47d4d37703ULL, 0x6d8a5664f10e4107ULL, - 0x17cc1b727220a94fULL, 0xe13abe8fa9a6ee06ULL, 0xdb14acc9e21c820fULL, - 0x2f9836e4e441529fULL, 0xc2757d1f534ddc0dULL, 0xb6295993c439041fULL, - 0x5f306dc9c882a53fULL, 0x84eafa3ea69bb81bULL, 0x6c52b3278872083fULL, - 0xbe60db9391054a7fULL, 0x9d5f47d4d377036ULL, 0xd8a5664f10e4107fULL, - 0x7cc1b727220a94feULL, 0x13abe8fa9a6ee06dULL, 0xb14acc9e21c820ffULL, - 0xf9836e4e441529fcULL, 0x2757d1f534ddc0dbULL, 0x6295993c439041feULL, - 0xf306dc9c882a53f8ULL, 0x4eafa3ea69bb81b6ULL, 0xc52b3278872083fcULL, - 0xe60db9391054a7f0ULL, 0x9d5f47d4d377036dULL, 0x8a5664f10e4107f9ULL, - 0xcc1b727220a94fe1ULL, 0x3abe8fa9a6ee06dbULL, 0x14acc9e21c820ff2ULL, - 0x9836e4e441529fc2ULL, 0x757d1f534ddc0db6ULL, 0x295993c439041fe5ULL, - 0x306dc9c882a53f84ULL, 0xeafa3ea69bb81b6cULL, 0x52b3278872083fcaULL, - 0x60db9391054a7f09ULL, 0xd5f47d4d377036d8ULL, 0xa5664f10e4107f94ULL, - 0xc1b727220a94fe13ULL, 0xabe8fa9a6ee06db1ULL, 0x4acc9e21c820ff28ULL, - 0x836e4e441529fc27ULL, 0x57d1f534ddc0db62ULL, 0x95993c439041fe51ULL, - 0x6dc9c882a53f84eULL, 0xafa3ea69bb81b6c5ULL, 0x2b3278872083fca2ULL, - 0xdb9391054a7f09dULL, 0x5f47d4d377036d8aULL, 0x5664f10e4107f945ULL, - 0x1b727220a94fe13aULL, 0xbe8fa9a6ee06db14ULL, 0xacc9e21c820ff28bULL, - 0x36e4e441529fc275ULL, 0x7d1f534ddc0db629ULL, 0x5993c439041fe516ULL, - 0x6dc9c882a53f84eaULL, 0xfa3ea69bb81b6c52ULL, 0xb3278872083fca2cULL, - 0xdb9391054a7f09d5ULL, 0xf47d4d377036d8a5ULL, 0x664f10e4107f9458ULL, - 0xb727220a94fe13abULL, 0xe8fa9a6ee06db14aULL, 0xcc9e21c820ff28b1ULL, - 0x6e4e441529fc2757ULL, 0xd1f534ddc0db6295ULL, 0x993c439041fe5163ULL, - 0xdc9c882a53f84eafULL, 0xa3ea69bb81b6c52bULL, 0x3278872083fca2c7ULL, - 0xb9391054a7f09d5fULL, 0x47d4d377036d8a56ULL, 0x64f10e4107f9458eULL, - 0x727220a94fe13abeULL, 0x8fa9a6ee06db14acULL, 0xc9e21c820ff28b1dULL, - 0xe4e441529fc2757dULL, 0x1f534ddc0db62959ULL, 0x93c439041fe5163aULL, - 0xc9c882a53f84eafaULL, 0x3ea69bb81b6c52b3ULL, 0x278872083fca2c75ULL, - 0x9391054a7f09d5f4ULL, 0x7d4d377036d8a566ULL, 0x4f10e4107f9458eaULL, - 0x27220a94fe13abe8ULL, 0xfa9a6ee06db14accULL, 0x9e21c820ff28b1d5ULL, - 0x4e441529fc2757d1ULL, 0xf534ddc0db629599ULL, 0x3c439041fe5163abULL, - 0x9c882a53f84eafa3ULL, 0xea69bb81b6c52b32ULL, 0x78872083fca2c757ULL, - 0x391054a7f09d5f47ULL, 0xd4d377036d8a5664ULL, 0xf10e4107f9458eafULL, - 0x7220a94fe13abe8fULL, 0xa9a6ee06db14acc9ULL, 0xe21c820ff28b1d5eULL, - 0xe441529fc2757d1fULL, 0x534ddc0db6295993ULL, 0xc439041fe5163abdULL, - 0xc882a53f84eafa3eULL, 0xa69bb81b6c52b327ULL, 0x8872083fca2c757bULL, - 0x91054a7f09d5f47dULL, 0x4d377036d8a5664fULL, 0x10e4107f9458eaf7ULL, - 0x220a94fe13abe8faULL, 0x9a6ee06db14acc9eULL, 0x21c820ff28b1d5efULL, - 0x441529fc2757d1f5ULL, 0x34ddc0db6295993cULL, 0x439041fe5163abdeULL, - 0x882a53f84eafa3eaULL, 0x69bb81b6c52b3278ULL, 0x872083fca2c757bdULL, - 0x1054a7f09d5f47d4ULL, 0xd377036d8a5664f1ULL, 0xe4107f9458eaf7aULL, - 0x20a94fe13abe8fa9ULL, 0xa6ee06db14acc9e2ULL, 0x1c820ff28b1d5ef5ULL, - 0x41529fc2757d1f53ULL, 0x4ddc0db6295993c4ULL, 0x39041fe5163abdebULL, - 0x82a53f84eafa3ea6ULL, 0x9bb81b6c52b32788ULL, 0x72083fca2c757bd7ULL, - 0x54a7f09d5f47d4dULL, 0x377036d8a5664f10ULL, 0xe4107f9458eaf7aeULL, - 0xa94fe13abe8fa9aULL, 0x6ee06db14acc9e21ULL, 0xc820ff28b1d5ef5dULL, - 0x1529fc2757d1f534ULL, 0xddc0db6295993c43ULL, 0x9041fe5163abdebbULL, - 0x2a53f84eafa3ea69ULL, 0xbb81b6c52b327887ULL, 0x2083fca2c757bd77ULL, - 0x54a7f09d5f47d4d3ULL, 0x77036d8a5664f10eULL, 0x4107f9458eaf7aefULL, - 0xa94fe13abe8fa9a6ULL, 0xee06db14acc9e21cULL, 0x820ff28b1d5ef5deULL, - 0x529fc2757d1f534dULL, 0xdc0db6295993c439ULL, 0x41fe5163abdebbcULL, - 0xa53f84eafa3ea69bULL, 0xb81b6c52b3278872ULL, 0x83fca2c757bd778ULL, - 0x4a7f09d5f47d4d37ULL, 0x7036d8a5664f10e4ULL, 0x107f9458eaf7aef1ULL, - 0x94fe13abe8fa9a6eULL, 0xe06db14acc9e21c8ULL, 0x20ff28b1d5ef5de2ULL, - 0x29fc2757d1f534ddULL, 0xc0db6295993c4390ULL, 0x41fe5163abdebbc5ULL, - 0x53f84eafa3ea69bbULL, 0x81b6c52b32788720ULL, 0x83fca2c757bd778aULL, - 0xa7f09d5f47d4d377ULL, 0x36d8a5664f10e41ULL, 0x7f9458eaf7aef15ULL, - 0x4fe13abe8fa9a6eeULL, 0x6db14acc9e21c82ULL, 0xff28b1d5ef5de2bULL, - 0x9fc2757d1f534ddcULL, 0xdb6295993c43904ULL, 0x1fe5163abdebbc56ULL, - 0x3f84eafa3ea69bb8ULL, 0x1b6c52b327887208ULL, 0x3fca2c757bd778acULL, - 0x7f09d5f47d4d3770ULL, 0x36d8a5664f10e410ULL, 0x7f9458eaf7aef158ULL, - 0xfe13abe8fa9a6ee0ULL, 0x6db14acc9e21c820ULL, 0xff28b1d5ef5de2b0ULL, - 0xfc2757d1f534ddc0ULL, 0xdb6295993c439041ULL, 0xfe5163abdebbc561ULL, - 0xf84eafa3ea69bb81ULL, 0xb6c52b3278872083ULL, 0xfca2c757bd778ac3ULL, - 0xf09d5f47d4d37703ULL, 0x6d8a5664f10e4107ULL, 0xf9458eaf7aef1586ULL, - 0xe13abe8fa9a6ee06ULL, 0xdb14acc9e21c820fULL, 0xf28b1d5ef5de2b0dULL, - 0xc2757d1f534ddc0dULL, 0xb6295993c439041fULL, 0xe5163abdebbc561bULL, - 0x84eafa3ea69bb81bULL, 0x6c52b3278872083fULL, 0xca2c757bd778ac36ULL, - 0x9d5f47d4d377036ULL, 0xd8a5664f10e4107fULL, 0x9458eaf7aef1586dULL, - 0x13abe8fa9a6ee06dULL, 0xb14acc9e21c820ffULL, 0x28b1d5ef5de2b0dbULL, - 0x2757d1f534ddc0dbULL, 0x6295993c439041feULL, 0x5163abdebbc561b7ULL, - 0x4eafa3ea69bb81b6ULL, 0xc52b3278872083fcULL, 0xa2c757bd778ac36eULL, - 0x9d5f47d4d377036dULL, 0x8a5664f10e4107f9ULL, 0x458eaf7aef1586dcULL, - 0x3abe8fa9a6ee06dbULL, 0x14acc9e21c820ff2ULL, 0x8b1d5ef5de2b0db9ULL, - 0x757d1f534ddc0db6ULL, 0x295993c439041fe5ULL, 0x163abdebbc561b72ULL, - 0xeafa3ea69bb81b6cULL, 0x52b3278872083fcaULL, 0x2c757bd778ac36e4ULL, - 0xd5f47d4d377036d8ULL, 0xa5664f10e4107f94ULL, 0x58eaf7aef1586dc9ULL, - 0xabe8fa9a6ee06db1ULL, 0x4acc9e21c820ff28ULL, 0xb1d5ef5de2b0db92ULL, - 0x57d1f534ddc0db62ULL, 0x95993c439041fe51ULL, 0x63abdebbc561b724ULL, - 0xafa3ea69bb81b6c5ULL, 0x2b3278872083fca2ULL, 0xc757bd778ac36e48ULL, - 0x5f47d4d377036d8aULL, 0x5664f10e4107f945ULL, 0x8eaf7aef1586dc91ULL, - 0xbe8fa9a6ee06db14ULL, 0xacc9e21c820ff28bULL, 0x1d5ef5de2b0db923ULL, - 0x7d1f534ddc0db629ULL, 0x5993c439041fe516ULL, 0x3abdebbc561b7246ULL, - 0xfa3ea69bb81b6c52ULL, 0xb3278872083fca2cULL, 0x757bd778ac36e48dULL, - 0xf47d4d377036d8a5ULL, 0x664f10e4107f9458ULL, 0xeaf7aef1586dc91bULL, - 0xe8fa9a6ee06db14aULL, 0xcc9e21c820ff28b1ULL, 0xd5ef5de2b0db9237ULL, - 0xd1f534ddc0db6295ULL, 0x993c439041fe5163ULL, 0xabdebbc561b7246eULL, - 0xa3ea69bb81b6c52bULL, 0x3278872083fca2c7ULL, 0x57bd778ac36e48dcULL, - 0x47d4d377036d8a56ULL, 0x64f10e4107f9458eULL, 0xaf7aef1586dc91b8ULL, - 0x8fa9a6ee06db14acULL, 0xc9e21c820ff28b1dULL, 0x5ef5de2b0db92371ULL, - 0x1f534ddc0db62959ULL, 0x93c439041fe5163aULL, 0xbdebbc561b7246e3ULL, - 0x3ea69bb81b6c52b3ULL, 0x278872083fca2c75ULL, 0x7bd778ac36e48dc7ULL, - 0x7d4d377036d8a566ULL, 0x4f10e4107f9458eaULL, 0xf7aef1586dc91b8eULL, - 0xfa9a6ee06db14accULL, 0x9e21c820ff28b1d5ULL, 0xef5de2b0db92371dULL, - 0xf534ddc0db629599ULL, 0x3c439041fe5163abULL, 0xdebbc561b7246e3aULL, - 0xea69bb81b6c52b32ULL, 0x78872083fca2c757ULL, 0xbd778ac36e48dc74ULL, - 0xd4d377036d8a5664ULL, 0xf10e4107f9458eafULL, 0x7aef1586dc91b8e9ULL, - 0xa9a6ee06db14acc9ULL, 0xe21c820ff28b1d5eULL, 0xf5de2b0db92371d2ULL, - 0x534ddc0db6295993ULL, 0xc439041fe5163abdULL, 0xebbc561b7246e3a4ULL, - 0xa69bb81b6c52b327ULL, 0x8872083fca2c757bULL, 0xd778ac36e48dc748ULL, - 0x4d377036d8a5664fULL, 0x10e4107f9458eaf7ULL, 0xaef1586dc91b8e90ULL, - 0x9a6ee06db14acc9eULL, 0x21c820ff28b1d5efULL, 0x5de2b0db92371d21ULL, - 0x34ddc0db6295993cULL, 0x439041fe5163abdeULL, 0xbbc561b7246e3a42ULL, - 0x69bb81b6c52b3278ULL, 0x872083fca2c757bdULL, 0x778ac36e48dc7484ULL, - 0xd377036d8a5664f1ULL, 0xe4107f9458eaf7aULL, 0xef1586dc91b8e909ULL, - 0xa6ee06db14acc9e2ULL, 0x1c820ff28b1d5ef5ULL, 0xde2b0db92371d212ULL, - 0x4ddc0db6295993c4ULL, 0x39041fe5163abdebULL, 0xbc561b7246e3a424ULL, - 0x9bb81b6c52b32788ULL, 0x72083fca2c757bd7ULL, 0x78ac36e48dc74849ULL, - 0x377036d8a5664f10ULL, 0xe4107f9458eaf7aeULL, 0xf1586dc91b8e9093ULL, - 0x6ee06db14acc9e21ULL, 0xc820ff28b1d5ef5dULL, 0xe2b0db92371d2126ULL, - 0xddc0db6295993c43ULL, 0x9041fe5163abdebbULL, 0xc561b7246e3a424dULL, - 0xbb81b6c52b327887ULL, 0x2083fca2c757bd77ULL, 0x8ac36e48dc74849bULL, - 0x77036d8a5664f10eULL, 0x4107f9458eaf7aefULL, 0x1586dc91b8e90937ULL, - 0xee06db14acc9e21cULL, 0x820ff28b1d5ef5deULL, 0x2b0db92371d2126eULL, - 0xdc0db6295993c439ULL, 0x41fe5163abdebbcULL, 0x561b7246e3a424ddULL, - 0xb81b6c52b3278872ULL, 0x83fca2c757bd778ULL, 0xac36e48dc74849baULL, - 0x7036d8a5664f10e4ULL, 0x107f9458eaf7aef1ULL, 0x586dc91b8e909374ULL, - 0xe06db14acc9e21c8ULL, 0x20ff28b1d5ef5de2ULL, 0xb0db92371d2126e9ULL, - 0xc0db6295993c4390ULL, 0x41fe5163abdebbc5ULL, 0x61b7246e3a424dd2ULL, - 0x81b6c52b32788720ULL, 0x83fca2c757bd778aULL, 0xc36e48dc74849ba5ULL, - 0x36d8a5664f10e41ULL, 0x7f9458eaf7aef15ULL, 0x86dc91b8e909374bULL, - 0x6db14acc9e21c82ULL, 0xff28b1d5ef5de2bULL, 0xdb92371d2126e97ULL, - 0xdb6295993c43904ULL, 0x1fe5163abdebbc56ULL, 0x1b7246e3a424dd2eULL, - 0x1b6c52b327887208ULL, 0x3fca2c757bd778acULL, 0x36e48dc74849ba5cULL, - 0x36d8a5664f10e410ULL, 0x7f9458eaf7aef158ULL, 0x6dc91b8e909374b8ULL, - 0x6db14acc9e21c820ULL, 0xff28b1d5ef5de2b0ULL, 0xdb92371d2126e970ULL, - 0xdb6295993c439041ULL, 0xfe5163abdebbc561ULL, 0xb7246e3a424dd2e0ULL, - 0xb6c52b3278872083ULL, 0xfca2c757bd778ac3ULL, 0x6e48dc74849ba5c0ULL, - 0x6d8a5664f10e4107ULL, 0xf9458eaf7aef1586ULL, 0xdc91b8e909374b80ULL, - 0xdb14acc9e21c820fULL, 0xf28b1d5ef5de2b0dULL, 0xb92371d2126e9700ULL, - 0xb6295993c439041fULL, 0xe5163abdebbc561bULL, 0x7246e3a424dd2e00ULL, - 0x6c52b3278872083fULL, 0xca2c757bd778ac36ULL, 0xe48dc74849ba5c00ULL, - 0xd8a5664f10e4107fULL, 0x9458eaf7aef1586dULL, 0xc91b8e909374b801ULL, - 0xb14acc9e21c820ffULL, 0x28b1d5ef5de2b0dbULL, 0x92371d2126e97003ULL, - 0x6295993c439041feULL, 0x5163abdebbc561b7ULL, 0x246e3a424dd2e006ULL, - 0xc52b3278872083fcULL, 0xa2c757bd778ac36eULL, 0x48dc74849ba5c00cULL, - 0x8a5664f10e4107f9ULL, 0x458eaf7aef1586dcULL, 0x91b8e909374b8019ULL, - 0x14acc9e21c820ff2ULL, 0x8b1d5ef5de2b0db9ULL, 0x2371d2126e970032ULL, - 0x295993c439041fe5ULL, 0x163abdebbc561b72ULL, 0x46e3a424dd2e0064ULL, - 0x52b3278872083fcaULL, 0x2c757bd778ac36e4ULL, 0x8dc74849ba5c00c9ULL, - 0xa5664f10e4107f94ULL, 0x58eaf7aef1586dc9ULL, 0x1b8e909374b80192ULL, - 0x4acc9e21c820ff28ULL, 0xb1d5ef5de2b0db92ULL, 0x371d2126e9700324ULL, - 0x95993c439041fe51ULL, 0x63abdebbc561b724ULL, 0x6e3a424dd2e00649ULL, - 0x2b3278872083fca2ULL, 0xc757bd778ac36e48ULL, 0xdc74849ba5c00c92ULL, - 0x5664f10e4107f945ULL, 0x8eaf7aef1586dc91ULL, 0xb8e909374b801924ULL, - 0xacc9e21c820ff28bULL, 0x1d5ef5de2b0db923ULL, 0x71d2126e97003249ULL, - 0x5993c439041fe516ULL, 0x3abdebbc561b7246ULL, 0xe3a424dd2e006492ULL, - 0xb3278872083fca2cULL, 0x757bd778ac36e48dULL, 0xc74849ba5c00c925ULL, - 0x664f10e4107f9458ULL, 0xeaf7aef1586dc91bULL, 0x8e909374b801924bULL, - 0xcc9e21c820ff28b1ULL, 0xd5ef5de2b0db9237ULL, 0x1d2126e970032497ULL, - 0x993c439041fe5163ULL, 0xabdebbc561b7246eULL, 0x3a424dd2e006492eULL, - 0x3278872083fca2c7ULL, 0x57bd778ac36e48dcULL, 0x74849ba5c00c925dULL, - 0x64f10e4107f9458eULL, 0xaf7aef1586dc91b8ULL, 0xe909374b801924bbULL, - 0xc9e21c820ff28b1dULL, 0x5ef5de2b0db92371ULL, 0xd2126e9700324977ULL, - 0x93c439041fe5163aULL, 0xbdebbc561b7246e3ULL, 0xa424dd2e006492eeULL, - 0x278872083fca2c75ULL, 0x7bd778ac36e48dc7ULL, 0x4849ba5c00c925ddULL, - 0x4f10e4107f9458eaULL, 0xf7aef1586dc91b8eULL, 0x909374b801924bbaULL, - 0x9e21c820ff28b1d5ULL, 0xef5de2b0db92371dULL, 0x2126e97003249775ULL, - 0x3c439041fe5163abULL, 0xdebbc561b7246e3aULL, 0x424dd2e006492eeaULL, - 0x78872083fca2c757ULL, 0xbd778ac36e48dc74ULL, 0x849ba5c00c925dd4ULL, - 0xf10e4107f9458eafULL, 0x7aef1586dc91b8e9ULL, 0x9374b801924bba8ULL, - 0xe21c820ff28b1d5eULL, 0xf5de2b0db92371d2ULL, 0x126e970032497750ULL, - 0xc439041fe5163abdULL, 0xebbc561b7246e3a4ULL, 0x24dd2e006492eea0ULL, - 0x8872083fca2c757bULL, 0xd778ac36e48dc748ULL, 0x49ba5c00c925dd41ULL, - 0x10e4107f9458eaf7ULL, 0xaef1586dc91b8e90ULL, 0x9374b801924bba82ULL, - 0x21c820ff28b1d5efULL, 0x5de2b0db92371d21ULL, 0x26e9700324977504ULL, - 0x439041fe5163abdeULL, 0xbbc561b7246e3a42ULL, 0x4dd2e006492eea09ULL, - 0x872083fca2c757bdULL, 0x778ac36e48dc7484ULL, 0x9ba5c00c925dd413ULL, - 0xe4107f9458eaf7aULL, 0xef1586dc91b8e909ULL, 0x374b801924bba827ULL, - 0x1c820ff28b1d5ef5ULL, 0xde2b0db92371d212ULL, 0x6e9700324977504eULL, - 0x39041fe5163abdebULL, 0xbc561b7246e3a424ULL, 0xdd2e006492eea09dULL, - 0x72083fca2c757bd7ULL, 0x78ac36e48dc74849ULL, 0xba5c00c925dd413aULL, - 0xe4107f9458eaf7aeULL, 0xf1586dc91b8e9093ULL, 0x74b801924bba8274ULL, - 0xc820ff28b1d5ef5dULL, 0xe2b0db92371d2126ULL, 0xe9700324977504e8ULL, - 0x9041fe5163abdebbULL, 0xc561b7246e3a424dULL, 0xd2e006492eea09d1ULL, - 0x2083fca2c757bd77ULL, 0x8ac36e48dc74849bULL, 0xa5c00c925dd413a3ULL, - 0x4107f9458eaf7aefULL, 0x1586dc91b8e90937ULL, 0x4b801924bba82746ULL, - 0x820ff28b1d5ef5deULL, 0x2b0db92371d2126eULL, 0x9700324977504e8cULL, - 0x41fe5163abdebbcULL, 0x561b7246e3a424ddULL, 0x2e006492eea09d19ULL, - 0x83fca2c757bd778ULL, 0xac36e48dc74849baULL, 0x5c00c925dd413a32ULL, - 0x107f9458eaf7aef1ULL, 0x586dc91b8e909374ULL, 0xb801924bba827464ULL, - 0x20ff28b1d5ef5de2ULL, 0xb0db92371d2126e9ULL, 0x700324977504e8c9ULL, - 0x41fe5163abdebbc5ULL, 0x61b7246e3a424dd2ULL, 0xe006492eea09d192ULL, - 0x83fca2c757bd778aULL, 0xc36e48dc74849ba5ULL, 0xc00c925dd413a324ULL, - 0x7f9458eaf7aef15ULL, 0x86dc91b8e909374bULL, 0x801924bba8274648ULL, - 0xff28b1d5ef5de2bULL, 0xdb92371d2126e97ULL, 0x324977504e8c90ULL, - 0x1fe5163abdebbc56ULL, 0x1b7246e3a424dd2eULL, 0x6492eea09d1921ULL, - 0x3fca2c757bd778acULL, 0x36e48dc74849ba5cULL, 0xc925dd413a3243ULL, - 0x7f9458eaf7aef158ULL, 0x6dc91b8e909374b8ULL, 0x1924bba82746487ULL, - 0xff28b1d5ef5de2b0ULL, 0xdb92371d2126e970ULL, 0x324977504e8c90eULL, - 0xfe5163abdebbc561ULL, 0xb7246e3a424dd2e0ULL, 0x6492eea09d1921cULL, - 0xfca2c757bd778ac3ULL, 0x6e48dc74849ba5c0ULL, 0xc925dd413a32439ULL, - 0xf9458eaf7aef1586ULL, 0xdc91b8e909374b80ULL, 0x1924bba827464873ULL, - 0xf28b1d5ef5de2b0dULL, 0xb92371d2126e9700ULL, 0x324977504e8c90e7ULL, - 0xe5163abdebbc561bULL, 0x7246e3a424dd2e00ULL, 0x6492eea09d1921cfULL, - 0xca2c757bd778ac36ULL, 0xe48dc74849ba5c00ULL, 0xc925dd413a32439fULL, - 0x9458eaf7aef1586dULL, 0xc91b8e909374b801ULL, 0x924bba827464873fULL, - 0x28b1d5ef5de2b0dbULL, 0x92371d2126e97003ULL, 0x24977504e8c90e7fULL, - 0x5163abdebbc561b7ULL, 0x246e3a424dd2e006ULL, 0x492eea09d1921cfeULL, - 0xa2c757bd778ac36eULL, 0x48dc74849ba5c00cULL, 0x925dd413a32439fcULL, - 0x458eaf7aef1586dcULL, 0x91b8e909374b8019ULL, 0x24bba827464873f8ULL, - 0x8b1d5ef5de2b0db9ULL, 0x2371d2126e970032ULL, 0x4977504e8c90e7f0ULL, - 0x163abdebbc561b72ULL, 0x46e3a424dd2e0064ULL, 0x92eea09d1921cfe1ULL, - 0x2c757bd778ac36e4ULL, 0x8dc74849ba5c00c9ULL, 0x25dd413a32439fc3ULL, - 0x58eaf7aef1586dc9ULL, 0x1b8e909374b80192ULL, 0x4bba827464873f87ULL, - 0xb1d5ef5de2b0db92ULL, 0x371d2126e9700324ULL, 0x977504e8c90e7f0eULL, - 0x63abdebbc561b724ULL, 0x6e3a424dd2e00649ULL, 0x2eea09d1921cfe1dULL, - 0xc757bd778ac36e48ULL, 0xdc74849ba5c00c92ULL, 0x5dd413a32439fc3bULL, - 0x8eaf7aef1586dc91ULL, 0xb8e909374b801924ULL, 0xbba827464873f877ULL, - 0x1d5ef5de2b0db923ULL, 0x71d2126e97003249ULL, 0x77504e8c90e7f0efULL, - 0x3abdebbc561b7246ULL, 0xe3a424dd2e006492ULL, 0xeea09d1921cfe1deULL, - 0x757bd778ac36e48dULL, 0xc74849ba5c00c925ULL, 0xdd413a32439fc3bdULL, - 0xeaf7aef1586dc91bULL, 0x8e909374b801924bULL, 0xba827464873f877aULL, - 0xd5ef5de2b0db9237ULL, 0x1d2126e970032497ULL, 0x7504e8c90e7f0ef5ULL, - 0xabdebbc561b7246eULL, 0x3a424dd2e006492eULL, 0xea09d1921cfe1debULL, - 0x57bd778ac36e48dcULL, 0x74849ba5c00c925dULL, 0xd413a32439fc3bd6ULL, - 0xaf7aef1586dc91b8ULL, 0xe909374b801924bbULL, 0xa827464873f877acULL, - 0x5ef5de2b0db92371ULL, 0xd2126e9700324977ULL, 0x504e8c90e7f0ef58ULL, - 0xbdebbc561b7246e3ULL, 0xa424dd2e006492eeULL, 0xa09d1921cfe1deb1ULL, - 0x7bd778ac36e48dc7ULL, 0x4849ba5c00c925ddULL, 0x413a32439fc3bd63ULL, - 0xf7aef1586dc91b8eULL, 0x909374b801924bbaULL, 0x827464873f877ac7ULL, - 0xef5de2b0db92371dULL, 0x2126e97003249775ULL, 0x4e8c90e7f0ef58eULL, - 0xdebbc561b7246e3aULL, 0x424dd2e006492eeaULL, 0x9d1921cfe1deb1cULL, - 0xbd778ac36e48dc74ULL, 0x849ba5c00c925dd4ULL, 0x13a32439fc3bd639ULL, - 0x7aef1586dc91b8e9ULL, 0x9374b801924bba8ULL, 0x27464873f877ac72ULL, - 0xf5de2b0db92371d2ULL, 0x126e970032497750ULL, 0x4e8c90e7f0ef58e5ULL, - 0xebbc561b7246e3a4ULL, 0x24dd2e006492eea0ULL, 0x9d1921cfe1deb1cbULL, - 0xd778ac36e48dc748ULL, 0x49ba5c00c925dd41ULL, 0x3a32439fc3bd6396ULL, - 0xaef1586dc91b8e90ULL, 0x9374b801924bba82ULL, 0x7464873f877ac72cULL, - 0x5de2b0db92371d21ULL, 0x26e9700324977504ULL, 0xe8c90e7f0ef58e58ULL, - 0xbbc561b7246e3a42ULL, 0x4dd2e006492eea09ULL, 0xd1921cfe1deb1cb1ULL, - 0x778ac36e48dc7484ULL, 0x9ba5c00c925dd413ULL, 0xa32439fc3bd63962ULL, - 0xef1586dc91b8e909ULL, 0x374b801924bba827ULL, 0x464873f877ac72c4ULL, - 0xde2b0db92371d212ULL, 0x6e9700324977504eULL, 0x8c90e7f0ef58e589ULL, - 0xbc561b7246e3a424ULL, 0xdd2e006492eea09dULL, 0x1921cfe1deb1cb12ULL, - 0x78ac36e48dc74849ULL, 0xba5c00c925dd413aULL, 0x32439fc3bd639625ULL, - 0xf1586dc91b8e9093ULL, 0x74b801924bba8274ULL, 0x64873f877ac72c4aULL, - 0xe2b0db92371d2126ULL, 0xe9700324977504e8ULL, 0xc90e7f0ef58e5894ULL, - 0xc561b7246e3a424dULL, 0xd2e006492eea09d1ULL, 0x921cfe1deb1cb129ULL, - 0x8ac36e48dc74849bULL, 0xa5c00c925dd413a3ULL, 0x2439fc3bd6396253ULL, - 0x1586dc91b8e90937ULL, 0x4b801924bba82746ULL, 0x4873f877ac72c4a6ULL, - 0x2b0db92371d2126eULL, 0x9700324977504e8cULL, 0x90e7f0ef58e5894dULL, - 0x561b7246e3a424ddULL, 0x2e006492eea09d19ULL, 0x21cfe1deb1cb129aULL, - 0xac36e48dc74849baULL, 0x5c00c925dd413a32ULL, 0x439fc3bd63962534ULL, - 0x586dc91b8e909374ULL, 0xb801924bba827464ULL, 0x873f877ac72c4a69ULL, - 0xb0db92371d2126e9ULL, 0x700324977504e8c9ULL, 0xe7f0ef58e5894d3ULL, - 0x61b7246e3a424dd2ULL, 0xe006492eea09d192ULL, 0x1cfe1deb1cb129a7ULL, - 0xc36e48dc74849ba5ULL, 0xc00c925dd413a324ULL, 0x39fc3bd63962534eULL, - 0x86dc91b8e909374bULL, 0x801924bba8274648ULL, 0x73f877ac72c4a69cULL, - 0xdb92371d2126e97ULL, 0x324977504e8c90ULL, 0xe7f0ef58e5894d39ULL, - 0x1b7246e3a424dd2eULL, 0x6492eea09d1921ULL, 0xcfe1deb1cb129a73ULL, - 0x36e48dc74849ba5cULL, 0xc925dd413a3243ULL, 0x9fc3bd63962534e7ULL, - 0x6dc91b8e909374b8ULL, 0x1924bba82746487ULL, 0x3f877ac72c4a69cfULL, - 0xdb92371d2126e970ULL, 0x324977504e8c90eULL, 0x7f0ef58e5894d39fULL, - 0xb7246e3a424dd2e0ULL, 0x6492eea09d1921cULL, 0xfe1deb1cb129a73eULL, - 0x6e48dc74849ba5c0ULL, 0xc925dd413a32439ULL, 0xfc3bd63962534e7dULL, - 0xdc91b8e909374b80ULL, 0x1924bba827464873ULL, 0xf877ac72c4a69cfbULL, - 0xb92371d2126e9700ULL, 0x324977504e8c90e7ULL, 0xf0ef58e5894d39f7ULL, - 0x7246e3a424dd2e00ULL, 0x6492eea09d1921cfULL, 0xe1deb1cb129a73eeULL, - 0xe48dc74849ba5c00ULL, 0xc925dd413a32439fULL, 0xc3bd63962534e7ddULL, - 0xc91b8e909374b801ULL, 0x924bba827464873fULL, 0x877ac72c4a69cfbaULL, - 0x92371d2126e97003ULL, 0x24977504e8c90e7fULL, 0xef58e5894d39f74ULL, - 0x246e3a424dd2e006ULL, 0x492eea09d1921cfeULL, 0x1deb1cb129a73ee8ULL, - 0x48dc74849ba5c00cULL, 0x925dd413a32439fcULL, 0x3bd63962534e7dd1ULL, - 0x91b8e909374b8019ULL, 0x24bba827464873f8ULL, 0x77ac72c4a69cfba2ULL, - 0x2371d2126e970032ULL, 0x4977504e8c90e7f0ULL, 0xef58e5894d39f744ULL, - 0x46e3a424dd2e0064ULL, 0x92eea09d1921cfe1ULL, 0xdeb1cb129a73ee88ULL, - 0x8dc74849ba5c00c9ULL, 0x25dd413a32439fc3ULL, 0xbd63962534e7dd10ULL, - 0x1b8e909374b80192ULL, 0x4bba827464873f87ULL, 0x7ac72c4a69cfba20ULL, - 0x371d2126e9700324ULL, 0x977504e8c90e7f0eULL, 0xf58e5894d39f7441ULL, - 0x6e3a424dd2e00649ULL, 0x2eea09d1921cfe1dULL, 0xeb1cb129a73ee882ULL, - 0xdc74849ba5c00c92ULL, 0x5dd413a32439fc3bULL, 0xd63962534e7dd104ULL, - 0xb8e909374b801924ULL, 0xbba827464873f877ULL, 0xac72c4a69cfba208ULL, - 0x71d2126e97003249ULL, 0x77504e8c90e7f0efULL, 0x58e5894d39f74411ULL, - 0xe3a424dd2e006492ULL, 0xeea09d1921cfe1deULL, 0xb1cb129a73ee8823ULL, - 0xc74849ba5c00c925ULL, 0xdd413a32439fc3bdULL, 0x63962534e7dd1046ULL, - 0x8e909374b801924bULL, 0xba827464873f877aULL, 0xc72c4a69cfba208dULL, - 0x1d2126e970032497ULL, 0x7504e8c90e7f0ef5ULL, 0x8e5894d39f74411aULL, - 0x3a424dd2e006492eULL, 0xea09d1921cfe1debULL, 0x1cb129a73ee88235ULL, - 0x74849ba5c00c925dULL, 0xd413a32439fc3bd6ULL, 0x3962534e7dd1046bULL, - 0xe909374b801924bbULL, 0xa827464873f877acULL, 0x72c4a69cfba208d7ULL, - 0xd2126e9700324977ULL, 0x504e8c90e7f0ef58ULL, 0xe5894d39f74411afULL, - 0xa424dd2e006492eeULL, 0xa09d1921cfe1deb1ULL, 0xcb129a73ee88235fULL, - 0x4849ba5c00c925ddULL, 0x413a32439fc3bd63ULL, 0x962534e7dd1046beULL, - 0x909374b801924bbaULL, 0x827464873f877ac7ULL, 0x2c4a69cfba208d7dULL, - 0x2126e97003249775ULL, 0x4e8c90e7f0ef58eULL, 0x5894d39f74411afaULL, - 0x424dd2e006492eeaULL, 0x9d1921cfe1deb1cULL, 0xb129a73ee88235f5ULL, - 0x849ba5c00c925dd4ULL, 0x13a32439fc3bd639ULL, 0x62534e7dd1046beaULL, - 0x9374b801924bba8ULL, 0x27464873f877ac72ULL, 0xc4a69cfba208d7d4ULL, - 0x126e970032497750ULL, 0x4e8c90e7f0ef58e5ULL, 0x894d39f74411afa9ULL, - 0x24dd2e006492eea0ULL, 0x9d1921cfe1deb1cbULL, 0x129a73ee88235f52ULL, - 0x49ba5c00c925dd41ULL, 0x3a32439fc3bd6396ULL, 0x2534e7dd1046bea5ULL, - 0x9374b801924bba82ULL, 0x7464873f877ac72cULL, 0x4a69cfba208d7d4bULL, - 0x26e9700324977504ULL, 0xe8c90e7f0ef58e58ULL, 0x94d39f74411afa97ULL, - 0x4dd2e006492eea09ULL, 0xd1921cfe1deb1cb1ULL, 0x29a73ee88235f52eULL, - 0x9ba5c00c925dd413ULL, 0xa32439fc3bd63962ULL, 0x534e7dd1046bea5dULL, - 0x374b801924bba827ULL, 0x464873f877ac72c4ULL, 0xa69cfba208d7d4baULL, - 0x6e9700324977504eULL, 0x8c90e7f0ef58e589ULL, 0x4d39f74411afa975ULL, - 0xdd2e006492eea09dULL, 0x1921cfe1deb1cb12ULL, 0x9a73ee88235f52ebULL, - 0xba5c00c925dd413aULL, 0x32439fc3bd639625ULL, 0x34e7dd1046bea5d7ULL, - 0x74b801924bba8274ULL, 0x64873f877ac72c4aULL, 0x69cfba208d7d4baeULL, - 0xe9700324977504e8ULL, 0xc90e7f0ef58e5894ULL, 0xd39f74411afa975dULL, - 0xd2e006492eea09d1ULL, 0x921cfe1deb1cb129ULL, 0xa73ee88235f52ebbULL, - 0xa5c00c925dd413a3ULL, 0x2439fc3bd6396253ULL, 0x4e7dd1046bea5d76ULL, - 0x4b801924bba82746ULL, 0x4873f877ac72c4a6ULL, 0x9cfba208d7d4baedULL, - 0x9700324977504e8cULL, 0x90e7f0ef58e5894dULL, 0x39f74411afa975daULL, - 0x2e006492eea09d19ULL, 0x21cfe1deb1cb129aULL, 0x73ee88235f52ebb4ULL, - 0x5c00c925dd413a32ULL, 0x439fc3bd63962534ULL, 0xe7dd1046bea5d768ULL, - 0xb801924bba827464ULL, 0x873f877ac72c4a69ULL, 0xcfba208d7d4baed1ULL, - 0x700324977504e8c9ULL, 0xe7f0ef58e5894d3ULL, 0x9f74411afa975da2ULL, - 0xe006492eea09d192ULL, 0x1cfe1deb1cb129a7ULL, 0x3ee88235f52ebb44ULL, - 0xc00c925dd413a324ULL, 0x39fc3bd63962534eULL, 0x7dd1046bea5d7689ULL, - 0x801924bba8274648ULL, 0x73f877ac72c4a69cULL, 0xfba208d7d4baed12ULL, - 0x324977504e8c90ULL, 0xe7f0ef58e5894d39ULL, 0xf74411afa975da24ULL, - 0x6492eea09d1921ULL, 0xcfe1deb1cb129a73ULL, 0xee88235f52ebb448ULL, - 0xc925dd413a3243ULL, 0x9fc3bd63962534e7ULL, 0xdd1046bea5d76890ULL, - 0x1924bba82746487ULL, 0x3f877ac72c4a69cfULL, 0xba208d7d4baed121ULL, - 0x324977504e8c90eULL, 0x7f0ef58e5894d39fULL, 0x74411afa975da242ULL, - 0x6492eea09d1921cULL, 0xfe1deb1cb129a73eULL, 0xe88235f52ebb4484ULL, - 0xc925dd413a32439ULL, 0xfc3bd63962534e7dULL, 0xd1046bea5d768909ULL, - 0x1924bba827464873ULL, 0xf877ac72c4a69cfbULL, 0xa208d7d4baed1213ULL, - 0x324977504e8c90e7ULL, 0xf0ef58e5894d39f7ULL, 0x4411afa975da2427ULL, - 0x6492eea09d1921cfULL, 0xe1deb1cb129a73eeULL, 0x88235f52ebb4484eULL, - 0xc925dd413a32439fULL, 0xc3bd63962534e7ddULL, 0x1046bea5d768909dULL, - 0x924bba827464873fULL, 0x877ac72c4a69cfbaULL, 0x208d7d4baed1213aULL, - 0x24977504e8c90e7fULL, 0xef58e5894d39f74ULL, 0x411afa975da24274ULL, - 0x492eea09d1921cfeULL, 0x1deb1cb129a73ee8ULL, 0x8235f52ebb4484e9ULL, - 0x925dd413a32439fcULL, 0x3bd63962534e7dd1ULL, 0x46bea5d768909d3ULL, - 0x24bba827464873f8ULL, 0x77ac72c4a69cfba2ULL, 0x8d7d4baed1213a6ULL, - 0x4977504e8c90e7f0ULL, 0xef58e5894d39f744ULL, 0x11afa975da24274cULL, - 0x92eea09d1921cfe1ULL, 0xdeb1cb129a73ee88ULL, 0x235f52ebb4484e99ULL, - 0x25dd413a32439fc3ULL, 0xbd63962534e7dd10ULL, 0x46bea5d768909d33ULL, - 0x4bba827464873f87ULL, 0x7ac72c4a69cfba20ULL, 0x8d7d4baed1213a67ULL, - 0x977504e8c90e7f0eULL, 0xf58e5894d39f7441ULL, 0x1afa975da24274ceULL, - 0x2eea09d1921cfe1dULL, 0xeb1cb129a73ee882ULL, 0x35f52ebb4484e99cULL, - 0x5dd413a32439fc3bULL, 0xd63962534e7dd104ULL, 0x6bea5d768909d338ULL, - 0xbba827464873f877ULL, 0xac72c4a69cfba208ULL, 0xd7d4baed1213a671ULL, - 0x77504e8c90e7f0efULL, 0x58e5894d39f74411ULL, 0xafa975da24274ce3ULL, - 0xeea09d1921cfe1deULL, 0xb1cb129a73ee8823ULL, 0x5f52ebb4484e99c7ULL, - 0xdd413a32439fc3bdULL, 0x63962534e7dd1046ULL, 0xbea5d768909d338eULL, - 0xba827464873f877aULL, 0xc72c4a69cfba208dULL, 0x7d4baed1213a671cULL, - 0x7504e8c90e7f0ef5ULL, 0x8e5894d39f74411aULL, 0xfa975da24274ce38ULL, - 0xea09d1921cfe1debULL, 0x1cb129a73ee88235ULL, 0xf52ebb4484e99c70ULL, - 0xd413a32439fc3bd6ULL, 0x3962534e7dd1046bULL, 0xea5d768909d338e0ULL, - 0xa827464873f877acULL, 0x72c4a69cfba208d7ULL, 0xd4baed1213a671c0ULL, - 0x504e8c90e7f0ef58ULL, 0xe5894d39f74411afULL, 0xa975da24274ce381ULL, - 0xa09d1921cfe1deb1ULL, 0xcb129a73ee88235fULL, 0x52ebb4484e99c702ULL, - 0x413a32439fc3bd63ULL, 0x962534e7dd1046beULL, 0xa5d768909d338e04ULL, - 0x827464873f877ac7ULL, 0x2c4a69cfba208d7dULL, 0x4baed1213a671c09ULL, - 0x4e8c90e7f0ef58eULL, 0x5894d39f74411afaULL, 0x975da24274ce3813ULL, - 0x9d1921cfe1deb1cULL, 0xb129a73ee88235f5ULL, 0x2ebb4484e99c7026ULL, - 0x13a32439fc3bd639ULL, 0x62534e7dd1046beaULL, 0x5d768909d338e04dULL, - 0x27464873f877ac72ULL, 0xc4a69cfba208d7d4ULL, 0xbaed1213a671c09aULL, - 0x4e8c90e7f0ef58e5ULL, 0x894d39f74411afa9ULL, 0x75da24274ce38135ULL, - 0x9d1921cfe1deb1cbULL, 0x129a73ee88235f52ULL, 0xebb4484e99c7026bULL, - 0x3a32439fc3bd6396ULL, 0x2534e7dd1046bea5ULL, 0xd768909d338e04d6ULL, - 0x7464873f877ac72cULL, 0x4a69cfba208d7d4bULL, 0xaed1213a671c09adULL, - 0xe8c90e7f0ef58e58ULL, 0x94d39f74411afa97ULL, 0x5da24274ce38135aULL, - 0xd1921cfe1deb1cb1ULL, 0x29a73ee88235f52eULL, 0xbb4484e99c7026b4ULL, - 0xa32439fc3bd63962ULL, 0x534e7dd1046bea5dULL, 0x768909d338e04d68ULL, - 0x464873f877ac72c4ULL, 0xa69cfba208d7d4baULL, 0xed1213a671c09ad1ULL, - 0x8c90e7f0ef58e589ULL, 0x4d39f74411afa975ULL, 0xda24274ce38135a2ULL, - 0x1921cfe1deb1cb12ULL, 0x9a73ee88235f52ebULL, 0xb4484e99c7026b45ULL, - 0x32439fc3bd639625ULL, 0x34e7dd1046bea5d7ULL, 0x68909d338e04d68bULL, - 0x64873f877ac72c4aULL, 0x69cfba208d7d4baeULL, 0xd1213a671c09ad17ULL, - 0xc90e7f0ef58e5894ULL, 0xd39f74411afa975dULL, 0xa24274ce38135a2fULL, - 0x921cfe1deb1cb129ULL, 0xa73ee88235f52ebbULL, 0x4484e99c7026b45fULL, - 0x2439fc3bd6396253ULL, 0x4e7dd1046bea5d76ULL, 0x8909d338e04d68beULL, - 0x4873f877ac72c4a6ULL, 0x9cfba208d7d4baedULL, 0x1213a671c09ad17dULL, - 0x90e7f0ef58e5894dULL, 0x39f74411afa975daULL, 0x24274ce38135a2fbULL, - 0x21cfe1deb1cb129aULL, 0x73ee88235f52ebb4ULL, 0x484e99c7026b45f7ULL, - 0x439fc3bd63962534ULL, 0xe7dd1046bea5d768ULL, 0x909d338e04d68befULL, - 0x873f877ac72c4a69ULL, 0xcfba208d7d4baed1ULL, 0x213a671c09ad17dfULL, - 0xe7f0ef58e5894d3ULL, 0x9f74411afa975da2ULL, 0x4274ce38135a2fbfULL, - 0x1cfe1deb1cb129a7ULL, 0x3ee88235f52ebb44ULL, 0x84e99c7026b45f7eULL, - 0x39fc3bd63962534eULL, 0x7dd1046bea5d7689ULL, 0x9d338e04d68befcULL, - 0x73f877ac72c4a69cULL, 0xfba208d7d4baed12ULL, 0x13a671c09ad17df9ULL, - 0xe7f0ef58e5894d39ULL, 0xf74411afa975da24ULL, 0x274ce38135a2fbf2ULL, - 0xcfe1deb1cb129a73ULL, 0xee88235f52ebb448ULL, 0x4e99c7026b45f7e4ULL, - 0x9fc3bd63962534e7ULL, 0xdd1046bea5d76890ULL, 0x9d338e04d68befc8ULL, - 0x3f877ac72c4a69cfULL, 0xba208d7d4baed121ULL, 0x3a671c09ad17df90ULL, - 0x7f0ef58e5894d39fULL, 0x74411afa975da242ULL, 0x74ce38135a2fbf20ULL, - 0xfe1deb1cb129a73eULL, 0xe88235f52ebb4484ULL, 0xe99c7026b45f7e41ULL, - 0xfc3bd63962534e7dULL, 0xd1046bea5d768909ULL, 0xd338e04d68befc82ULL, - 0xf877ac72c4a69cfbULL, 0xa208d7d4baed1213ULL, 0xa671c09ad17df904ULL, - 0xf0ef58e5894d39f7ULL, 0x4411afa975da2427ULL, 0x4ce38135a2fbf209ULL, - 0xe1deb1cb129a73eeULL, 0x88235f52ebb4484eULL, 0x99c7026b45f7e413ULL, - 0xc3bd63962534e7ddULL, 0x1046bea5d768909dULL, 0x338e04d68befc827ULL, - 0x877ac72c4a69cfbaULL, 0x208d7d4baed1213aULL, 0x671c09ad17df904eULL, - 0xef58e5894d39f74ULL, 0x411afa975da24274ULL, 0xce38135a2fbf209cULL, - 0x1deb1cb129a73ee8ULL, 0x8235f52ebb4484e9ULL, 0x9c7026b45f7e4139ULL, - 0x3bd63962534e7dd1ULL, 0x46bea5d768909d3ULL, 0x38e04d68befc8273ULL, - 0x77ac72c4a69cfba2ULL, 0x8d7d4baed1213a6ULL, 0x71c09ad17df904e6ULL, - 0xef58e5894d39f744ULL, 0x11afa975da24274cULL, 0xe38135a2fbf209ccULL, - 0xdeb1cb129a73ee88ULL, 0x235f52ebb4484e99ULL, 0xc7026b45f7e41399ULL, - 0xbd63962534e7dd10ULL, 0x46bea5d768909d33ULL, 0x8e04d68befc82732ULL, - 0x7ac72c4a69cfba20ULL, 0x8d7d4baed1213a67ULL, 0x1c09ad17df904e64ULL, - 0xf58e5894d39f7441ULL, 0x1afa975da24274ceULL, 0x38135a2fbf209cc8ULL, - 0xeb1cb129a73ee882ULL, 0x35f52ebb4484e99cULL, 0x7026b45f7e413991ULL, - 0xd63962534e7dd104ULL, 0x6bea5d768909d338ULL, 0xe04d68befc827323ULL, - 0xac72c4a69cfba208ULL, 0xd7d4baed1213a671ULL, 0xc09ad17df904e647ULL, - 0x58e5894d39f74411ULL, 0xafa975da24274ce3ULL, 0x8135a2fbf209cc8eULL, - 0xb1cb129a73ee8823ULL, 0x5f52ebb4484e99c7ULL, 0x26b45f7e413991dULL, - 0x63962534e7dd1046ULL, 0xbea5d768909d338eULL, 0x4d68befc827323aULL, - 0xc72c4a69cfba208dULL, 0x7d4baed1213a671cULL, 0x9ad17df904e6475ULL, - 0x8e5894d39f74411aULL, 0xfa975da24274ce38ULL, 0x135a2fbf209cc8ebULL, - 0x1cb129a73ee88235ULL, 0xf52ebb4484e99c70ULL, 0x26b45f7e413991d6ULL, - 0x3962534e7dd1046bULL, 0xea5d768909d338e0ULL, 0x4d68befc827323acULL, - 0x72c4a69cfba208d7ULL, 0xd4baed1213a671c0ULL, 0x9ad17df904e64758ULL, - 0xe5894d39f74411afULL, 0xa975da24274ce381ULL, 0x35a2fbf209cc8eb1ULL, - 0xcb129a73ee88235fULL, 0x52ebb4484e99c702ULL, 0x6b45f7e413991d63ULL, - 0x962534e7dd1046beULL, 0xa5d768909d338e04ULL, 0xd68befc827323ac7ULL, - 0x2c4a69cfba208d7dULL, 0x4baed1213a671c09ULL, 0xad17df904e64758eULL, - 0x5894d39f74411afaULL, 0x975da24274ce3813ULL, 0x5a2fbf209cc8eb1cULL, - 0xb129a73ee88235f5ULL, 0x2ebb4484e99c7026ULL, 0xb45f7e413991d639ULL, - 0x62534e7dd1046beaULL, 0x5d768909d338e04dULL, 0x68befc827323ac73ULL, - 0xc4a69cfba208d7d4ULL, 0xbaed1213a671c09aULL, 0xd17df904e64758e6ULL, - 0x894d39f74411afa9ULL, 0x75da24274ce38135ULL, 0xa2fbf209cc8eb1ccULL, - 0x129a73ee88235f52ULL, 0xebb4484e99c7026bULL, 0x45f7e413991d6398ULL, - 0x2534e7dd1046bea5ULL, 0xd768909d338e04d6ULL, 0x8befc827323ac730ULL, - 0x4a69cfba208d7d4bULL, 0xaed1213a671c09adULL, 0x17df904e64758e60ULL, - 0x94d39f74411afa97ULL, 0x5da24274ce38135aULL, 0x2fbf209cc8eb1cc1ULL, - 0x29a73ee88235f52eULL, 0xbb4484e99c7026b4ULL, 0x5f7e413991d63983ULL, - 0x534e7dd1046bea5dULL, 0x768909d338e04d68ULL, 0xbefc827323ac7306ULL, - 0xa69cfba208d7d4baULL, 0xed1213a671c09ad1ULL, 0x7df904e64758e60dULL, - 0x4d39f74411afa975ULL, 0xda24274ce38135a2ULL, 0xfbf209cc8eb1cc1aULL, - 0x9a73ee88235f52ebULL, 0xb4484e99c7026b45ULL, 0xf7e413991d639835ULL, - 0x34e7dd1046bea5d7ULL, 0x68909d338e04d68bULL, 0xefc827323ac7306aULL, - 0x69cfba208d7d4baeULL, 0xd1213a671c09ad17ULL, 0xdf904e64758e60d4ULL, - 0xd39f74411afa975dULL, 0xa24274ce38135a2fULL, 0xbf209cc8eb1cc1a9ULL, - 0xa73ee88235f52ebbULL, 0x4484e99c7026b45fULL, 0x7e413991d6398353ULL, - 0x4e7dd1046bea5d76ULL, 0x8909d338e04d68beULL, 0xfc827323ac7306a6ULL, - 0x9cfba208d7d4baedULL, 0x1213a671c09ad17dULL, 0xf904e64758e60d4cULL, - 0x39f74411afa975daULL, 0x24274ce38135a2fbULL, 0xf209cc8eb1cc1a99ULL, - 0x73ee88235f52ebb4ULL, 0x484e99c7026b45f7ULL, 0xe413991d63983533ULL, - 0xe7dd1046bea5d768ULL, 0x909d338e04d68befULL, 0xc827323ac7306a67ULL, - 0xcfba208d7d4baed1ULL, 0x213a671c09ad17dfULL, 0x904e64758e60d4ceULL, - 0x9f74411afa975da2ULL, 0x4274ce38135a2fbfULL, 0x209cc8eb1cc1a99cULL, - 0x3ee88235f52ebb44ULL, 0x84e99c7026b45f7eULL, 0x413991d639835339ULL, - 0x7dd1046bea5d7689ULL, 0x9d338e04d68befcULL, 0x827323ac7306a673ULL, - 0xfba208d7d4baed12ULL, 0x13a671c09ad17df9ULL, 0x4e64758e60d4ce7ULL, - 0xf74411afa975da24ULL, 0x274ce38135a2fbf2ULL, 0x9cc8eb1cc1a99cfULL, - 0xee88235f52ebb448ULL, 0x4e99c7026b45f7e4ULL, 0x13991d639835339fULL, - 0xdd1046bea5d76890ULL, 0x9d338e04d68befc8ULL, 0x27323ac7306a673eULL, - 0xba208d7d4baed121ULL, 0x3a671c09ad17df90ULL, 0x4e64758e60d4ce7dULL, - 0x74411afa975da242ULL, 0x74ce38135a2fbf20ULL, 0x9cc8eb1cc1a99cfaULL, - 0xe88235f52ebb4484ULL, 0xe99c7026b45f7e41ULL, 0x3991d639835339f4ULL, - 0xd1046bea5d768909ULL, 0xd338e04d68befc82ULL, 0x7323ac7306a673e9ULL, - 0xa208d7d4baed1213ULL, 0xa671c09ad17df904ULL, 0xe64758e60d4ce7d2ULL, - 0x4411afa975da2427ULL, 0x4ce38135a2fbf209ULL, 0xcc8eb1cc1a99cfa4ULL, - 0x88235f52ebb4484eULL, 0x99c7026b45f7e413ULL, 0x991d639835339f49ULL, - 0x1046bea5d768909dULL, 0x338e04d68befc827ULL, 0x323ac7306a673e93ULL, - 0x208d7d4baed1213aULL, 0x671c09ad17df904eULL, 0x64758e60d4ce7d27ULL, - 0x411afa975da24274ULL, 0xce38135a2fbf209cULL, 0xc8eb1cc1a99cfa4eULL, - 0x8235f52ebb4484e9ULL, 0x9c7026b45f7e4139ULL, 0x91d639835339f49cULL, - 0x46bea5d768909d3ULL, 0x38e04d68befc8273ULL, 0x23ac7306a673e939ULL, - 0x8d7d4baed1213a6ULL, 0x71c09ad17df904e6ULL, 0x4758e60d4ce7d272ULL, - 0x11afa975da24274cULL, 0xe38135a2fbf209ccULL, 0x8eb1cc1a99cfa4e4ULL, - 0x235f52ebb4484e99ULL, 0xc7026b45f7e41399ULL, 0x1d639835339f49c8ULL, - 0x46bea5d768909d33ULL, 0x8e04d68befc82732ULL, 0x3ac7306a673e9390ULL, - 0x8d7d4baed1213a67ULL, 0x1c09ad17df904e64ULL, 0x758e60d4ce7d2721ULL, - 0x1afa975da24274ceULL, 0x38135a2fbf209cc8ULL, 0xeb1cc1a99cfa4e42ULL, - 0x35f52ebb4484e99cULL, 0x7026b45f7e413991ULL, 0xd639835339f49c84ULL, - 0x6bea5d768909d338ULL, 0xe04d68befc827323ULL, 0xac7306a673e93908ULL, - 0xd7d4baed1213a671ULL, 0xc09ad17df904e647ULL, 0x58e60d4ce7d27211ULL, - 0xafa975da24274ce3ULL, 0x8135a2fbf209cc8eULL, 0xb1cc1a99cfa4e422ULL, - 0x5f52ebb4484e99c7ULL, 0x26b45f7e413991dULL, 0x639835339f49c845ULL, - 0xbea5d768909d338eULL, 0x4d68befc827323aULL, 0xc7306a673e93908bULL, - 0x7d4baed1213a671cULL, 0x9ad17df904e6475ULL, 0x8e60d4ce7d272117ULL, - 0xfa975da24274ce38ULL, 0x135a2fbf209cc8ebULL, 0x1cc1a99cfa4e422fULL, - 0xf52ebb4484e99c70ULL, 0x26b45f7e413991d6ULL, 0x39835339f49c845fULL, - 0xea5d768909d338e0ULL, 0x4d68befc827323acULL, 0x7306a673e93908bfULL, - 0xd4baed1213a671c0ULL, 0x9ad17df904e64758ULL, 0xe60d4ce7d272117eULL, - 0xa975da24274ce381ULL, 0x35a2fbf209cc8eb1ULL, 0xcc1a99cfa4e422fcULL, - 0x52ebb4484e99c702ULL, 0x6b45f7e413991d63ULL, 0x9835339f49c845f8ULL, - 0xa5d768909d338e04ULL, 0xd68befc827323ac7ULL, 0x306a673e93908bf1ULL, - 0x4baed1213a671c09ULL, 0xad17df904e64758eULL, 0x60d4ce7d272117e2ULL, - 0x975da24274ce3813ULL, 0x5a2fbf209cc8eb1cULL, 0xc1a99cfa4e422fc5ULL, - 0x2ebb4484e99c7026ULL, 0xb45f7e413991d639ULL, 0x835339f49c845f8bULL, - 0x5d768909d338e04dULL, 0x68befc827323ac73ULL, 0x6a673e93908bf17ULL, - 0xbaed1213a671c09aULL, 0xd17df904e64758e6ULL, 0xd4ce7d272117e2eULL, - 0x75da24274ce38135ULL, 0xa2fbf209cc8eb1ccULL, 0x1a99cfa4e422fc5dULL, - 0xebb4484e99c7026bULL, 0x45f7e413991d6398ULL, 0x35339f49c845f8bbULL, - 0xd768909d338e04d6ULL, 0x8befc827323ac730ULL, 0x6a673e93908bf177ULL, - 0xaed1213a671c09adULL, 0x17df904e64758e60ULL, 0xd4ce7d272117e2efULL, - 0x5da24274ce38135aULL, 0x2fbf209cc8eb1cc1ULL, 0xa99cfa4e422fc5deULL, - 0xbb4484e99c7026b4ULL, 0x5f7e413991d63983ULL, 0x5339f49c845f8bbdULL, - 0x768909d338e04d68ULL, 0xbefc827323ac7306ULL, 0xa673e93908bf177bULL, - 0xed1213a671c09ad1ULL, 0x7df904e64758e60dULL, 0x4ce7d272117e2ef7ULL, - 0xda24274ce38135a2ULL, 0xfbf209cc8eb1cc1aULL, 0x99cfa4e422fc5defULL, - 0xb4484e99c7026b45ULL, 0xf7e413991d639835ULL, 0x339f49c845f8bbdfULL, - 0x68909d338e04d68bULL, 0xefc827323ac7306aULL, 0x673e93908bf177bfULL, - 0xd1213a671c09ad17ULL, 0xdf904e64758e60d4ULL, 0xce7d272117e2ef7eULL, - 0xa24274ce38135a2fULL, 0xbf209cc8eb1cc1a9ULL, 0x9cfa4e422fc5defcULL, - 0x4484e99c7026b45fULL, 0x7e413991d6398353ULL, 0x39f49c845f8bbdf9ULL, - 0x8909d338e04d68beULL, 0xfc827323ac7306a6ULL, 0x73e93908bf177bf2ULL, - 0x1213a671c09ad17dULL, 0xf904e64758e60d4cULL, 0xe7d272117e2ef7e4ULL, - 0x24274ce38135a2fbULL, 0xf209cc8eb1cc1a99ULL, 0xcfa4e422fc5defc9ULL, - 0x484e99c7026b45f7ULL, 0xe413991d63983533ULL, 0x9f49c845f8bbdf92ULL, - 0x909d338e04d68befULL, 0xc827323ac7306a67ULL, 0x3e93908bf177bf25ULL, - 0x213a671c09ad17dfULL, 0x904e64758e60d4ceULL, 0x7d272117e2ef7e4aULL, - 0x4274ce38135a2fbfULL, 0x209cc8eb1cc1a99cULL, 0xfa4e422fc5defc94ULL, - 0x84e99c7026b45f7eULL, 0x413991d639835339ULL, 0xf49c845f8bbdf928ULL, - 0x9d338e04d68befcULL, 0x827323ac7306a673ULL, 0xe93908bf177bf250ULL, - 0x13a671c09ad17df9ULL, 0x4e64758e60d4ce7ULL, 0xd272117e2ef7e4a0ULL, - 0x274ce38135a2fbf2ULL, 0x9cc8eb1cc1a99cfULL, 0xa4e422fc5defc941ULL, - 0x4e99c7026b45f7e4ULL, 0x13991d639835339fULL, 0x49c845f8bbdf9283ULL, - 0x9d338e04d68befc8ULL, 0x27323ac7306a673eULL, 0x93908bf177bf2507ULL, - 0x3a671c09ad17df90ULL, 0x4e64758e60d4ce7dULL, 0x272117e2ef7e4a0eULL, - 0x74ce38135a2fbf20ULL, 0x9cc8eb1cc1a99cfaULL, 0x4e422fc5defc941dULL, - 0xe99c7026b45f7e41ULL, 0x3991d639835339f4ULL, 0x9c845f8bbdf9283bULL, - 0xd338e04d68befc82ULL, 0x7323ac7306a673e9ULL, 0x3908bf177bf25076ULL, - 0xa671c09ad17df904ULL, 0xe64758e60d4ce7d2ULL, 0x72117e2ef7e4a0ecULL, - 0x4ce38135a2fbf209ULL, 0xcc8eb1cc1a99cfa4ULL, 0xe422fc5defc941d8ULL, - 0x99c7026b45f7e413ULL, 0x991d639835339f49ULL, 0xc845f8bbdf9283b1ULL, - 0x338e04d68befc827ULL, 0x323ac7306a673e93ULL, 0x908bf177bf250763ULL, - 0x671c09ad17df904eULL, 0x64758e60d4ce7d27ULL, 0x2117e2ef7e4a0ec7ULL, - 0xce38135a2fbf209cULL, 0xc8eb1cc1a99cfa4eULL, 0x422fc5defc941d8fULL, - 0x9c7026b45f7e4139ULL, 0x91d639835339f49cULL, 0x845f8bbdf9283b1fULL, - 0x38e04d68befc8273ULL, 0x23ac7306a673e939ULL, 0x8bf177bf250763fULL, - 0x71c09ad17df904e6ULL, 0x4758e60d4ce7d272ULL, 0x117e2ef7e4a0ec7fULL, - 0xe38135a2fbf209ccULL, 0x8eb1cc1a99cfa4e4ULL, 0x22fc5defc941d8ffULL, - 0xc7026b45f7e41399ULL, 0x1d639835339f49c8ULL, 0x45f8bbdf9283b1ffULL, - 0x8e04d68befc82732ULL, 0x3ac7306a673e9390ULL, 0x8bf177bf250763ffULL, - 0x1c09ad17df904e64ULL, 0x758e60d4ce7d2721ULL, 0x17e2ef7e4a0ec7feULL, - 0x38135a2fbf209cc8ULL, 0xeb1cc1a99cfa4e42ULL, 0x2fc5defc941d8ffcULL, - 0x7026b45f7e413991ULL, 0xd639835339f49c84ULL, 0x5f8bbdf9283b1ff8ULL, - 0xe04d68befc827323ULL, 0xac7306a673e93908ULL, 0xbf177bf250763ff1ULL, - 0xc09ad17df904e647ULL, 0x58e60d4ce7d27211ULL, 0x7e2ef7e4a0ec7fe2ULL, - 0x8135a2fbf209cc8eULL, 0xb1cc1a99cfa4e422ULL, 0xfc5defc941d8ffc4ULL, - 0x26b45f7e413991dULL, 0x639835339f49c845ULL, 0xf8bbdf9283b1ff89ULL, - 0x4d68befc827323aULL, 0xc7306a673e93908bULL, 0xf177bf250763ff12ULL, - 0x9ad17df904e6475ULL, 0x8e60d4ce7d272117ULL, 0xe2ef7e4a0ec7fe25ULL, - 0x135a2fbf209cc8ebULL, 0x1cc1a99cfa4e422fULL, 0xc5defc941d8ffc4bULL, - 0x26b45f7e413991d6ULL, 0x39835339f49c845fULL, 0x8bbdf9283b1ff897ULL, - 0x4d68befc827323acULL, 0x7306a673e93908bfULL, 0x177bf250763ff12fULL, - 0x9ad17df904e64758ULL, 0xe60d4ce7d272117eULL, 0x2ef7e4a0ec7fe25fULL, - 0x35a2fbf209cc8eb1ULL, 0xcc1a99cfa4e422fcULL, 0x5defc941d8ffc4bfULL, - 0x6b45f7e413991d63ULL, 0x9835339f49c845f8ULL, 0xbbdf9283b1ff897fULL, - 0xd68befc827323ac7ULL, 0x306a673e93908bf1ULL, 0x77bf250763ff12ffULL, - 0xad17df904e64758eULL, 0x60d4ce7d272117e2ULL, 0xef7e4a0ec7fe25ffULL, - 0x5a2fbf209cc8eb1cULL, 0xc1a99cfa4e422fc5ULL, 0xdefc941d8ffc4bffULL, - 0xb45f7e413991d639ULL, 0x835339f49c845f8bULL, 0xbdf9283b1ff897ffULL, - 0x68befc827323ac73ULL, 0x6a673e93908bf17ULL, 0x7bf250763ff12fffULL, - 0xd17df904e64758e6ULL, 0xd4ce7d272117e2eULL, 0xf7e4a0ec7fe25fffULL, - 0xa2fbf209cc8eb1ccULL, 0x1a99cfa4e422fc5dULL, 0xefc941d8ffc4bffeULL, - 0x45f7e413991d6398ULL, 0x35339f49c845f8bbULL, 0xdf9283b1ff897ffdULL, - 0x8befc827323ac730ULL, 0x6a673e93908bf177ULL, 0xbf250763ff12fffbULL, - 0x17df904e64758e60ULL, 0xd4ce7d272117e2efULL, 0x7e4a0ec7fe25fff7ULL, - 0x2fbf209cc8eb1cc1ULL, 0xa99cfa4e422fc5deULL, 0xfc941d8ffc4bffefULL, - 0x5f7e413991d63983ULL, 0x5339f49c845f8bbdULL, 0xf9283b1ff897ffdeULL, - 0xbefc827323ac7306ULL, 0xa673e93908bf177bULL, 0xf250763ff12fffbcULL, - 0x7df904e64758e60dULL, 0x4ce7d272117e2ef7ULL, 0xe4a0ec7fe25fff78ULL, - 0xfbf209cc8eb1cc1aULL, 0x99cfa4e422fc5defULL, 0xc941d8ffc4bffef0ULL, - 0xf7e413991d639835ULL, 0x339f49c845f8bbdfULL, 0x9283b1ff897ffde0ULL, - 0xefc827323ac7306aULL, 0x673e93908bf177bfULL, 0x250763ff12fffbc0ULL, - 0xdf904e64758e60d4ULL, 0xce7d272117e2ef7eULL, 0x4a0ec7fe25fff781ULL, - 0xbf209cc8eb1cc1a9ULL, 0x9cfa4e422fc5defcULL, 0x941d8ffc4bffef02ULL, - 0x7e413991d6398353ULL, 0x39f49c845f8bbdf9ULL, 0x283b1ff897ffde05ULL, - 0xfc827323ac7306a6ULL, 0x73e93908bf177bf2ULL, 0x50763ff12fffbc0bULL, - 0xf904e64758e60d4cULL, 0xe7d272117e2ef7e4ULL, 0xa0ec7fe25fff7816ULL, - 0xf209cc8eb1cc1a99ULL, 0xcfa4e422fc5defc9ULL, 0x41d8ffc4bffef02cULL, - 0xe413991d63983533ULL, 0x9f49c845f8bbdf92ULL, 0x83b1ff897ffde059ULL, - 0xc827323ac7306a67ULL, 0x3e93908bf177bf25ULL, 0x763ff12fffbc0b3ULL, - 0x904e64758e60d4ceULL, 0x7d272117e2ef7e4aULL, 0xec7fe25fff78166ULL, - 0x209cc8eb1cc1a99cULL, 0xfa4e422fc5defc94ULL, 0x1d8ffc4bffef02ccULL, - 0x413991d639835339ULL, 0xf49c845f8bbdf928ULL, 0x3b1ff897ffde0598ULL, - 0x827323ac7306a673ULL, 0xe93908bf177bf250ULL, 0x763ff12fffbc0b30ULL, - 0x4e64758e60d4ce7ULL, 0xd272117e2ef7e4a0ULL, 0xec7fe25fff781660ULL, - 0x9cc8eb1cc1a99cfULL, 0xa4e422fc5defc941ULL, 0xd8ffc4bffef02cc0ULL, - 0x13991d639835339fULL, 0x49c845f8bbdf9283ULL, 0xb1ff897ffde05980ULL, - 0x27323ac7306a673eULL, 0x93908bf177bf2507ULL, 0x63ff12fffbc0b301ULL, - 0x4e64758e60d4ce7dULL, 0x272117e2ef7e4a0eULL, 0xc7fe25fff7816603ULL, - 0x9cc8eb1cc1a99cfaULL, 0x4e422fc5defc941dULL, 0x8ffc4bffef02cc07ULL, - 0x3991d639835339f4ULL, 0x9c845f8bbdf9283bULL, 0x1ff897ffde05980fULL, - 0x7323ac7306a673e9ULL, 0x3908bf177bf25076ULL, 0x3ff12fffbc0b301fULL, - 0xe64758e60d4ce7d2ULL, 0x72117e2ef7e4a0ecULL, 0x7fe25fff7816603fULL, - 0xcc8eb1cc1a99cfa4ULL, 0xe422fc5defc941d8ULL, 0xffc4bffef02cc07fULL, - 0x991d639835339f49ULL, 0xc845f8bbdf9283b1ULL, 0xff897ffde05980feULL, - 0x323ac7306a673e93ULL, 0x908bf177bf250763ULL, 0xff12fffbc0b301fdULL, - 0x64758e60d4ce7d27ULL, 0x2117e2ef7e4a0ec7ULL, 0xfe25fff7816603fbULL, - 0xc8eb1cc1a99cfa4eULL, 0x422fc5defc941d8fULL, 0xfc4bffef02cc07f7ULL, - 0x91d639835339f49cULL, 0x845f8bbdf9283b1fULL, 0xf897ffde05980fefULL, - 0x23ac7306a673e939ULL, 0x8bf177bf250763fULL, 0xf12fffbc0b301fdeULL, - 0x4758e60d4ce7d272ULL, 0x117e2ef7e4a0ec7fULL, 0xe25fff7816603fbcULL, - 0x8eb1cc1a99cfa4e4ULL, 0x22fc5defc941d8ffULL, 0xc4bffef02cc07f79ULL, - 0x1d639835339f49c8ULL, 0x45f8bbdf9283b1ffULL, 0x897ffde05980fef2ULL, - 0x3ac7306a673e9390ULL, 0x8bf177bf250763ffULL, 0x12fffbc0b301fde5ULL, - 0x758e60d4ce7d2721ULL, 0x17e2ef7e4a0ec7feULL, 0x25fff7816603fbcbULL, - 0xeb1cc1a99cfa4e42ULL, 0x2fc5defc941d8ffcULL, 0x4bffef02cc07f797ULL, - 0xd639835339f49c84ULL, 0x5f8bbdf9283b1ff8ULL, 0x97ffde05980fef2fULL, - 0xac7306a673e93908ULL, 0xbf177bf250763ff1ULL, 0x2fffbc0b301fde5eULL, - 0x58e60d4ce7d27211ULL, 0x7e2ef7e4a0ec7fe2ULL, 0x5fff7816603fbcbcULL, - 0xb1cc1a99cfa4e422ULL, 0xfc5defc941d8ffc4ULL, 0xbffef02cc07f7978ULL, - 0x639835339f49c845ULL, 0xf8bbdf9283b1ff89ULL, 0x7ffde05980fef2f1ULL, - 0xc7306a673e93908bULL, 0xf177bf250763ff12ULL, 0xfffbc0b301fde5e2ULL, - 0x8e60d4ce7d272117ULL, 0xe2ef7e4a0ec7fe25ULL, 0xfff7816603fbcbc4ULL, - 0x1cc1a99cfa4e422fULL, 0xc5defc941d8ffc4bULL, 0xffef02cc07f79788ULL, - 0x39835339f49c845fULL, 0x8bbdf9283b1ff897ULL, 0xffde05980fef2f11ULL, - 0x7306a673e93908bfULL, 0x177bf250763ff12fULL, 0xffbc0b301fde5e23ULL, - 0xe60d4ce7d272117eULL, 0x2ef7e4a0ec7fe25fULL, 0xff7816603fbcbc46ULL, - 0xcc1a99cfa4e422fcULL, 0x5defc941d8ffc4bfULL, 0xfef02cc07f79788cULL, - 0x9835339f49c845f8ULL, 0xbbdf9283b1ff897fULL, 0xfde05980fef2f118ULL, - 0x306a673e93908bf1ULL, 0x77bf250763ff12ffULL, 0xfbc0b301fde5e231ULL, - 0x60d4ce7d272117e2ULL, 0xef7e4a0ec7fe25ffULL, 0xf7816603fbcbc462ULL, - 0xc1a99cfa4e422fc5ULL, 0xdefc941d8ffc4bffULL, 0xef02cc07f79788c5ULL, - 0x835339f49c845f8bULL, 0xbdf9283b1ff897ffULL, 0xde05980fef2f118bULL, - 0x6a673e93908bf17ULL, 0x7bf250763ff12fffULL, 0xbc0b301fde5e2316ULL, - 0xd4ce7d272117e2eULL, 0xf7e4a0ec7fe25fffULL, 0x7816603fbcbc462dULL, - 0x1a99cfa4e422fc5dULL, 0xefc941d8ffc4bffeULL, 0xf02cc07f79788c5aULL, - 0x35339f49c845f8bbULL, 0xdf9283b1ff897ffdULL, 0xe05980fef2f118b5ULL, - 0x6a673e93908bf177ULL, 0xbf250763ff12fffbULL, 0xc0b301fde5e2316bULL, - 0xd4ce7d272117e2efULL, 0x7e4a0ec7fe25fff7ULL, 0x816603fbcbc462d6ULL, - 0xa99cfa4e422fc5deULL, 0xfc941d8ffc4bffefULL, 0x2cc07f79788c5adULL, - 0x5339f49c845f8bbdULL, 0xf9283b1ff897ffdeULL, 0x5980fef2f118b5aULL, - 0xa673e93908bf177bULL, 0xf250763ff12fffbcULL, 0xb301fde5e2316b4ULL, - 0x4ce7d272117e2ef7ULL, 0xe4a0ec7fe25fff78ULL, 0x16603fbcbc462d68ULL, - 0x99cfa4e422fc5defULL, 0xc941d8ffc4bffef0ULL, 0x2cc07f79788c5ad0ULL, - 0x339f49c845f8bbdfULL, 0x9283b1ff897ffde0ULL, 0x5980fef2f118b5a0ULL, - 0x673e93908bf177bfULL, 0x250763ff12fffbc0ULL, 0xb301fde5e2316b41ULL, - 0xce7d272117e2ef7eULL, 0x4a0ec7fe25fff781ULL, 0x6603fbcbc462d682ULL, - 0x9cfa4e422fc5defcULL, 0x941d8ffc4bffef02ULL, 0xcc07f79788c5ad05ULL, - 0x39f49c845f8bbdf9ULL, 0x283b1ff897ffde05ULL, 0x980fef2f118b5a0aULL, - 0x73e93908bf177bf2ULL, 0x50763ff12fffbc0bULL, 0x301fde5e2316b414ULL, - 0xe7d272117e2ef7e4ULL, 0xa0ec7fe25fff7816ULL, 0x603fbcbc462d6829ULL, - 0xcfa4e422fc5defc9ULL, 0x41d8ffc4bffef02cULL, 0xc07f79788c5ad053ULL, - 0x9f49c845f8bbdf92ULL, 0x83b1ff897ffde059ULL, 0x80fef2f118b5a0a6ULL, - 0x3e93908bf177bf25ULL, 0x763ff12fffbc0b3ULL, 0x1fde5e2316b414dULL, - 0x7d272117e2ef7e4aULL, 0xec7fe25fff78166ULL, 0x3fbcbc462d6829bULL, - 0xfa4e422fc5defc94ULL, 0x1d8ffc4bffef02ccULL, 0x7f79788c5ad0536ULL, - 0xf49c845f8bbdf928ULL, 0x3b1ff897ffde0598ULL, 0xfef2f118b5a0a6dULL, - 0xe93908bf177bf250ULL, 0x763ff12fffbc0b30ULL, 0x1fde5e2316b414daULL, - 0xd272117e2ef7e4a0ULL, 0xec7fe25fff781660ULL, 0x3fbcbc462d6829b4ULL, - 0xa4e422fc5defc941ULL, 0xd8ffc4bffef02cc0ULL, 0x7f79788c5ad05368ULL, - 0x49c845f8bbdf9283ULL, 0xb1ff897ffde05980ULL, 0xfef2f118b5a0a6d1ULL, - 0x93908bf177bf2507ULL, 0x63ff12fffbc0b301ULL, 0xfde5e2316b414da3ULL, - 0x272117e2ef7e4a0eULL, 0xc7fe25fff7816603ULL, 0xfbcbc462d6829b47ULL, - 0x4e422fc5defc941dULL, 0x8ffc4bffef02cc07ULL, 0xf79788c5ad05368fULL, - 0x9c845f8bbdf9283bULL, 0x1ff897ffde05980fULL, 0xef2f118b5a0a6d1fULL, - 0x3908bf177bf25076ULL, 0x3ff12fffbc0b301fULL, 0xde5e2316b414da3eULL, - 0x72117e2ef7e4a0ecULL, 0x7fe25fff7816603fULL, 0xbcbc462d6829b47dULL, - 0xe422fc5defc941d8ULL, 0xffc4bffef02cc07fULL, 0x79788c5ad05368fbULL, - 0xc845f8bbdf9283b1ULL, 0xff897ffde05980feULL, 0xf2f118b5a0a6d1f6ULL, - 0x908bf177bf250763ULL, 0xff12fffbc0b301fdULL, 0xe5e2316b414da3edULL, - 0x2117e2ef7e4a0ec7ULL, 0xfe25fff7816603fbULL, 0xcbc462d6829b47dbULL, - 0x422fc5defc941d8fULL, 0xfc4bffef02cc07f7ULL, 0x9788c5ad05368fb6ULL, - 0x845f8bbdf9283b1fULL, 0xf897ffde05980fefULL, 0x2f118b5a0a6d1f6dULL, - 0x8bf177bf250763fULL, 0xf12fffbc0b301fdeULL, 0x5e2316b414da3edaULL, - 0x117e2ef7e4a0ec7fULL, 0xe25fff7816603fbcULL, 0xbc462d6829b47db4ULL, - 0x22fc5defc941d8ffULL, 0xc4bffef02cc07f79ULL, 0x788c5ad05368fb69ULL, - 0x45f8bbdf9283b1ffULL, 0x897ffde05980fef2ULL, 0xf118b5a0a6d1f6d3ULL, - 0x8bf177bf250763ffULL, 0x12fffbc0b301fde5ULL, 0xe2316b414da3eda6ULL, - 0x17e2ef7e4a0ec7feULL, 0x25fff7816603fbcbULL, 0xc462d6829b47db4dULL, - 0x2fc5defc941d8ffcULL, 0x4bffef02cc07f797ULL, 0x88c5ad05368fb69bULL, - 0x5f8bbdf9283b1ff8ULL, 0x97ffde05980fef2fULL, 0x118b5a0a6d1f6d36ULL, - 0xbf177bf250763ff1ULL, 0x2fffbc0b301fde5eULL, 0x2316b414da3eda6cULL, - 0x7e2ef7e4a0ec7fe2ULL, 0x5fff7816603fbcbcULL, 0x462d6829b47db4d9ULL, - 0xfc5defc941d8ffc4ULL, 0xbffef02cc07f7978ULL, 0x8c5ad05368fb69b3ULL, - 0xf8bbdf9283b1ff89ULL, 0x7ffde05980fef2f1ULL, 0x18b5a0a6d1f6d367ULL, - 0xf177bf250763ff12ULL, 0xfffbc0b301fde5e2ULL, 0x316b414da3eda6cfULL, - 0xe2ef7e4a0ec7fe25ULL, 0xfff7816603fbcbc4ULL, 0x62d6829b47db4d9fULL, - 0xc5defc941d8ffc4bULL, 0xffef02cc07f79788ULL, 0xc5ad05368fb69b3fULL, - 0x8bbdf9283b1ff897ULL, 0xffde05980fef2f11ULL, 0x8b5a0a6d1f6d367eULL, - 0x177bf250763ff12fULL, 0xffbc0b301fde5e23ULL, 0x16b414da3eda6cfdULL, - 0x2ef7e4a0ec7fe25fULL, 0xff7816603fbcbc46ULL, 0x2d6829b47db4d9fbULL, - 0x5defc941d8ffc4bfULL, 0xfef02cc07f79788cULL, 0x5ad05368fb69b3f6ULL, - 0xbbdf9283b1ff897fULL, 0xfde05980fef2f118ULL, 0xb5a0a6d1f6d367ecULL, - 0x77bf250763ff12ffULL, 0xfbc0b301fde5e231ULL, 0x6b414da3eda6cfd9ULL, - 0xef7e4a0ec7fe25ffULL, 0xf7816603fbcbc462ULL, 0xd6829b47db4d9fb3ULL, - 0xdefc941d8ffc4bffULL, 0xef02cc07f79788c5ULL, 0xad05368fb69b3f67ULL, - 0xbdf9283b1ff897ffULL, 0xde05980fef2f118bULL, 0x5a0a6d1f6d367ecfULL, - 0x7bf250763ff12fffULL, 0xbc0b301fde5e2316ULL, 0xb414da3eda6cfd9eULL, - 0xf7e4a0ec7fe25fffULL, 0x7816603fbcbc462dULL, 0x6829b47db4d9fb3cULL, - 0xefc941d8ffc4bffeULL, 0xf02cc07f79788c5aULL, 0xd05368fb69b3f679ULL, - 0xdf9283b1ff897ffdULL, 0xe05980fef2f118b5ULL, 0xa0a6d1f6d367ecf2ULL, - 0xbf250763ff12fffbULL, 0xc0b301fde5e2316bULL, 0x414da3eda6cfd9e4ULL, - 0x7e4a0ec7fe25fff7ULL, 0x816603fbcbc462d6ULL, 0x829b47db4d9fb3c9ULL, - 0xfc941d8ffc4bffefULL, 0x2cc07f79788c5adULL, 0x5368fb69b3f6793ULL, - 0xf9283b1ff897ffdeULL, 0x5980fef2f118b5aULL, 0xa6d1f6d367ecf27ULL, - 0xf250763ff12fffbcULL, 0xb301fde5e2316b4ULL, 0x14da3eda6cfd9e4fULL, - 0xe4a0ec7fe25fff78ULL, 0x16603fbcbc462d68ULL, 0x29b47db4d9fb3c9fULL, - 0xc941d8ffc4bffef0ULL, 0x2cc07f79788c5ad0ULL, 0x5368fb69b3f6793eULL, - 0x9283b1ff897ffde0ULL, 0x5980fef2f118b5a0ULL, 0xa6d1f6d367ecf27cULL, - 0x250763ff12fffbc0ULL, 0xb301fde5e2316b41ULL, 0x4da3eda6cfd9e4f9ULL, - 0x4a0ec7fe25fff781ULL, 0x6603fbcbc462d682ULL, 0x9b47db4d9fb3c9f2ULL, - 0x941d8ffc4bffef02ULL, 0xcc07f79788c5ad05ULL, 0x368fb69b3f6793e5ULL, - 0x283b1ff897ffde05ULL, 0x980fef2f118b5a0aULL, 0x6d1f6d367ecf27cbULL, - 0x50763ff12fffbc0bULL, 0x301fde5e2316b414ULL, 0xda3eda6cfd9e4f96ULL, - 0xa0ec7fe25fff7816ULL, 0x603fbcbc462d6829ULL, 0xb47db4d9fb3c9f2cULL, - 0x41d8ffc4bffef02cULL, 0xc07f79788c5ad053ULL, 0x68fb69b3f6793e58ULL, - 0x83b1ff897ffde059ULL, 0x80fef2f118b5a0a6ULL, 0xd1f6d367ecf27cb0ULL, - 0x763ff12fffbc0b3ULL, 0x1fde5e2316b414dULL, 0xa3eda6cfd9e4f961ULL, - 0xec7fe25fff78166ULL, 0x3fbcbc462d6829bULL, 0x47db4d9fb3c9f2c2ULL, - 0x1d8ffc4bffef02ccULL, 0x7f79788c5ad0536ULL, 0x8fb69b3f6793e584ULL, - 0x3b1ff897ffde0598ULL, 0xfef2f118b5a0a6dULL, 0x1f6d367ecf27cb09ULL, - 0x763ff12fffbc0b30ULL, 0x1fde5e2316b414daULL, 0x3eda6cfd9e4f9613ULL, - 0xec7fe25fff781660ULL, 0x3fbcbc462d6829b4ULL, 0x7db4d9fb3c9f2c26ULL, - 0xd8ffc4bffef02cc0ULL, 0x7f79788c5ad05368ULL, 0xfb69b3f6793e584dULL, - 0xb1ff897ffde05980ULL, 0xfef2f118b5a0a6d1ULL, 0xf6d367ecf27cb09bULL, - 0x63ff12fffbc0b301ULL, 0xfde5e2316b414da3ULL, 0xeda6cfd9e4f96136ULL, - 0xc7fe25fff7816603ULL, 0xfbcbc462d6829b47ULL, 0xdb4d9fb3c9f2c26dULL, - 0x8ffc4bffef02cc07ULL, 0xf79788c5ad05368fULL, 0xb69b3f6793e584dbULL, - 0x1ff897ffde05980fULL, 0xef2f118b5a0a6d1fULL, 0x6d367ecf27cb09b7ULL, - 0x3ff12fffbc0b301fULL, 0xde5e2316b414da3eULL, 0xda6cfd9e4f96136eULL, - 0x7fe25fff7816603fULL, 0xbcbc462d6829b47dULL, 0xb4d9fb3c9f2c26ddULL, - 0xffc4bffef02cc07fULL, 0x79788c5ad05368fbULL, 0x69b3f6793e584dbaULL, - 0xff897ffde05980feULL, 0xf2f118b5a0a6d1f6ULL, 0xd367ecf27cb09b74ULL, - 0xff12fffbc0b301fdULL, 0xe5e2316b414da3edULL, 0xa6cfd9e4f96136e9ULL, - 0xfe25fff7816603fbULL, 0xcbc462d6829b47dbULL, 0x4d9fb3c9f2c26dd3ULL, - 0xfc4bffef02cc07f7ULL, 0x9788c5ad05368fb6ULL, 0x9b3f6793e584dba7ULL, - 0xf897ffde05980fefULL, 0x2f118b5a0a6d1f6dULL, 0x367ecf27cb09b74fULL, - 0xf12fffbc0b301fdeULL, 0x5e2316b414da3edaULL, 0x6cfd9e4f96136e9eULL, - 0xe25fff7816603fbcULL, 0xbc462d6829b47db4ULL, 0xd9fb3c9f2c26dd3dULL, - 0xc4bffef02cc07f79ULL, 0x788c5ad05368fb69ULL, 0xb3f6793e584dba7aULL, - 0x897ffde05980fef2ULL, 0xf118b5a0a6d1f6d3ULL, 0x67ecf27cb09b74f4ULL, - 0x12fffbc0b301fde5ULL, 0xe2316b414da3eda6ULL, 0xcfd9e4f96136e9e8ULL, - 0x25fff7816603fbcbULL, 0xc462d6829b47db4dULL, 0x9fb3c9f2c26dd3d1ULL, - 0x4bffef02cc07f797ULL, 0x88c5ad05368fb69bULL, 0x3f6793e584dba7a3ULL, - 0x97ffde05980fef2fULL, 0x118b5a0a6d1f6d36ULL, 0x7ecf27cb09b74f46ULL, - 0x2fffbc0b301fde5eULL, 0x2316b414da3eda6cULL, 0xfd9e4f96136e9e8cULL, - 0x5fff7816603fbcbcULL, 0x462d6829b47db4d9ULL, 0xfb3c9f2c26dd3d18ULL, - 0xbffef02cc07f7978ULL, 0x8c5ad05368fb69b3ULL, 0xf6793e584dba7a31ULL, - 0x7ffde05980fef2f1ULL, 0x18b5a0a6d1f6d367ULL, 0xecf27cb09b74f463ULL, - 0xfffbc0b301fde5e2ULL, 0x316b414da3eda6cfULL, 0xd9e4f96136e9e8c7ULL, - 0xfff7816603fbcbc4ULL, 0x62d6829b47db4d9fULL, 0xb3c9f2c26dd3d18fULL, - 0xffef02cc07f79788ULL, 0xc5ad05368fb69b3fULL, 0x6793e584dba7a31fULL, - 0xffde05980fef2f11ULL, 0x8b5a0a6d1f6d367eULL, 0xcf27cb09b74f463fULL, - 0xffbc0b301fde5e23ULL, 0x16b414da3eda6cfdULL, 0x9e4f96136e9e8c7eULL, - 0xff7816603fbcbc46ULL, 0x2d6829b47db4d9fbULL, 0x3c9f2c26dd3d18fdULL, - 0xfef02cc07f79788cULL, 0x5ad05368fb69b3f6ULL, 0x793e584dba7a31fbULL, - 0xfde05980fef2f118ULL, 0xb5a0a6d1f6d367ecULL, 0xf27cb09b74f463f6ULL, - 0xfbc0b301fde5e231ULL, 0x6b414da3eda6cfd9ULL, 0xe4f96136e9e8c7ecULL, - 0xf7816603fbcbc462ULL, 0xd6829b47db4d9fb3ULL, 0xc9f2c26dd3d18fd9ULL, - 0xef02cc07f79788c5ULL, 0xad05368fb69b3f67ULL, 0x93e584dba7a31fb3ULL, - 0xde05980fef2f118bULL, 0x5a0a6d1f6d367ecfULL, 0x27cb09b74f463f66ULL, - 0xbc0b301fde5e2316ULL, 0xb414da3eda6cfd9eULL, 0x4f96136e9e8c7ecdULL, - 0x7816603fbcbc462dULL, 0x6829b47db4d9fb3cULL, 0x9f2c26dd3d18fd9aULL, - 0xf02cc07f79788c5aULL, 0xd05368fb69b3f679ULL, 0x3e584dba7a31fb34ULL, - 0xe05980fef2f118b5ULL, 0xa0a6d1f6d367ecf2ULL, 0x7cb09b74f463f669ULL, - 0xc0b301fde5e2316bULL, 0x414da3eda6cfd9e4ULL, 0xf96136e9e8c7ecd3ULL, - 0x816603fbcbc462d6ULL, 0x829b47db4d9fb3c9ULL, 0xf2c26dd3d18fd9a7ULL, - 0x2cc07f79788c5adULL, 0x5368fb69b3f6793ULL, 0xe584dba7a31fb34fULL, - 0x5980fef2f118b5aULL, 0xa6d1f6d367ecf27ULL, 0xcb09b74f463f669eULL, - 0xb301fde5e2316b4ULL, 0x14da3eda6cfd9e4fULL, 0x96136e9e8c7ecd3cULL, - 0x16603fbcbc462d68ULL, 0x29b47db4d9fb3c9fULL, 0x2c26dd3d18fd9a79ULL, - 0x2cc07f79788c5ad0ULL, 0x5368fb69b3f6793eULL, 0x584dba7a31fb34f2ULL, - 0x5980fef2f118b5a0ULL, 0xa6d1f6d367ecf27cULL, 0xb09b74f463f669e5ULL, - 0xb301fde5e2316b41ULL, 0x4da3eda6cfd9e4f9ULL, 0x6136e9e8c7ecd3cbULL, - 0x6603fbcbc462d682ULL, 0x9b47db4d9fb3c9f2ULL, 0xc26dd3d18fd9a797ULL, - 0xcc07f79788c5ad05ULL, 0x368fb69b3f6793e5ULL, 0x84dba7a31fb34f2fULL, - 0x980fef2f118b5a0aULL, 0x6d1f6d367ecf27cbULL, 0x9b74f463f669e5fULL, - 0x301fde5e2316b414ULL, 0xda3eda6cfd9e4f96ULL, 0x136e9e8c7ecd3cbfULL, - 0x603fbcbc462d6829ULL, 0xb47db4d9fb3c9f2cULL, 0x26dd3d18fd9a797fULL, - 0xc07f79788c5ad053ULL, 0x68fb69b3f6793e58ULL, 0x4dba7a31fb34f2ffULL, - 0x80fef2f118b5a0a6ULL, 0xd1f6d367ecf27cb0ULL, 0x9b74f463f669e5feULL, - 0x1fde5e2316b414dULL, 0xa3eda6cfd9e4f961ULL, 0x36e9e8c7ecd3cbfdULL, - 0x3fbcbc462d6829bULL, 0x47db4d9fb3c9f2c2ULL, 0x6dd3d18fd9a797faULL, - 0x7f79788c5ad0536ULL, 0x8fb69b3f6793e584ULL, 0xdba7a31fb34f2ff5ULL, - 0xfef2f118b5a0a6dULL, 0x1f6d367ecf27cb09ULL, 0xb74f463f669e5feaULL, - 0x1fde5e2316b414daULL, 0x3eda6cfd9e4f9613ULL, 0x6e9e8c7ecd3cbfd4ULL, - 0x3fbcbc462d6829b4ULL, 0x7db4d9fb3c9f2c26ULL, 0xdd3d18fd9a797fa8ULL, - 0x7f79788c5ad05368ULL, 0xfb69b3f6793e584dULL, 0xba7a31fb34f2ff51ULL, - 0xfef2f118b5a0a6d1ULL, 0xf6d367ecf27cb09bULL, 0x74f463f669e5fea2ULL, - 0xfde5e2316b414da3ULL, 0xeda6cfd9e4f96136ULL, 0xe9e8c7ecd3cbfd45ULL, - 0xfbcbc462d6829b47ULL, 0xdb4d9fb3c9f2c26dULL, 0xd3d18fd9a797fa8bULL, - 0xf79788c5ad05368fULL, 0xb69b3f6793e584dbULL, 0xa7a31fb34f2ff516ULL, - 0xef2f118b5a0a6d1fULL, 0x6d367ecf27cb09b7ULL, 0x4f463f669e5fea2dULL, - 0xde5e2316b414da3eULL, 0xda6cfd9e4f96136eULL, 0x9e8c7ecd3cbfd45aULL, - 0xbcbc462d6829b47dULL, 0xb4d9fb3c9f2c26ddULL, 0x3d18fd9a797fa8b5ULL, - 0x79788c5ad05368fbULL, 0x69b3f6793e584dbaULL, 0x7a31fb34f2ff516bULL, - 0xf2f118b5a0a6d1f6ULL, 0xd367ecf27cb09b74ULL, 0xf463f669e5fea2d7ULL, - 0xe5e2316b414da3edULL, 0xa6cfd9e4f96136e9ULL, 0xe8c7ecd3cbfd45aeULL, - 0xcbc462d6829b47dbULL, 0x4d9fb3c9f2c26dd3ULL, 0xd18fd9a797fa8b5dULL, - 0x9788c5ad05368fb6ULL, 0x9b3f6793e584dba7ULL, 0xa31fb34f2ff516baULL, - 0x2f118b5a0a6d1f6dULL, 0x367ecf27cb09b74fULL, 0x463f669e5fea2d75ULL, - 0x5e2316b414da3edaULL, 0x6cfd9e4f96136e9eULL, 0x8c7ecd3cbfd45aeaULL, - 0xbc462d6829b47db4ULL, 0xd9fb3c9f2c26dd3dULL, 0x18fd9a797fa8b5d4ULL, - 0x788c5ad05368fb69ULL, 0xb3f6793e584dba7aULL, 0x31fb34f2ff516ba9ULL, - 0xf118b5a0a6d1f6d3ULL, 0x67ecf27cb09b74f4ULL, 0x63f669e5fea2d752ULL, - 0xe2316b414da3eda6ULL, 0xcfd9e4f96136e9e8ULL, 0xc7ecd3cbfd45aea4ULL, - 0xc462d6829b47db4dULL, 0x9fb3c9f2c26dd3d1ULL, 0x8fd9a797fa8b5d49ULL, - 0x88c5ad05368fb69bULL, 0x3f6793e584dba7a3ULL, 0x1fb34f2ff516ba93ULL, - 0x118b5a0a6d1f6d36ULL, 0x7ecf27cb09b74f46ULL, 0x3f669e5fea2d7527ULL, - 0x2316b414da3eda6cULL, 0xfd9e4f96136e9e8cULL, 0x7ecd3cbfd45aea4fULL, - 0x462d6829b47db4d9ULL, 0xfb3c9f2c26dd3d18ULL, 0xfd9a797fa8b5d49eULL, - 0x8c5ad05368fb69b3ULL, 0xf6793e584dba7a31ULL, 0xfb34f2ff516ba93dULL, - 0x18b5a0a6d1f6d367ULL, 0xecf27cb09b74f463ULL, 0xf669e5fea2d7527bULL, - 0x316b414da3eda6cfULL, 0xd9e4f96136e9e8c7ULL, 0xecd3cbfd45aea4f7ULL, - 0x62d6829b47db4d9fULL, 0xb3c9f2c26dd3d18fULL, 0xd9a797fa8b5d49eeULL, - 0xc5ad05368fb69b3fULL, 0x6793e584dba7a31fULL, 0xb34f2ff516ba93ddULL, - 0x8b5a0a6d1f6d367eULL, 0xcf27cb09b74f463fULL, 0x669e5fea2d7527baULL, - 0x16b414da3eda6cfdULL, 0x9e4f96136e9e8c7eULL, 0xcd3cbfd45aea4f75ULL, - 0x2d6829b47db4d9fbULL, 0x3c9f2c26dd3d18fdULL, 0x9a797fa8b5d49eebULL, - 0x5ad05368fb69b3f6ULL, 0x793e584dba7a31fbULL, 0x34f2ff516ba93dd6ULL, - 0xb5a0a6d1f6d367ecULL, 0xf27cb09b74f463f6ULL, 0x69e5fea2d7527bacULL, - 0x6b414da3eda6cfd9ULL, 0xe4f96136e9e8c7ecULL, 0xd3cbfd45aea4f758ULL, - 0xd6829b47db4d9fb3ULL, 0xc9f2c26dd3d18fd9ULL, 0xa797fa8b5d49eeb1ULL, - 0xad05368fb69b3f67ULL, 0x93e584dba7a31fb3ULL, 0x4f2ff516ba93dd63ULL, - 0x5a0a6d1f6d367ecfULL, 0x27cb09b74f463f66ULL, 0x9e5fea2d7527bac7ULL, - 0xb414da3eda6cfd9eULL, 0x4f96136e9e8c7ecdULL, 0x3cbfd45aea4f758fULL, - 0x6829b47db4d9fb3cULL, 0x9f2c26dd3d18fd9aULL, 0x797fa8b5d49eeb1fULL, - 0xd05368fb69b3f679ULL, 0x3e584dba7a31fb34ULL, 0xf2ff516ba93dd63fULL, - 0xa0a6d1f6d367ecf2ULL, 0x7cb09b74f463f669ULL, 0xe5fea2d7527bac7eULL, - 0x414da3eda6cfd9e4ULL, 0xf96136e9e8c7ecd3ULL, 0xcbfd45aea4f758fdULL, - 0x829b47db4d9fb3c9ULL, 0xf2c26dd3d18fd9a7ULL, 0x97fa8b5d49eeb1faULL, - 0x5368fb69b3f6793ULL, 0xe584dba7a31fb34fULL, 0x2ff516ba93dd63f5ULL, - 0xa6d1f6d367ecf27ULL, 0xcb09b74f463f669eULL, 0x5fea2d7527bac7ebULL, - 0x14da3eda6cfd9e4fULL, 0x96136e9e8c7ecd3cULL, 0xbfd45aea4f758fd7ULL, - 0x29b47db4d9fb3c9fULL, 0x2c26dd3d18fd9a79ULL, 0x7fa8b5d49eeb1fafULL, - 0x5368fb69b3f6793eULL, 0x584dba7a31fb34f2ULL, 0xff516ba93dd63f5fULL, - 0xa6d1f6d367ecf27cULL, 0xb09b74f463f669e5ULL, 0xfea2d7527bac7ebeULL, - 0x4da3eda6cfd9e4f9ULL, 0x6136e9e8c7ecd3cbULL, 0xfd45aea4f758fd7cULL, - 0x9b47db4d9fb3c9f2ULL, 0xc26dd3d18fd9a797ULL, 0xfa8b5d49eeb1faf9ULL, - 0x368fb69b3f6793e5ULL, 0x84dba7a31fb34f2fULL, 0xf516ba93dd63f5f2ULL, - 0x6d1f6d367ecf27cbULL, 0x9b74f463f669e5fULL, 0xea2d7527bac7ebe5ULL, - 0xda3eda6cfd9e4f96ULL, 0x136e9e8c7ecd3cbfULL, 0xd45aea4f758fd7cbULL, - 0xb47db4d9fb3c9f2cULL, 0x26dd3d18fd9a797fULL, 0xa8b5d49eeb1faf97ULL, - 0x68fb69b3f6793e58ULL, 0x4dba7a31fb34f2ffULL, 0x516ba93dd63f5f2fULL, - 0xd1f6d367ecf27cb0ULL, 0x9b74f463f669e5feULL, 0xa2d7527bac7ebe5fULL, - 0xa3eda6cfd9e4f961ULL, 0x36e9e8c7ecd3cbfdULL, 0x45aea4f758fd7cbeULL, - 0x47db4d9fb3c9f2c2ULL, 0x6dd3d18fd9a797faULL, 0x8b5d49eeb1faf97cULL, - 0x8fb69b3f6793e584ULL, 0xdba7a31fb34f2ff5ULL, 0x16ba93dd63f5f2f8ULL, - 0x1f6d367ecf27cb09ULL, 0xb74f463f669e5feaULL, 0x2d7527bac7ebe5f1ULL, - 0x3eda6cfd9e4f9613ULL, 0x6e9e8c7ecd3cbfd4ULL, 0x5aea4f758fd7cbe2ULL, - 0x7db4d9fb3c9f2c26ULL, 0xdd3d18fd9a797fa8ULL, 0xb5d49eeb1faf97c5ULL, - 0xfb69b3f6793e584dULL, 0xba7a31fb34f2ff51ULL, 0x6ba93dd63f5f2f8bULL, - 0xf6d367ecf27cb09bULL, 0x74f463f669e5fea2ULL, 0xd7527bac7ebe5f17ULL, - 0xeda6cfd9e4f96136ULL, 0xe9e8c7ecd3cbfd45ULL, 0xaea4f758fd7cbe2fULL, - 0xdb4d9fb3c9f2c26dULL, 0xd3d18fd9a797fa8bULL, 0x5d49eeb1faf97c5eULL, - 0xb69b3f6793e584dbULL, 0xa7a31fb34f2ff516ULL, 0xba93dd63f5f2f8bdULL, - 0x6d367ecf27cb09b7ULL, 0x4f463f669e5fea2dULL, 0x7527bac7ebe5f17bULL, - 0xda6cfd9e4f96136eULL, 0x9e8c7ecd3cbfd45aULL, 0xea4f758fd7cbe2f6ULL, - 0xb4d9fb3c9f2c26ddULL, 0x3d18fd9a797fa8b5ULL, 0xd49eeb1faf97c5ecULL, - 0x69b3f6793e584dbaULL, 0x7a31fb34f2ff516bULL, 0xa93dd63f5f2f8bd9ULL, - 0xd367ecf27cb09b74ULL, 0xf463f669e5fea2d7ULL, 0x527bac7ebe5f17b3ULL, - 0xa6cfd9e4f96136e9ULL, 0xe8c7ecd3cbfd45aeULL, 0xa4f758fd7cbe2f67ULL, - 0x4d9fb3c9f2c26dd3ULL, 0xd18fd9a797fa8b5dULL, 0x49eeb1faf97c5ecfULL, - 0x9b3f6793e584dba7ULL, 0xa31fb34f2ff516baULL, 0x93dd63f5f2f8bd9eULL, - 0x367ecf27cb09b74fULL, 0x463f669e5fea2d75ULL, 0x27bac7ebe5f17b3dULL, - 0x6cfd9e4f96136e9eULL, 0x8c7ecd3cbfd45aeaULL, 0x4f758fd7cbe2f67aULL, - 0xd9fb3c9f2c26dd3dULL, 0x18fd9a797fa8b5d4ULL, 0x9eeb1faf97c5ecf4ULL, - 0xb3f6793e584dba7aULL, 0x31fb34f2ff516ba9ULL, 0x3dd63f5f2f8bd9e8ULL, - 0x67ecf27cb09b74f4ULL, 0x63f669e5fea2d752ULL, 0x7bac7ebe5f17b3d0ULL, - 0xcfd9e4f96136e9e8ULL, 0xc7ecd3cbfd45aea4ULL, 0xf758fd7cbe2f67a0ULL, - 0x9fb3c9f2c26dd3d1ULL, 0x8fd9a797fa8b5d49ULL, 0xeeb1faf97c5ecf41ULL, - 0x3f6793e584dba7a3ULL, 0x1fb34f2ff516ba93ULL, 0xdd63f5f2f8bd9e83ULL, - 0x7ecf27cb09b74f46ULL, 0x3f669e5fea2d7527ULL, 0xbac7ebe5f17b3d07ULL, - 0xfd9e4f96136e9e8cULL, 0x7ecd3cbfd45aea4fULL, 0x758fd7cbe2f67a0eULL, - 0xfb3c9f2c26dd3d18ULL, 0xfd9a797fa8b5d49eULL, 0xeb1faf97c5ecf41cULL, - 0xf6793e584dba7a31ULL, 0xfb34f2ff516ba93dULL, 0xd63f5f2f8bd9e839ULL, - 0xecf27cb09b74f463ULL, 0xf669e5fea2d7527bULL, 0xac7ebe5f17b3d073ULL, - 0xd9e4f96136e9e8c7ULL, 0xecd3cbfd45aea4f7ULL, 0x58fd7cbe2f67a0e7ULL, - 0xb3c9f2c26dd3d18fULL, 0xd9a797fa8b5d49eeULL, 0xb1faf97c5ecf41ceULL, - 0x6793e584dba7a31fULL, 0xb34f2ff516ba93ddULL, 0x63f5f2f8bd9e839cULL, - 0xcf27cb09b74f463fULL, 0x669e5fea2d7527baULL, 0xc7ebe5f17b3d0739ULL, - 0x9e4f96136e9e8c7eULL, 0xcd3cbfd45aea4f75ULL, 0x8fd7cbe2f67a0e73ULL, - 0x3c9f2c26dd3d18fdULL, 0x9a797fa8b5d49eebULL, 0x1faf97c5ecf41ce7ULL, - 0x793e584dba7a31fbULL, 0x34f2ff516ba93dd6ULL, 0x3f5f2f8bd9e839cfULL, - 0xf27cb09b74f463f6ULL, 0x69e5fea2d7527bacULL, 0x7ebe5f17b3d0739fULL, - 0xe4f96136e9e8c7ecULL, 0xd3cbfd45aea4f758ULL, 0xfd7cbe2f67a0e73eULL, - 0xc9f2c26dd3d18fd9ULL, 0xa797fa8b5d49eeb1ULL, 0xfaf97c5ecf41ce7dULL, - 0x93e584dba7a31fb3ULL, 0x4f2ff516ba93dd63ULL, 0xf5f2f8bd9e839cfbULL, - 0x27cb09b74f463f66ULL, 0x9e5fea2d7527bac7ULL, 0xebe5f17b3d0739f7ULL, - 0x4f96136e9e8c7ecdULL, 0x3cbfd45aea4f758fULL, 0xd7cbe2f67a0e73efULL, - 0x9f2c26dd3d18fd9aULL, 0x797fa8b5d49eeb1fULL, 0xaf97c5ecf41ce7deULL, - 0x3e584dba7a31fb34ULL, 0xf2ff516ba93dd63fULL, 0x5f2f8bd9e839cfbcULL, - 0x7cb09b74f463f669ULL, 0xe5fea2d7527bac7eULL, 0xbe5f17b3d0739f78ULL, - 0xf96136e9e8c7ecd3ULL, 0xcbfd45aea4f758fdULL, 0x7cbe2f67a0e73ef1ULL, - 0xf2c26dd3d18fd9a7ULL, 0x97fa8b5d49eeb1faULL, 0xf97c5ecf41ce7de2ULL, - 0xe584dba7a31fb34fULL, 0x2ff516ba93dd63f5ULL, 0xf2f8bd9e839cfbc5ULL, - 0xcb09b74f463f669eULL, 0x5fea2d7527bac7ebULL, 0xe5f17b3d0739f78aULL, - 0x96136e9e8c7ecd3cULL, 0xbfd45aea4f758fd7ULL, 0xcbe2f67a0e73ef14ULL, - 0x2c26dd3d18fd9a79ULL, 0x7fa8b5d49eeb1fafULL, 0x97c5ecf41ce7de29ULL, - 0x584dba7a31fb34f2ULL, 0xff516ba93dd63f5fULL, 0x2f8bd9e839cfbc52ULL, - 0xb09b74f463f669e5ULL, 0xfea2d7527bac7ebeULL, 0x5f17b3d0739f78a5ULL, - 0x6136e9e8c7ecd3cbULL, 0xfd45aea4f758fd7cULL, 0xbe2f67a0e73ef14aULL, - 0xc26dd3d18fd9a797ULL, 0xfa8b5d49eeb1faf9ULL, 0x7c5ecf41ce7de294ULL, - 0x84dba7a31fb34f2fULL, 0xf516ba93dd63f5f2ULL, 0xf8bd9e839cfbc529ULL, - 0x9b74f463f669e5fULL, 0xea2d7527bac7ebe5ULL, 0xf17b3d0739f78a52ULL, - 0x136e9e8c7ecd3cbfULL, 0xd45aea4f758fd7cbULL, 0xe2f67a0e73ef14a5ULL, - 0x26dd3d18fd9a797fULL, 0xa8b5d49eeb1faf97ULL, 0xc5ecf41ce7de294aULL, - 0x4dba7a31fb34f2ffULL, 0x516ba93dd63f5f2fULL, 0x8bd9e839cfbc5294ULL, - 0x9b74f463f669e5feULL, 0xa2d7527bac7ebe5fULL, 0x17b3d0739f78a529ULL, - 0x36e9e8c7ecd3cbfdULL, 0x45aea4f758fd7cbeULL, 0x2f67a0e73ef14a52ULL, - 0x6dd3d18fd9a797faULL, 0x8b5d49eeb1faf97cULL, 0x5ecf41ce7de294a4ULL, - 0xdba7a31fb34f2ff5ULL, 0x16ba93dd63f5f2f8ULL, 0xbd9e839cfbc52949ULL, - 0xb74f463f669e5feaULL, 0x2d7527bac7ebe5f1ULL, 0x7b3d0739f78a5292ULL, - 0x6e9e8c7ecd3cbfd4ULL, 0x5aea4f758fd7cbe2ULL, 0xf67a0e73ef14a525ULL, - 0xdd3d18fd9a797fa8ULL, 0xb5d49eeb1faf97c5ULL, 0xecf41ce7de294a4bULL, - 0xba7a31fb34f2ff51ULL, 0x6ba93dd63f5f2f8bULL, 0xd9e839cfbc529497ULL, - 0x74f463f669e5fea2ULL, 0xd7527bac7ebe5f17ULL, 0xb3d0739f78a5292eULL, - 0xe9e8c7ecd3cbfd45ULL, 0xaea4f758fd7cbe2fULL, 0x67a0e73ef14a525dULL, - 0xd3d18fd9a797fa8bULL, 0x5d49eeb1faf97c5eULL, 0xcf41ce7de294a4baULL, - 0xa7a31fb34f2ff516ULL, 0xba93dd63f5f2f8bdULL, 0x9e839cfbc5294975ULL, - 0x4f463f669e5fea2dULL, 0x7527bac7ebe5f17bULL, 0x3d0739f78a5292eaULL, - 0x9e8c7ecd3cbfd45aULL, 0xea4f758fd7cbe2f6ULL, 0x7a0e73ef14a525d4ULL, - 0x3d18fd9a797fa8b5ULL, 0xd49eeb1faf97c5ecULL, 0xf41ce7de294a4ba9ULL, - 0x7a31fb34f2ff516bULL, 0xa93dd63f5f2f8bd9ULL, 0xe839cfbc52949753ULL, - 0xf463f669e5fea2d7ULL, 0x527bac7ebe5f17b3ULL, 0xd0739f78a5292ea6ULL, - 0xe8c7ecd3cbfd45aeULL, 0xa4f758fd7cbe2f67ULL, 0xa0e73ef14a525d4dULL, - 0xd18fd9a797fa8b5dULL, 0x49eeb1faf97c5ecfULL, 0x41ce7de294a4ba9aULL, - 0xa31fb34f2ff516baULL, 0x93dd63f5f2f8bd9eULL, 0x839cfbc529497535ULL, - 0x463f669e5fea2d75ULL, 0x27bac7ebe5f17b3dULL, 0x739f78a5292ea6bULL, - 0x8c7ecd3cbfd45aeaULL, 0x4f758fd7cbe2f67aULL, 0xe73ef14a525d4d7ULL, - 0x18fd9a797fa8b5d4ULL, 0x9eeb1faf97c5ecf4ULL, 0x1ce7de294a4ba9afULL, - 0x31fb34f2ff516ba9ULL, 0x3dd63f5f2f8bd9e8ULL, 0x39cfbc529497535fULL, - 0x63f669e5fea2d752ULL, 0x7bac7ebe5f17b3d0ULL, 0x739f78a5292ea6bfULL, - 0xc7ecd3cbfd45aea4ULL, 0xf758fd7cbe2f67a0ULL, 0xe73ef14a525d4d7fULL, - 0x8fd9a797fa8b5d49ULL, 0xeeb1faf97c5ecf41ULL, 0xce7de294a4ba9afeULL, - 0x1fb34f2ff516ba93ULL, 0xdd63f5f2f8bd9e83ULL, 0x9cfbc529497535fdULL, - 0x3f669e5fea2d7527ULL, 0xbac7ebe5f17b3d07ULL, 0x39f78a5292ea6bfbULL, - 0x7ecd3cbfd45aea4fULL, 0x758fd7cbe2f67a0eULL, 0x73ef14a525d4d7f6ULL, - 0xfd9a797fa8b5d49eULL, 0xeb1faf97c5ecf41cULL, 0xe7de294a4ba9afedULL, - 0xfb34f2ff516ba93dULL, 0xd63f5f2f8bd9e839ULL, 0xcfbc529497535fdaULL, - 0xf669e5fea2d7527bULL, 0xac7ebe5f17b3d073ULL, 0x9f78a5292ea6bfb5ULL, - 0xecd3cbfd45aea4f7ULL, 0x58fd7cbe2f67a0e7ULL, 0x3ef14a525d4d7f6bULL, - 0xd9a797fa8b5d49eeULL, 0xb1faf97c5ecf41ceULL, 0x7de294a4ba9afed7ULL, - 0xb34f2ff516ba93ddULL, 0x63f5f2f8bd9e839cULL, 0xfbc529497535fdafULL, - 0x669e5fea2d7527baULL, 0xc7ebe5f17b3d0739ULL, 0xf78a5292ea6bfb5fULL, - 0xcd3cbfd45aea4f75ULL, 0x8fd7cbe2f67a0e73ULL, 0xef14a525d4d7f6bfULL, - 0x9a797fa8b5d49eebULL, 0x1faf97c5ecf41ce7ULL, 0xde294a4ba9afed7eULL, - 0x34f2ff516ba93dd6ULL, 0x3f5f2f8bd9e839cfULL, 0xbc529497535fdafdULL, - 0x69e5fea2d7527bacULL, 0x7ebe5f17b3d0739fULL, 0x78a5292ea6bfb5fbULL, - 0xd3cbfd45aea4f758ULL, 0xfd7cbe2f67a0e73eULL, 0xf14a525d4d7f6bf6ULL, - 0xa797fa8b5d49eeb1ULL, 0xfaf97c5ecf41ce7dULL, 0xe294a4ba9afed7ecULL, - 0x4f2ff516ba93dd63ULL, 0xf5f2f8bd9e839cfbULL, 0xc529497535fdafd8ULL, - 0x9e5fea2d7527bac7ULL, 0xebe5f17b3d0739f7ULL, 0x8a5292ea6bfb5fb1ULL, - 0x3cbfd45aea4f758fULL, 0xd7cbe2f67a0e73efULL, 0x14a525d4d7f6bf62ULL, - 0x797fa8b5d49eeb1fULL, 0xaf97c5ecf41ce7deULL, 0x294a4ba9afed7ec4ULL, - 0xf2ff516ba93dd63fULL, 0x5f2f8bd9e839cfbcULL, 0x529497535fdafd88ULL, - 0xe5fea2d7527bac7eULL, 0xbe5f17b3d0739f78ULL, 0xa5292ea6bfb5fb11ULL, - 0xcbfd45aea4f758fdULL, 0x7cbe2f67a0e73ef1ULL, 0x4a525d4d7f6bf623ULL, - 0x97fa8b5d49eeb1faULL, 0xf97c5ecf41ce7de2ULL, 0x94a4ba9afed7ec47ULL, - 0x2ff516ba93dd63f5ULL, 0xf2f8bd9e839cfbc5ULL, 0x29497535fdafd88fULL, - 0x5fea2d7527bac7ebULL, 0xe5f17b3d0739f78aULL, 0x5292ea6bfb5fb11fULL, - 0xbfd45aea4f758fd7ULL, 0xcbe2f67a0e73ef14ULL, 0xa525d4d7f6bf623fULL, - 0x7fa8b5d49eeb1fafULL, 0x97c5ecf41ce7de29ULL, 0x4a4ba9afed7ec47eULL, - 0xff516ba93dd63f5fULL, 0x2f8bd9e839cfbc52ULL, 0x9497535fdafd88fcULL, - 0xfea2d7527bac7ebeULL, 0x5f17b3d0739f78a5ULL, 0x292ea6bfb5fb11f8ULL, - 0xfd45aea4f758fd7cULL, 0xbe2f67a0e73ef14aULL, 0x525d4d7f6bf623f1ULL, - 0xfa8b5d49eeb1faf9ULL, 0x7c5ecf41ce7de294ULL, 0xa4ba9afed7ec47e3ULL, - 0xf516ba93dd63f5f2ULL, 0xf8bd9e839cfbc529ULL, 0x497535fdafd88fc6ULL, - 0xea2d7527bac7ebe5ULL, 0xf17b3d0739f78a52ULL, 0x92ea6bfb5fb11f8dULL, - 0xd45aea4f758fd7cbULL, 0xe2f67a0e73ef14a5ULL, 0x25d4d7f6bf623f1aULL, - 0xa8b5d49eeb1faf97ULL, 0xc5ecf41ce7de294aULL, 0x4ba9afed7ec47e35ULL, - 0x516ba93dd63f5f2fULL, 0x8bd9e839cfbc5294ULL, 0x97535fdafd88fc6aULL, - 0xa2d7527bac7ebe5fULL, 0x17b3d0739f78a529ULL, 0x2ea6bfb5fb11f8d5ULL, - 0x45aea4f758fd7cbeULL, 0x2f67a0e73ef14a52ULL, 0x5d4d7f6bf623f1abULL, - 0x8b5d49eeb1faf97cULL, 0x5ecf41ce7de294a4ULL, 0xba9afed7ec47e357ULL, - 0x16ba93dd63f5f2f8ULL, 0xbd9e839cfbc52949ULL, 0x7535fdafd88fc6aeULL, - 0x2d7527bac7ebe5f1ULL, 0x7b3d0739f78a5292ULL, 0xea6bfb5fb11f8d5dULL, - 0x5aea4f758fd7cbe2ULL, 0xf67a0e73ef14a525ULL, 0xd4d7f6bf623f1abaULL, - 0xb5d49eeb1faf97c5ULL, 0xecf41ce7de294a4bULL, 0xa9afed7ec47e3574ULL, - 0x6ba93dd63f5f2f8bULL, 0xd9e839cfbc529497ULL, 0x535fdafd88fc6ae8ULL, - 0xd7527bac7ebe5f17ULL, 0xb3d0739f78a5292eULL, 0xa6bfb5fb11f8d5d0ULL, - 0xaea4f758fd7cbe2fULL, 0x67a0e73ef14a525dULL, 0x4d7f6bf623f1aba1ULL, - 0x5d49eeb1faf97c5eULL, 0xcf41ce7de294a4baULL, 0x9afed7ec47e35742ULL, - 0xba93dd63f5f2f8bdULL, 0x9e839cfbc5294975ULL, 0x35fdafd88fc6ae84ULL, - 0x7527bac7ebe5f17bULL, 0x3d0739f78a5292eaULL, 0x6bfb5fb11f8d5d08ULL, - 0xea4f758fd7cbe2f6ULL, 0x7a0e73ef14a525d4ULL, 0xd7f6bf623f1aba10ULL, - 0xd49eeb1faf97c5ecULL, 0xf41ce7de294a4ba9ULL, 0xafed7ec47e357421ULL, - 0xa93dd63f5f2f8bd9ULL, 0xe839cfbc52949753ULL, 0x5fdafd88fc6ae842ULL, - 0x527bac7ebe5f17b3ULL, 0xd0739f78a5292ea6ULL, 0xbfb5fb11f8d5d085ULL, - 0xa4f758fd7cbe2f67ULL, 0xa0e73ef14a525d4dULL, 0x7f6bf623f1aba10aULL, - 0x49eeb1faf97c5ecfULL, 0x41ce7de294a4ba9aULL, 0xfed7ec47e3574215ULL, - 0x93dd63f5f2f8bd9eULL, 0x839cfbc529497535ULL, 0xfdafd88fc6ae842bULL, - 0x27bac7ebe5f17b3dULL, 0x739f78a5292ea6bULL, 0xfb5fb11f8d5d0856ULL, - 0x4f758fd7cbe2f67aULL, 0xe73ef14a525d4d7ULL, 0xf6bf623f1aba10acULL, - 0x9eeb1faf97c5ecf4ULL, 0x1ce7de294a4ba9afULL, 0xed7ec47e35742158ULL, -}; -}} // namespace {namespace} -#endif // NPSR_TRIG_DATA_LARGE_REDUCTION_H_PY diff --git a/npsr/trig/data/large-reduction.h.py b/npsr/trig/data/large-reduction.h.py deleted file mode 100644 index 6bb051b..0000000 --- a/npsr/trig/data/large-reduction.h.py +++ /dev/null @@ -1,51 +0,0 @@ -#!/usr/bin/env python3 -""" -Precompute int(2^exp × 4/π) with ~96-bit precision (f32) or ~192-bit precision (f64) -and split them into three chunks: 32-bit chunks for single precision, 64-bit chunks for double precision. - -This generates a lookup table for large range reduction in trigonometric functions. -The table is used to compute mantissa × (2^exp × 4/π) using wider integer multiplications for precision: -- f32: 16×16 → 32-bit multiplications -- f64: 32×32 → 64-bit multiplications - -For input x = mantissa × 2^exp, the algorithm becomes: -x × 4/π = mantissa × table_lookup[exp], providing high precision without floating-point errors. - -Args: - float_size: 32 for f32 or 64 for f64 -""" -from generator import c_array, c_header, sollya - - -def gen_reduction(float_size=64): - exp = (1 << (8 if float_size == 32 else 11)) - 1 - offset = 70 if float_size == 32 else 137 - bias = exp >> 1 - sol = f""" - prec = {bias + offset + 1}; - four_over_pi = 4 / pi; - for e from 0 to {exp} do {{ - e_shift = e - {bias} + {offset}; - floor(four_over_pi * (2^e_shift)); - }}; - """ - ints = sollya(sol, as_int=10) - chunk_mask = (1 << float_size) - 1 - chunks = [ - hex((i >> shift) & chunk_mask) - for i in ints - for shift in [float_size * 2, float_size, 0] - ] - return chunks - - -print( - c_header( - "template constexpr T kLargeReductionTable[] = {};", - "template <> constexpr uint32_t kLargeReductionTable[] = " - + c_array(gen_reduction(32), col=3, sfx="U"), - "template <> constexpr uint64_t kLargeReductionTable[] = " - + c_array(gen_reduction(64), col=3, sfx="ULL"), - namespace="npsr::trig::data", - ) -) diff --git a/npsr/trig/data/reduction.h b/npsr/trig/data/reduction.h new file mode 100644 index 0000000..950afbe --- /dev/null +++ b/npsr/trig/data/reduction.h @@ -0,0 +1,2320 @@ +// Auto-generated by npsr/trig/data/reduction.h.sol +// Use `spin generate -f` to force regeneration +#ifndef NPSR_TRIG_DATA_REDUCTION_H +#define NPSR_TRIG_DATA_REDUCTION_H + +namespace npsr::trig::data { +template constexpr T kLargeReductionTable[] = {}; +template <> constexpr uint32_t kLargeReductionTable[] = { + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 0u, + 0u, 0u, 1u, + 0u, 0u, 2u, + 0u, 0u, 5u, + 0u, 0u, 10u, + 0u, 0u, 20u, + 0u, 0u, 40u, + 0u, 0u, 81u, + 0u, 0u, 162u, + 0u, 0u, 325u, + 0u, 0u, 651u, + 0u, 0u, 1303u, + 0u, 0u, 2607u, + 0u, 0u, 5215u, + 0u, 0u, 10430u, + 0u, 0u, 20860u, + 0u, 0u, 41721u, + 0u, 0u, 83443u, + 0u, 0u, 166886u, + 0u, 0u, 333772u, + 0u, 0u, 667544u, + 0u, 0u, 1335088u, + 0u, 0u, 2670176u, + 0u, 0u, 5340353u, + 0u, 0u, 10680707u, + 0u, 0u, 21361414u, + 0u, 0u, 42722829u, + 0u, 0u, 85445659u, + 0u, 0u, 170891318u, + 0u, 0u, 341782637u, + 0u, 0u, 683565275u, + 0u, 0u, 1367130551u, + 0u, 0u, 2734261102u, + 0u, 1u, 1173554908u, + 0u, 2u, 2347109817u, + 0u, 5u, 399252338u, + 0u, 10u, 798504676u, + 0u, 20u, 1597009353u, + 0u, 40u, 3194018707u, + 0u, 81u, 2093070119u, + 0u, 162u, 4186140238u, + 0u, 325u, 4077313180u, + 0u, 651u, 3859659065u, + 0u, 1303u, 3424350834u, + 0u, 2607u, 2553734372u, + 0u, 5215u, 812501448u, + 0u, 10430u, 1625002897u, + 0u, 20860u, 3250005794u, + 0u, 41721u, 2205044292u, + 0u, 83443u, 115121288u, + 0u, 166886u, 230242576u, + 0u, 333772u, 460485152u, + 0u, 667544u, 920970305u, + 0u, 1335088u, 1841940610u, + 0u, 2670176u, 3683881221u, + 0u, 5340353u, 3072795146u, + 0u, 10680707u, 1850622997u, + 0u, 21361414u, 3701245994u, + 0u, 42722829u, 3107524692u, + 0u, 85445659u, 1920082089u, + 0u, 170891318u, 3840164178u, + 0u, 341782637u, 3385361061u, + 0u, 683565275u, 2475754826u, + 0u, 1367130551u, 656542356u, + 0u, 2734261102u, 1313084713u, + 1u, 1173554908u, 2626169427u, + 2u, 2347109817u, 957371559u, + 5u, 399252338u, 1914743119u, + 10u, 798504676u, 3829486239u, + 20u, 1597009353u, 3364005183u, + 40u, 3194018707u, 2433043071u, + 81u, 2093070119u, 571118846u, + 162u, 4186140238u, 1142237692u, + 325u, 4077313180u, 2284475384u, + 651u, 3859659065u, 273983472u, + 1303u, 3424350834u, 547966945u, + 2607u, 2553734372u, 1095933890u, + 5215u, 812501448u, 2191867780u, + 10430u, 1625002897u, 88768265u, + 20860u, 3250005794u, 177536531u, + 41721u, 2205044292u, 355073063u, + 83443u, 115121288u, 710146126u, + 166886u, 230242576u, 1420292253u, + 333772u, 460485152u, 2840584506u, + 667544u, 920970305u, 1386201717u, + 1335088u, 1841940610u, 2772403434u, + 2670176u, 3683881221u, 1249839573u, + 5340353u, 3072795146u, 2499679147u, + 10680707u, 1850622997u, 704390999u, + 21361414u, 3701245994u, 1408781999u, + 42722829u, 3107524692u, 2817563999u, + 85445659u, 1920082089u, 1340160702u, + 170891318u, 3840164178u, 2680321405u, + 341782637u, 3385361061u, 1065675514u, + 683565275u, 2475754826u, 2131351028u, + 1367130551u, 656542356u, 4262702056u, + 2734261102u, 1313084713u, 4230436817u, + 1173554908u, 2626169427u, 4165906339u, + 2347109817u, 957371559u, 4036845383u, + 399252338u, 1914743119u, 3778723471u, + 798504676u, 3829486239u, 3262479647u, + 1597009353u, 3364005183u, 2229991998u, + 3194018707u, 2433043071u, 165016701u, + 2093070119u, 571118846u, 330033402u, + 4186140238u, 1142237692u, 660066805u, + 4077313180u, 2284475384u, 1320133610u, + 3859659065u, 273983472u, 2640267220u, + 3424350834u, 547966945u, 985567145u, + 2553734372u, 1095933890u, 1971134291u, + 812501448u, 2191867780u, 3942268582u, + 1625002897u, 88768265u, 3589569869u, + 3250005794u, 177536531u, 2884172442u, + 2205044292u, 355073063u, 1473377588u, + 115121288u, 710146126u, 2946755177u, + 230242576u, 1420292253u, 1598543059u, + 460485152u, 2840584506u, 3197086118u, + 920970305u, 1386201717u, 2099204941u, + 1841940610u, 2772403434u, 4198409883u, + 3683881221u, 1249839573u, 4101852471u, + 3072795146u, 2499679147u, 3908737646u, + 1850622997u, 704390999u, 3522507997u, + 3701245994u, 1408781999u, 2750048699u, + 3107524692u, 2817563999u, 1205130103u, + 1920082089u, 1340160702u, 2410260206u, + 3840164178u, 2680321405u, 525553116u, + 3385361061u, 1065675514u, 1051106232u, + 2475754826u, 2131351028u, 2102212464u, + 656542356u, 4262702056u, 4204424928u, + 1313084713u, 4230436817u, 4113882560u, + 2626169427u, 4165906339u, 3932797825u, + 957371559u, 4036845383u, 3570628355u, + 1914743119u, 3778723471u, 2846289414u, + 3829486239u, 3262479647u, 1397611533u, + 3364005183u, 2229991998u, 2795223067u, + 2433043071u, 165016701u, 1295478838u, + 571118846u, 330033402u, 2590957677u, + 1142237692u, 660066805u, 886948059u, + 2284475384u, 1320133610u, 1773896118u, + 273983472u, 2640267220u, 3547792237u, + 547966945u, 985567145u, 2800617179u, + 1095933890u, 1971134291u, 1306267062u, + 2191867780u, 3942268582u, 2612534124u, + 88768265u, 3589569869u, 930100952u, + 177536531u, 2884172442u, 1860201905u, + 355073063u, 1473377588u, 3720403810u, + 710146126u, 2946755177u, 3145840325u, + 1420292253u, 1598543059u, 1996713354u, + 2840584506u, 3197086118u, 3993426708u, + 1386201717u, 2099204941u, 3691886121u, + 2772403434u, 4198409883u, 3088804946u, + 1249839573u, 4101852471u, 1882642597u, + 2499679147u, 3908737646u, 3765285194u, + 704390999u, 3522507997u, 3235603093u, + 1408781999u, 2750048699u, 2176238891u, + 2817563999u, 1205130103u, 57510486u, + 1340160702u, 2410260206u, 115020972u, + 2680321405u, 525553116u, 230041945u, + 1065675514u, 1051106232u, 460083891u, + 2131351028u, 2102212464u, 920167782u, + 4262702056u, 4204424928u, 1840335564u, + 4230436817u, 4113882560u, 3680671129u, + 4165906339u, 3932797825u, 3066374962u, + 4036845383u, 3570628355u, 1837782628u, + 3778723471u, 2846289414u, 3675565257u, + 3262479647u, 1397611533u, 3056163219u, + 2229991998u, 2795223067u, 1817359143u, + 165016701u, 1295478838u, 3634718287u, + 330033402u, 2590957677u, 2974469278u, + 660066805u, 886948059u, 1653971260u, + 1320133610u, 1773896118u, 3307942520u, + 2640267220u, 3547792237u, 2320917745u, + 985567145u, 2800617179u, 346868194u, + 1971134291u, 1306267062u, 693736388u, + 3942268582u, 2612534124u, 1387472776u, + 3589569869u, 930100952u, 2774945552u, + 2884172442u, 1860201905u, 1254923809u, + 1473377588u, 3720403810u, 2509847619u, + 2946755177u, 3145840325u, 724727943u, + 1598543059u, 1996713354u, 1449455886u, + 3197086118u, 3993426708u, 2898911772u, + 2099204941u, 3691886121u, 1502856249u, + 4198409883u, 3088804946u, 3005712498u, + 4101852471u, 1882642597u, 1716457700u, + 3908737646u, 3765285194u, 3432915400u, + 3522507997u, 3235603093u, 2570863504u, + 2750048699u, 2176238891u, 846759712u, + 1205130103u, 57510486u, 1693519425u, + 2410260206u, 115020972u, 3387038850u, + 525553116u, 230041945u, 2479110404u, + 1051106232u, 460083891u, 663253512u, + 2102212464u, 920167782u, 1326507024u, + 4204424928u, 1840335564u, 2653014048u, + 4113882560u, 3680671129u, 1011060801u, + 3932797825u, 3066374962u, 2022121603u, + 3570628355u, 1837782628u, 4044243207u, + 2846289414u, 3675565257u, 3793519119u, + 1397611533u, 3056163219u, 3292070943u, + 2795223067u, 1817359143u, 2289174591u, + 1295478838u, 3634718287u, 283381887u, + 2590957677u, 2974469278u, 566763775u, +};; + +template <> constexpr uint64_t kLargeReductionTable[] = { + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 0ull, + 0ull, 0ull, 1ull, + 0ull, 0ull, 2ull, + 0ull, 0ull, 5ull, + 0ull, 0ull, 10ull, + 0ull, 0ull, 20ull, + 0ull, 0ull, 40ull, + 0ull, 0ull, 81ull, + 0ull, 0ull, 162ull, + 0ull, 0ull, 325ull, + 0ull, 0ull, 651ull, + 0ull, 0ull, 1303ull, + 0ull, 0ull, 2607ull, + 0ull, 0ull, 5215ull, + 0ull, 0ull, 10430ull, + 0ull, 0ull, 20860ull, + 0ull, 0ull, 41721ull, + 0ull, 0ull, 83443ull, + 0ull, 0ull, 166886ull, + 0ull, 0ull, 333772ull, + 0ull, 0ull, 667544ull, + 0ull, 0ull, 1335088ull, + 0ull, 0ull, 2670176ull, + 0ull, 0ull, 5340353ull, + 0ull, 0ull, 10680707ull, + 0ull, 0ull, 21361414ull, + 0ull, 0ull, 42722829ull, + 0ull, 0ull, 85445659ull, + 0ull, 0ull, 170891318ull, + 0ull, 0ull, 341782637ull, + 0ull, 0ull, 683565275ull, + 0ull, 0ull, 1367130551ull, + 0ull, 0ull, 2734261102ull, + 0ull, 0ull, 5468522204ull, + 0ull, 0ull, 10937044409ull, + 0ull, 0ull, 21874088818ull, + 0ull, 0ull, 43748177636ull, + 0ull, 0ull, 87496355273ull, + 0ull, 0ull, 174992710547ull, + 0ull, 0ull, 349985421095ull, + 0ull, 0ull, 699970842190ull, + 0ull, 0ull, 1399941684380ull, + 0ull, 0ull, 2799883368761ull, + 0ull, 0ull, 5599766737522ull, + 0ull, 0ull, 11199533475044ull, + 0ull, 0ull, 22399066950088ull, + 0ull, 0ull, 44798133900177ull, + 0ull, 0ull, 89596267800354ull, + 0ull, 0ull, 179192535600708ull, + 0ull, 0ull, 358385071201416ull, + 0ull, 0ull, 716770142402832ull, + 0ull, 0ull, 1433540284805664ull, + 0ull, 0ull, 2867080569611329ull, + 0ull, 0ull, 5734161139222658ull, + 0ull, 0ull, 11468322278445317ull, + 0ull, 0ull, 22936644556890634ull, + 0ull, 0ull, 45873289113781269ull, + 0ull, 0ull, 91746578227562538ull, + 0ull, 0ull, 183493156455125076ull, + 0ull, 0ull, 366986312910250153ull, + 0ull, 0ull, 733972625820500306ull, + 0ull, 0ull, 1467945251641000613ull, + 0ull, 0ull, 2935890503282001226ull, + 0ull, 0ull, 5871781006564002452ull, + 0ull, 0ull, 11743562013128004905ull, + 0ull, 1ull, 5040379952546458195ull, + 0ull, 2ull, 10080759905092916391ull, + 0ull, 5ull, 1714775736476281167ull, + 0ull, 10ull, 3429551472952562335ull, + 0ull, 20ull, 6859102945905124671ull, + 0ull, 40ull, 13718205891810249343ull, + 0ull, 81ull, 8989667709910947070ull, + 0ull, 162ull, 17979335419821894140ull, + 0ull, 325ull, 17511926765934236664ull, + 0ull, 651ull, 16577109458158921712ull, + 0ull, 1303ull, 14707474842608291809ull, + 0ull, 2607ull, 10968205611507032002ull, + 0ull, 5215ull, 3489667149304512388ull, + 0ull, 10430ull, 6979334298609024777ull, + 0ull, 20860ull, 13958668597218049555ull, + 0ull, 41721ull, 9470593120726547495ull, + 0ull, 83443ull, 494442167743543374ull, + 0ull, 166886ull, 988884335487086749ull, + 0ull, 333772ull, 1977768670974173498ull, + 0ull, 667544ull, 3955537341948346997ull, + 0ull, 1335088ull, 7911074683896693994ull, + 0ull, 2670176ull, 15822149367793387989ull, + 0ull, 5340353ull, 13197554661877224363ull, + 0ull, 10680707ull, 7948365250044897111ull, + 0ull, 21361414ull, 15896730500089794223ull, + 0ull, 42722829ull, 13346716926470036831ull, + 0ull, 85445659ull, 8246689779230522046ull, + 0ull, 170891318ull, 16493379558461044093ull, + 0ull, 341782637ull, 14540015043212536570ull, + 0ull, 683565275ull, 10633286012715521524ull, + 0ull, 1367130551ull, 2819827951721491432ull, + 0ull, 2734261102ull, 5639655903442982865ull, + 0ull, 5468522204ull, 11279311806885965731ull, + 0ull, 10937044409ull, 4111879540062379847ull, + 0ull, 21874088818ull, 8223759080124759695ull, + 0ull, 43748177636ull, 16447518160249519391ull, + 0ull, 87496355273ull, 14448292246789487166ull, + 0ull, 174992710547ull, 10449840419869422717ull, + 0ull, 349985421095ull, 2452936766029293818ull, + 0ull, 699970842190ull, 4905873532058587637ull, + 0ull, 1399941684380ull, 9811747064117175274ull, + 0ull, 2799883368761ull, 1176750054524798932ull, + 0ull, 5599766737522ull, 2353500109049597865ull, + 0ull, 11199533475044ull, 4707000218099195731ull, + 0ull, 22399066950088ull, 9414000436198391462ull, + 0ull, 44798133900177ull, 381256798687231309ull, + 0ull, 89596267800354ull, 762513597374462618ull, + 0ull, 179192535600708ull, 1525027194748925236ull, + 0ull, 358385071201416ull, 3050054389497850473ull, + 0ull, 716770142402832ull, 6100108778995700947ull, + 0ull, 1433540284805664ull, 12200217557991401894ull, + 0ull, 2867080569611329ull, 5953691042273252173ull, + 0ull, 5734161139222658ull, 11907382084546504347ull, + 0ull, 11468322278445317ull, 5368020095383457079ull, + 0ull, 22936644556890634ull, 10736040190766914158ull, + 0ull, 45873289113781269ull, 3025336307824276701ull, + 0ull, 91746578227562538ull, 6050672615648553403ull, + 0ull, 183493156455125076ull, 12101345231297106807ull, + 0ull, 366986312910250153ull, 5755946388884661998ull, + 0ull, 733972625820500306ull, 11511892777769323996ull, + 0ull, 1467945251641000613ull, 4577041481829096376ull, + 0ull, 2935890503282001226ull, 9154082963658192752ull, + 0ull, 5871781006564002452ull, 18308165927316385504ull, + 0ull, 11743562013128004905ull, 18169587780923219392ull, + 1ull, 5040379952546458195ull, 17892431488136887169ull, + 2ull, 10080759905092916391ull, 17338118902564222723ull, + 5ull, 1714775736476281167ull, 16229493731418893830ull, + 10ull, 3429551472952562335ull, 14012243389128236045ull, + 20ull, 6859102945905124671ull, 9577742704546920475ull, + 40ull, 13718205891810249343ull, 708741335384289334ull, + 81ull, 8989667709910947070ull, 1417482670768578669ull, + 162ull, 17979335419821894140ull, 2834965341537157339ull, + 325ull, 17511926765934236664ull, 5669930683074314678ull, + 651ull, 16577109458158921712ull, 11339861366148629357ull, + 1303ull, 14707474842608291809ull, 4232978658587707099ull, + 2607ull, 10968205611507032002ull, 8465957317175414198ull, + 5215ull, 3489667149304512388ull, 16931914634350828396ull, + 10430ull, 6979334298609024777ull, 15417085194992105176ull, + 20860ull, 13958668597218049555ull, 12387426316274658737ull, + 41721ull, 9470593120726547495ull, 6328108558839765858ull, + 83443ull, 494442167743543374ull, 12656217117679531717ull, + 166886ull, 988884335487086749ull, 6865690161649511818ull, + 333772ull, 1977768670974173498ull, 13731380323299023636ull, + 667544ull, 3955537341948346997ull, 9016016572888495657ull, + 1335088ull, 7911074683896693994ull, 18032033145776991314ull, + 2670176ull, 15822149367793387989ull, 17617322217844431013ull, + 5340353ull, 13197554661877224363ull, 16787900361979310410ull, + 10680707ull, 7948365250044897111ull, 15129056650249069205ull, + 21361414ull, 15896730500089794223ull, 11811369226788586795ull, + 42722829ull, 13346716926470036831ull, 5175994379867621974ull, + 85445659ull, 8246689779230522046ull, 10351988759735243948ull, + 170891318ull, 16493379558461044093ull, 2257233445760936281ull, + 341782637ull, 14540015043212536570ull, 4514466891521872563ull, + 683565275ull, 10633286012715521524ull, 9028933783043745126ull, + 1367130551ull, 2819827951721491432ull, 18057867566087490252ull, + 2734261102ull, 5639655903442982865ull, 17668991058465428889ull, + 5468522204ull, 11279311806885965731ull, 16891238043221306162ull, + 10937044409ull, 4111879540062379847ull, 15335732012733060708ull, + 21874088818ull, 8223759080124759695ull, 12224719951756569801ull, + 43748177636ull, 16447518160249519391ull, 6002695829803587987ull, + 87496355273ull, 14448292246789487166ull, 12005391659607175975ull, + 174992710547ull, 10449840419869422717ull, 5564039245504800335ull, + 349985421095ull, 2452936766029293818ull, 11128078491009600670ull, + 699970842190ull, 4905873532058587637ull, 3809412908309649724ull, + 1399941684380ull, 9811747064117175274ull, 7618825816619299448ull, + 2799883368761ull, 1176750054524798932ull, 15237651633238598897ull, + 5599766737522ull, 2353500109049597865ull, 12028559192767646178ull, + 11199533475044ull, 4707000218099195731ull, 5610374311825740740ull, + 22399066950088ull, 9414000436198391462ull, 11220748623651481480ull, + 44798133900177ull, 381256798687231309ull, 3994753173593411344ull, + 89596267800354ull, 762513597374462618ull, 7989506347186822689ull, + 179192535600708ull, 1525027194748925236ull, 15979012694373645379ull, + 358385071201416ull, 3050054389497850473ull, 13511281315037739143ull, + 716770142402832ull, 6100108778995700947ull, 8575818556365926670ull, + 1433540284805664ull, 12200217557991401894ull, 17151637112731853340ull, + 2867080569611329ull, 5953691042273252173ull, 15856530151754155065ull, + 5734161139222658ull, 11907382084546504347ull, 13266316229798758514ull, + 11468322278445317ull, 5368020095383457079ull, 8085888385887965412ull, + 22936644556890634ull, 10736040190766914158ull, 16171776771775930824ull, + 45873289113781269ull, 3025336307824276701ull, 13896809469842310032ull, + 91746578227562538ull, 6050672615648553403ull, 9346874865975068448ull, + 183493156455125076ull, 12101345231297106807ull, 247005658240585281ull, + 366986312910250153ull, 5755946388884661998ull, 494011316481170562ull, + 733972625820500306ull, 11511892777769323996ull, 988022632962341124ull, + 1467945251641000613ull, 4577041481829096376ull, 1976045265924682248ull, + 2935890503282001226ull, 9154082963658192752ull, 3952090531849364496ull, + 5871781006564002452ull, 18308165927316385504ull, 7904181063698728992ull, + 11743562013128004905ull, 18169587780923219392ull, 15808362127397457985ull, + 5040379952546458195ull, 17892431488136887169ull, 13169980181085364355ull, + 10080759905092916391ull, 17338118902564222723ull, 7893216288461177095ull, + 1714775736476281167ull, 16229493731418893830ull, 15786432576922354191ull, + 3429551472952562335ull, 14012243389128236045ull, 13126121080135156767ull, + 6859102945905124671ull, 9577742704546920475ull, 7805498086560761919ull, + 13718205891810249343ull, 708741335384289334ull, 15610996173121523839ull, + 8989667709910947070ull, 1417482670768578669ull, 12775248272533496063ull, + 17979335419821894140ull, 2834965341537157339ull, 7103752471357440510ull, + 17511926765934236664ull, 5669930683074314678ull, 14207504942714881020ull, + 16577109458158921712ull, 11339861366148629357ull, 9968265811720210425ull, + 14707474842608291809ull, 4232978658587707099ull, 1489787549730869234ull, + 10968205611507032002ull, 8465957317175414198ull, 2979575099461738469ull, + 3489667149304512388ull, 16931914634350828396ull, 5959150198923476938ull, + 6979334298609024777ull, 15417085194992105176ull, 11918300397846953876ull, + 13958668597218049555ull, 12387426316274658737ull, 5389856721984356136ull, + 9470593120726547495ull, 6328108558839765858ull, 10779713443968712273ull, + 494442167743543374ull, 12656217117679531717ull, 3112682814227872930ull, + 988884335487086749ull, 6865690161649511818ull, 6225365628455745861ull, + 1977768670974173498ull, 13731380323299023636ull, 12450731256911491723ull, + 3955537341948346997ull, 9016016572888495657ull, 6454718440113431830ull, + 7911074683896693994ull, 18032033145776991314ull, 12909436880226863660ull, + 15822149367793387989ull, 17617322217844431013ull, 7372129686744175704ull, + 13197554661877224363ull, 16787900361979310410ull, 14744259373488351409ull, + 7948365250044897111ull, 15129056650249069205ull, 11041774673267151203ull, + 15896730500089794223ull, 11811369226788586795ull, 3636805272824750791ull, + 13346716926470036831ull, 5175994379867621974ull, 7273610545649501582ull, + 8246689779230522046ull, 10351988759735243948ull, 14547221091299003165ull, + 16493379558461044093ull, 2257233445760936281ull, 10647698108888454714ull, + 14540015043212536570ull, 4514466891521872563ull, 2848652144067357813ull, + 10633286012715521524ull, 9028933783043745126ull, 5697304288134715626ull, + 2819827951721491432ull, 18057867566087490252ull, 11394608576269431253ull, + 5639655903442982865ull, 17668991058465428889ull, 4342473078829310891ull, + 11279311806885965731ull, 16891238043221306162ull, 8684946157658621783ull, + 4111879540062379847ull, 15335732012733060708ull, 17369892315317243567ull, + 8223759080124759695ull, 12224719951756569801ull, 16293040556924935518ull, + 16447518160249519391ull, 6002695829803587987ull, 14139337040140319421ull, + 14448292246789487166ull, 12005391659607175975ull, 9831930006571087227ull, + 10449840419869422717ull, 5564039245504800335ull, 1217115939432622839ull, + 2452936766029293818ull, 11128078491009600670ull, 2434231878865245679ull, + 4905873532058587637ull, 3809412908309649724ull, 4868463757730491358ull, + 9811747064117175274ull, 7618825816619299448ull, 9736927515460982717ull, + 1176750054524798932ull, 15237651633238598897ull, 1027110957212413818ull, + 2353500109049597865ull, 12028559192767646178ull, 2054221914424827637ull, + 4707000218099195731ull, 5610374311825740740ull, 4108443828849655275ull, + 9414000436198391462ull, 11220748623651481480ull, 8216887657699310551ull, + 381256798687231309ull, 3994753173593411344ull, 16433775315398621102ull, + 762513597374462618ull, 7989506347186822689ull, 14420806557087690589ull, + 1525027194748925236ull, 15979012694373645379ull, 10394869040465829563ull, + 3050054389497850473ull, 13511281315037739143ull, 2342994007222107511ull, + 6100108778995700947ull, 8575818556365926670ull, 4685988014444215023ull, + 12200217557991401894ull, 17151637112731853340ull, 9371976028888430046ull, + 5953691042273252173ull, 15856530151754155065ull, 297207984067308476ull, + 11907382084546504347ull, 13266316229798758514ull, 594415968134616952ull, + 5368020095383457079ull, 8085888385887965412ull, 1188831936269233905ull, + 10736040190766914158ull, 16171776771775930824ull, 2377663872538467810ull, + 3025336307824276701ull, 13896809469842310032ull, 4755327745076935621ull, + 6050672615648553403ull, 9346874865975068448ull, 9510655490153871242ull, + 12101345231297106807ull, 247005658240585281ull, 574566906598190869ull, + 5755946388884661998ull, 494011316481170562ull, 1149133813196381739ull, + 11511892777769323996ull, 988022632962341124ull, 2298267626392763478ull, + 4577041481829096376ull, 1976045265924682248ull, 4596535252785526956ull, + 9154082963658192752ull, 3952090531849364496ull, 9193070505571053912ull, + 18308165927316385504ull, 7904181063698728992ull, 18386141011142107824ull, + 18169587780923219392ull, 15808362127397457985ull, 18325537948574664033ull, + 17892431488136887169ull, 13169980181085364355ull, 18204331823439776451ull, + 17338118902564222723ull, 7893216288461177095ull, 17961919573170001286ull, + 16229493731418893830ull, 15786432576922354191ull, 17477095072630450957ull, + 14012243389128236045ull, 13126121080135156767ull, 16507446071551350299ull, + 9577742704546920475ull, 7805498086560761919ull, 14568148069393148982ull, + 708741335384289334ull, 15610996173121523839ull, 10689552065076746349ull, + 1417482670768578669ull, 12775248272533496063ull, 2932360056443941083ull, + 2834965341537157339ull, 7103752471357440510ull, 5864720112887882167ull, + 5669930683074314678ull, 14207504942714881020ull, 11729440225775764334ull, + 11339861366148629357ull, 9968265811720210425ull, 5012136377841977052ull, + 4232978658587707099ull, 1489787549730869234ull, 10024272755683954105ull, + 8465957317175414198ull, 2979575099461738469ull, 1601801437658356594ull, + 16931914634350828396ull, 5959150198923476938ull, 3203602875316713188ull, + 15417085194992105176ull, 11918300397846953876ull, 6407205750633426377ull, + 12387426316274658737ull, 5389856721984356136ull, 12814411501266852754ull, + 6328108558839765858ull, 10779713443968712273ull, 7182078928824153892ull, + 12656217117679531717ull, 3112682814227872930ull, 14364157857648307784ull, + 6865690161649511818ull, 6225365628455745861ull, 10281571641587063953ull, + 13731380323299023636ull, 12450731256911491723ull, 2116399209464576291ull, + 9016016572888495657ull, 6454718440113431830ull, 4232798418929152582ull, + 18032033145776991314ull, 12909436880226863660ull, 8465596837858305165ull, + 17617322217844431013ull, 7372129686744175704ull, 16931193675716610331ull, + 16787900361979310410ull, 14744259373488351409ull, 15415643277723669047ull, + 15129056650249069205ull, 11041774673267151203ull, 12384542481737786478ull, + 11811369226788586795ull, 3636805272824750791ull, 6322340889766021340ull, + 5175994379867621974ull, 7273610545649501582ull, 12644681779532042680ull, + 10351988759735243948ull, 14547221091299003165ull, 6842619485354533745ull, + 2257233445760936281ull, 10647698108888454714ull, 13685238970709067491ull, + 4514466891521872563ull, 2848652144067357813ull, 8923733867708583367ull, + 9028933783043745126ull, 5697304288134715626ull, 17847467735417166734ull, + 18057867566087490252ull, 11394608576269431253ull, 17248191397124781853ull, + 17668991058465428889ull, 4342473078829310891ull, 16049638720540012090ull, + 16891238043221306162ull, 8684946157658621783ull, 13652533367370472564ull, + 15335732012733060708ull, 17369892315317243567ull, 8858322661031393513ull, + 12224719951756569801ull, 16293040556924935518ull, 17716645322062787026ull, + 6002695829803587987ull, 14139337040140319421ull, 16986546570416022436ull, + 12005391659607175975ull, 9831930006571087227ull, 15526349067122493256ull, + 5564039245504800335ull, 1217115939432622839ull, 12605954060535434896ull, + 11128078491009600670ull, 2434231878865245679ull, 6765164047361318177ull, + 3809412908309649724ull, 4868463757730491358ull, 13530328094722636354ull, + 7618825816619299448ull, 9736927515460982717ull, 8613912115735721092ull, + 15237651633238598897ull, 1027110957212413818ull, 17227824231471442185ull, + 12028559192767646178ull, 2054221914424827637ull, 16008904389233332754ull, + 5610374311825740740ull, 4108443828849655275ull, 13571064704757113892ull, + 11220748623651481480ull, 8216887657699310551ull, 8695385335804676169ull, + 3994753173593411344ull, 16433775315398621102ull, 17390770671609352339ull, + 7989506347186822689ull, 14420806557087690589ull, 16334797269509153062ull, + 15979012694373645379ull, 10394869040465829563ull, 14222850465308754509ull, + 13511281315037739143ull, 2342994007222107511ull, 9998956856907957403ull, + 8575818556365926670ull, 4685988014444215023ull, 1551169640106363191ull, + 17151637112731853340ull, 9371976028888430046ull, 3102339280212726382ull, + 15856530151754155065ull, 297207984067308476ull, 6204678560425452765ull, + 13266316229798758514ull, 594415968134616952ull, 12409357120850905530ull, + 8085888385887965412ull, 1188831936269233905ull, 6371970167992259444ull, + 16171776771775930824ull, 2377663872538467810ull, 12743940335984518889ull, + 13896809469842310032ull, 4755327745076935621ull, 7041136598259486162ull, + 9346874865975068448ull, 9510655490153871242ull, 14082273196518972325ull, + 247005658240585281ull, 574566906598190869ull, 9717802319328393035ull, + 494011316481170562ull, 1149133813196381739ull, 988860564947234455ull, + 988022632962341124ull, 2298267626392763478ull, 1977721129894468910ull, + 1976045265924682248ull, 4596535252785526956ull, 3955442259788937820ull, + 3952090531849364496ull, 9193070505571053912ull, 7910884519577875640ull, + 7904181063698728992ull, 18386141011142107824ull, 15821769039155751280ull, + 15808362127397457985ull, 18325537948574664033ull, 13196794004601950944ull, + 13169980181085364355ull, 18204331823439776451ull, 7946843935494350272ull, + 7893216288461177095ull, 17961919573170001286ull, 15893687870988700544ull, + 15786432576922354191ull, 17477095072630450957ull, 13340631668267849472ull, + 13126121080135156767ull, 16507446071551350299ull, 8234519262826147328ull, + 7805498086560761919ull, 14568148069393148982ull, 16469038525652294656ull, + 15610996173121523839ull, 10689552065076746349ull, 14491332977595037697ull, + 12775248272533496063ull, 2932360056443941083ull, 10535921881480523779ull, + 7103752471357440510ull, 5864720112887882167ull, 2625099689251495942ull, + 14207504942714881020ull, 11729440225775764334ull, 5250199378502991884ull, + 9968265811720210425ull, 5012136377841977052ull, 10500398757005983769ull, + 1489787549730869234ull, 10024272755683954105ull, 2554053440302415922ull, + 2979575099461738469ull, 1601801437658356594ull, 5108106880604831844ull, + 5959150198923476938ull, 3203602875316713188ull, 10216213761209663689ull, + 11918300397846953876ull, 6407205750633426377ull, 1985683448709775762ull, + 5389856721984356136ull, 12814411501266852754ull, 3971366897419551524ull, + 10779713443968712273ull, 7182078928824153892ull, 7942733794839103049ull, + 3112682814227872930ull, 14364157857648307784ull, 15885467589678206098ull, + 6225365628455745861ull, 10281571641587063953ull, 13324191105646860580ull, + 12450731256911491723ull, 2116399209464576291ull, 8201638137584169545ull, + 6454718440113431830ull, 4232798418929152582ull, 16403276275168339090ull, + 12909436880226863660ull, 8465596837858305165ull, 14359808476627126565ull, + 7372129686744175704ull, 16931193675716610331ull, 10272872879544701515ull, + 14744259373488351409ull, 15415643277723669047ull, 2099001685379851415ull, + 11041774673267151203ull, 12384542481737786478ull, 4198003370759702830ull, + 3636805272824750791ull, 6322340889766021340ull, 8396006741519405661ull, + 7273610545649501582ull, 12644681779532042680ull, 16792013483038811323ull, + 14547221091299003165ull, 6842619485354533745ull, 15137282892368071031ull, + 10647698108888454714ull, 13685238970709067491ull, 11827821711026590446ull, + 2848652144067357813ull, 8923733867708583367ull, 5208899348343629277ull, + 5697304288134715626ull, 17847467735417166734ull, 10417798696687258554ull, + 11394608576269431253ull, 17248191397124781853ull, 2388853319664965493ull, + 4342473078829310891ull, 16049638720540012090ull, 4777706639329930986ull, + 8684946157658621783ull, 13652533367370472564ull, 9555413278659861972ull, + 17369892315317243567ull, 8858322661031393513ull, 664082483610172328ull, + 16293040556924935518ull, 17716645322062787026ull, 1328164967220344656ull, + 14139337040140319421ull, 16986546570416022436ull, 2656329934440689312ull, + 9831930006571087227ull, 15526349067122493256ull, 5312659868881378625ull, + 1217115939432622839ull, 12605954060535434896ull, 10625319737762757250ull, + 2434231878865245679ull, 6765164047361318177ull, 2803895401815962884ull, + 4868463757730491358ull, 13530328094722636354ull, 5607790803631925769ull, + 9736927515460982717ull, 8613912115735721092ull, 11215581607263851539ull, + 1027110957212413818ull, 17227824231471442185ull, 3984419140818151463ull, + 2054221914424827637ull, 16008904389233332754ull, 7968838281636302926ull, + 4108443828849655275ull, 13571064704757113892ull, 15937676563272605853ull, + 8216887657699310551ull, 8695385335804676169ull, 13428609052835660090ull, + 16433775315398621102ull, 17390770671609352339ull, 8410474031961768564ull, + 14420806557087690589ull, 16334797269509153062ull, 16820948063923537128ull, + 10394869040465829563ull, 14222850465308754509ull, 15195152054137522641ull, + 2342994007222107511ull, 9998956856907957403ull, 11943560034565493667ull, + 4685988014444215023ull, 1551169640106363191ull, 5440375995421435718ull, + 9371976028888430046ull, 3102339280212726382ull, 10880751990842871436ull, + 297207984067308476ull, 6204678560425452765ull, 3314759907976191257ull, + 594415968134616952ull, 12409357120850905530ull, 6629519815952382514ull, + 1188831936269233905ull, 6371970167992259444ull, 13259039631904765028ull, + 2377663872538467810ull, 12743940335984518889ull, 8071335190099978441ull, + 4755327745076935621ull, 7041136598259486162ull, 16142670380199956882ull, + 9510655490153871242ull, 14082273196518972325ull, 13838596686690362148ull, + 574566906598190869ull, 9717802319328393035ull, 9230449299671172680ull, + 1149133813196381739ull, 988860564947234455ull, 14154525632793744ull, + 2298267626392763478ull, 1977721129894468910ull, 28309051265587489ull, + 4596535252785526956ull, 3955442259788937820ull, 56618102531174979ull, + 9193070505571053912ull, 7910884519577875640ull, 113236205062349959ull, + 18386141011142107824ull, 15821769039155751280ull, 226472410124699918ull, + 18325537948574664033ull, 13196794004601950944ull, 452944820249399836ull, + 18204331823439776451ull, 7946843935494350272ull, 905889640498799673ull, + 17961919573170001286ull, 15893687870988700544ull, 1811779280997599347ull, + 17477095072630450957ull, 13340631668267849472ull, 3623558561995198695ull, + 16507446071551350299ull, 8234519262826147328ull, 7247117123990397391ull, + 14568148069393148982ull, 16469038525652294656ull, 14494234247980794783ull, + 10689552065076746349ull, 14491332977595037697ull, 10541724422252037951ull, + 2932360056443941083ull, 10535921881480523779ull, 2636704770794524287ull, + 5864720112887882167ull, 2625099689251495942ull, 5273409541589048574ull, + 11729440225775764334ull, 5250199378502991884ull, 10546819083178097148ull, + 5012136377841977052ull, 10500398757005983769ull, 2646894092646642680ull, + 10024272755683954105ull, 2554053440302415922ull, 5293788185293285360ull, + 1601801437658356594ull, 5108106880604831844ull, 10587576370586570721ull, + 3203602875316713188ull, 10216213761209663689ull, 2728408667463589827ull, + 6407205750633426377ull, 1985683448709775762ull, 5456817334927179655ull, + 12814411501266852754ull, 3971366897419551524ull, 10913634669854359310ull, + 7182078928824153892ull, 7942733794839103049ull, 3380525265999167005ull, + 14364157857648307784ull, 15885467589678206098ull, 6761050531998334011ull, + 10281571641587063953ull, 13324191105646860580ull, 13522101063996668023ull, + 2116399209464576291ull, 8201638137584169545ull, 8597458054283784431ull, + 4232798418929152582ull, 16403276275168339090ull, 17194916108567568862ull, + 8465596837858305165ull, 14359808476627126565ull, 15943088143425586109ull, + 16931193675716610331ull, 10272872879544701515ull, 13439432213141620602ull, + 15415643277723669047ull, 2099001685379851415ull, 8432120352573689589ull, + 12384542481737786478ull, 4198003370759702830ull, 16864240705147379179ull, + 6322340889766021340ull, 8396006741519405661ull, 15281737336585206742ull, + 12644681779532042680ull, 16792013483038811323ull, 12116730599460861868ull, + 6842619485354533745ull, 15137282892368071031ull, 5786717125212172120ull, + 13685238970709067491ull, 11827821711026590446ull, 11573434250424344241ull, + 8923733867708583367ull, 5208899348343629277ull, 4700124427139136867ull, + 17847467735417166734ull, 10417798696687258554ull, 9400248854278273735ull, + 17248191397124781853ull, 2388853319664965493ull, 353753634846995854ull, + 16049638720540012090ull, 4777706639329930986ull, 707507269693991708ull, + 13652533367370472564ull, 9555413278659861972ull, 1415014539387983417ull, + 8858322661031393513ull, 664082483610172328ull, 2830029078775966834ull, + 17716645322062787026ull, 1328164967220344656ull, 5660058157551933669ull, + 16986546570416022436ull, 2656329934440689312ull, 11320116315103867339ull, + 15526349067122493256ull, 5312659868881378625ull, 4193488556498183062ull, + 12605954060535434896ull, 10625319737762757250ull, 8386977112996366124ull, + 6765164047361318177ull, 2803895401815962884ull, 16773954225992732248ull, + 13530328094722636354ull, 5607790803631925769ull, 15101164378275912881ull, + 8613912115735721092ull, 11215581607263851539ull, 11755584682842274146ull, + 17227824231471442185ull, 3984419140818151463ull, 5064425291974996676ull, + 16008904389233332754ull, 7968838281636302926ull, 10128850583949993353ull, + 13571064704757113892ull, 15937676563272605853ull, 1810957094190435090ull, + 8695385335804676169ull, 13428609052835660090ull, 3621914188380870181ull, + 17390770671609352339ull, 8410474031961768564ull, 7243828376761740362ull, + 16334797269509153062ull, 16820948063923537128ull, 14487656753523480724ull, + 14222850465308754509ull, 15195152054137522641ull, 10528569433337409833ull, + 9998956856907957403ull, 11943560034565493667ull, 2610394792965268051ull, + 1551169640106363191ull, 5440375995421435718ull, 5220789585930536102ull, + 3102339280212726382ull, 10880751990842871436ull, 10441579171861072205ull, + 6204678560425452765ull, 3314759907976191257ull, 2436414270012592794ull, + 12409357120850905530ull, 6629519815952382514ull, 4872828540025185588ull, + 6371970167992259444ull, 13259039631904765028ull, 9745657080050371177ull, + 12743940335984518889ull, 8071335190099978441ull, 1044570086391190739ull, + 7041136598259486162ull, 16142670380199956882ull, 2089140172782381479ull, + 14082273196518972325ull, 13838596686690362148ull, 4178280345564762958ull, + 9717802319328393035ull, 9230449299671172680ull, 8356560691129525916ull, + 988860564947234455ull, 14154525632793744ull, 16713121382259051833ull, + 1977721129894468910ull, 28309051265587489ull, 14979498690808552051ull, + 3955442259788937820ull, 56618102531174979ull, 11512253307907552487ull, + 7910884519577875640ull, 113236205062349959ull, 4577762542105553359ull, + 15821769039155751280ull, 226472410124699918ull, 9155525084211106719ull, + 13196794004601950944ull, 452944820249399836ull, 18311050168422213438ull, + 7946843935494350272ull, 905889640498799673ull, 18175356263134875261ull, + 15893687870988700544ull, 1811779280997599347ull, 17903968452560198907ull, + 13340631668267849472ull, 3623558561995198695ull, 17361192831410846199ull, + 8234519262826147328ull, 7247117123990397391ull, 16275641589112140782ull, + 16469038525652294656ull, 14494234247980794783ull, 14104539104514729949ull, + 14491332977595037697ull, 10541724422252037951ull, 9762334135319908282ull, + 10535921881480523779ull, 2636704770794524287ull, 1077924196930264948ull, + 2625099689251495942ull, 5273409541589048574ull, 2155848393860529896ull, + 5250199378502991884ull, 10546819083178097148ull, 4311696787721059793ull, + 10500398757005983769ull, 2646894092646642680ull, 8623393575442119586ull, + 2554053440302415922ull, 5293788185293285360ull, 17246787150884239172ull, + 5108106880604831844ull, 10587576370586570721ull, 16046830228058926728ull, + 10216213761209663689ull, 2728408667463589827ull, 13646916382408301840ull, + 1985683448709775762ull, 5456817334927179655ull, 8847088691107052064ull, + 3971366897419551524ull, 10913634669854359310ull, 17694177382214104129ull, + 7942733794839103049ull, 3380525265999167005ull, 16941610690718656642ull, + 15885467589678206098ull, 6761050531998334011ull, 15436477307727761668ull, + 13324191105646860580ull, 13522101063996668023ull, 12426210541745971720ull, + 8201638137584169545ull, 8597458054283784431ull, 6405677009782391825ull, + 16403276275168339090ull, 17194916108567568862ull, 12811354019564783651ull, + 14359808476627126565ull, 15943088143425586109ull, 7175963965420015686ull, + 10272872879544701515ull, 13439432213141620602ull, 14351927930840031373ull, + 2099001685379851415ull, 8432120352573689589ull, 10257111787970511130ull, + 4198003370759702830ull, 16864240705147379179ull, 2067479502231470645ull, + 8396006741519405661ull, 15281737336585206742ull, 4134959004462941291ull, + 16792013483038811323ull, 12116730599460861868ull, 8269918008925882583ull, + 15137282892368071031ull, 5786717125212172120ull, 16539836017851765167ull, + 11827821711026590446ull, 11573434250424344241ull, 14632927961993978719ull, + 5208899348343629277ull, 4700124427139136867ull, 10819111850278405822ull, + 10417798696687258554ull, 9400248854278273735ull, 3191479626847260029ull, + 2388853319664965493ull, 353753634846995854ull, 6382959253694520058ull, + 4777706639329930986ull, 707507269693991708ull, 12765918507389040117ull, + 9555413278659861972ull, 1415014539387983417ull, 7085092941068528618ull, + 664082483610172328ull, 2830029078775966834ull, 14170185882137057236ull, + 1328164967220344656ull, 5660058157551933669ull, 9893627690564562857ull, + 2656329934440689312ull, 11320116315103867339ull, 1340511307419574098ull, + 5312659868881378625ull, 4193488556498183062ull, 2681022614839148197ull, + 10625319737762757250ull, 8386977112996366124ull, 5362045229678296395ull, + 2803895401815962884ull, 16773954225992732248ull, 10724090459356592791ull, + 5607790803631925769ull, 15101164378275912881ull, 3001436845003633966ull, + 11215581607263851539ull, 11755584682842274146ull, 6002873690007267933ull, + 3984419140818151463ull, 5064425291974996676ull, 12005747380014535866ull, + 7968838281636302926ull, 10128850583949993353ull, 5564750686319520117ull, + 15937676563272605853ull, 1810957094190435090ull, 11129501372639040235ull, + 13428609052835660090ull, 3621914188380870181ull, 3812258671568528855ull, + 8410474031961768564ull, 7243828376761740362ull, 7624517343137057710ull, + 16820948063923537128ull, 14487656753523480724ull, 15249034686274115421ull, + 15195152054137522641ull, 10528569433337409833ull, 12051325298838679227ull, + 11943560034565493667ull, 2610394792965268051ull, 5655906523967806838ull, + 5440375995421435718ull, 5220789585930536102ull, 11311813047935613677ull, + 10880751990842871436ull, 10441579171861072205ull, 4176882022161675738ull, + 3314759907976191257ull, 2436414270012592794ull, 8353764044323351476ull, + 6629519815952382514ull, 4872828540025185588ull, 16707528088646702952ull, + 13259039631904765028ull, 9745657080050371177ull, 14968312103583854289ull, + 8071335190099978441ull, 1044570086391190739ull, 11489880133458156962ull, + 16142670380199956882ull, 2089140172782381479ull, 4533016193206762308ull, + 13838596686690362148ull, 4178280345564762958ull, 9066032386413524617ull, + 9230449299671172680ull, 8356560691129525916ull, 18132064772827049234ull, + 14154525632793744ull, 16713121382259051833ull, 17817385471944546852ull, + 28309051265587489ull, 14979498690808552051ull, 17188026870179542088ull, + 56618102531174979ull, 11512253307907552487ull, 15929309666649532560ull, + 113236205062349959ull, 4577762542105553359ull, 13411875259589513505ull, + 226472410124699918ull, 9155525084211106719ull, 8377006445469475394ull, + 452944820249399836ull, 18311050168422213438ull, 16754012890938950788ull, + 905889640498799673ull, 18175356263134875261ull, 15061281708168349961ull, + 1811779280997599347ull, 17903968452560198907ull, 11675819342627148307ull, + 3623558561995198695ull, 17361192831410846199ull, 4904894611544744999ull, + 7247117123990397391ull, 16275641589112140782ull, 9809789223089489998ull, + 14494234247980794783ull, 14104539104514729949ull, 1172834372469428381ull, + 10541724422252037951ull, 9762334135319908282ull, 2345668744938856762ull, + 2636704770794524287ull, 1077924196930264948ull, 4691337489877713524ull, + 5273409541589048574ull, 2155848393860529896ull, 9382674979755427049ull, + 10546819083178097148ull, 4311696787721059793ull, 318605885801302483ull, + 2646894092646642680ull, 8623393575442119586ull, 637211771602604966ull, + 5293788185293285360ull, 17246787150884239172ull, 1274423543205209932ull, + 10587576370586570721ull, 16046830228058926728ull, 2548847086410419865ull, + 2728408667463589827ull, 13646916382408301840ull, 5097694172820839731ull, + 5456817334927179655ull, 8847088691107052064ull, 10195388345641679463ull, + 10913634669854359310ull, 17694177382214104129ull, 1944032617573807310ull, + 3380525265999167005ull, 16941610690718656642ull, 3888065235147614620ull, + 6761050531998334011ull, 15436477307727761668ull, 7776130470295229240ull, + 13522101063996668023ull, 12426210541745971720ull, 15552260940590458481ull, + 8597458054283784431ull, 6405677009782391825ull, 12657777807471365347ull, + 17194916108567568862ull, 12811354019564783651ull, 6868811541233179079ull, + 15943088143425586109ull, 7175963965420015686ull, 13737623082466358158ull, + 13439432213141620602ull, 14351927930840031373ull, 9028502091223164700ull, + 8432120352573689589ull, 10257111787970511130ull, 18057004182446329400ull, + 16864240705147379179ull, 2067479502231470645ull, 17667264291183107184ull, + 15281737336585206742ull, 4134959004462941291ull, 16887784508656662752ull, + 12116730599460861868ull, 8269918008925882583ull, 15328824943603773888ull, + 5786717125212172120ull, 16539836017851765167ull, 12210905813497996161ull, + 11573434250424344241ull, 14632927961993978719ull, 5975067553286440706ull, + 4700124427139136867ull, 10819111850278405822ull, 11950135106572881412ull, + 9400248854278273735ull, 3191479626847260029ull, 5453526139436211209ull, + 353753634846995854ull, 6382959253694520058ull, 10907052278872422419ull, + 707507269693991708ull, 12765918507389040117ull, 3367360484035293222ull, + 1415014539387983417ull, 7085092941068528618ull, 6734720968070586445ull, + 2830029078775966834ull, 14170185882137057236ull, 13469441936141172890ull, + 5660058157551933669ull, 9893627690564562857ull, 8492139798572794165ull, + 11320116315103867339ull, 1340511307419574098ull, 16984279597145588331ull, + 4193488556498183062ull, 2681022614839148197ull, 15521815120581625046ull, + 8386977112996366124ull, 5362045229678296395ull, 12596886167453698477ull, + 16773954225992732248ull, 10724090459356592791ull, 6747028261197845338ull, + 15101164378275912881ull, 3001436845003633966ull, 13494056522395690676ull, + 11755584682842274146ull, 6002873690007267933ull, 8541368971081829736ull, + 5064425291974996676ull, 12005747380014535866ull, 17082737942163659473ull, + 10128850583949993353ull, 5564750686319520117ull, 15718731810617767330ull, + 1810957094190435090ull, 11129501372639040235ull, 12990719547525983045ull, + 3621914188380870181ull, 3812258671568528855ull, 7534695021342414475ull, + 7243828376761740362ull, 7624517343137057710ull, 15069390042684828951ull, + 14487656753523480724ull, 15249034686274115421ull, 11692036011660106287ull, + 10528569433337409833ull, 12051325298838679227ull, 4937327949610660959ull, + 2610394792965268051ull, 5655906523967806838ull, 9874655899221321918ull, + 5220789585930536102ull, 11311813047935613677ull, 1302567724733092221ull, + 10441579171861072205ull, 4176882022161675738ull, 2605135449466184443ull, + 2436414270012592794ull, 8353764044323351476ull, 5210270898932368887ull, + 4872828540025185588ull, 16707528088646702952ull, 10420541797864737775ull, + 9745657080050371177ull, 14968312103583854289ull, 2394339522019923935ull, + 1044570086391190739ull, 11489880133458156962ull, 4788679044039847871ull, + 2089140172782381479ull, 4533016193206762308ull, 9577358088079695742ull, + 4178280345564762958ull, 9066032386413524617ull, 707972102449839868ull, + 8356560691129525916ull, 18132064772827049234ull, 1415944204899679737ull, + 16713121382259051833ull, 17817385471944546852ull, 2831888409799359474ull, + 14979498690808552051ull, 17188026870179542088ull, 5663776819598718948ull, + 11512253307907552487ull, 15929309666649532560ull, 11327553639197437896ull, + 4577762542105553359ull, 13411875259589513505ull, 4208363204685324176ull, + 9155525084211106719ull, 8377006445469475394ull, 8416726409370648352ull, + 18311050168422213438ull, 16754012890938950788ull, 16833452818741296705ull, + 18175356263134875261ull, 15061281708168349961ull, 15220161563773041794ull, + 17903968452560198907ull, 11675819342627148307ull, 11993579053836531972ull, + 17361192831410846199ull, 4904894611544744999ull, 5540414033963512329ull, + 16275641589112140782ull, 9809789223089489998ull, 11080828067927024659ull, + 14104539104514729949ull, 1172834372469428381ull, 3714912062144497703ull, + 9762334135319908282ull, 2345668744938856762ull, 7429824124288995406ull, + 1077924196930264948ull, 4691337489877713524ull, 14859648248577990812ull, + 2155848393860529896ull, 9382674979755427049ull, 11272552423446430009ull, + 4311696787721059793ull, 318605885801302483ull, 4098360773183308403ull, + 8623393575442119586ull, 637211771602604966ull, 8196721546366616806ull, + 17246787150884239172ull, 1274423543205209932ull, 16393443092733233612ull, + 16046830228058926728ull, 2548847086410419865ull, 14340142111756915609ull, + 13646916382408301840ull, 5097694172820839731ull, 10233540149804279602ull, + 8847088691107052064ull, 10195388345641679463ull, 2020336225899007588ull, + 17694177382214104129ull, 1944032617573807310ull, 4040672451798015176ull, + 16941610690718656642ull, 3888065235147614620ull, 8081344903596030353ull, + 15436477307727761668ull, 7776130470295229240ull, 16162689807192060707ull, + 12426210541745971720ull, 15552260940590458481ull, 13878635540674569799ull, + 6405677009782391825ull, 12657777807471365347ull, 9310527007639587982ull, + 12811354019564783651ull, 6868811541233179079ull, 174309941569624349ull, + 7175963965420015686ull, 13737623082466358158ull, 348619883139248698ull, + 14351927930840031373ull, 9028502091223164700ull, 697239766278497397ull, + 10257111787970511130ull, 18057004182446329400ull, 1394479532556994795ull, + 2067479502231470645ull, 17667264291183107184ull, 2788959065113989590ull, + 4134959004462941291ull, 16887784508656662752ull, 5577918130227979180ull, + 8269918008925882583ull, 15328824943603773888ull, 11155836260455958360ull, + 16539836017851765167ull, 12210905813497996161ull, 3864928447202365105ull, + 14632927961993978719ull, 5975067553286440706ull, 7729856894404730211ull, + 10819111850278405822ull, 11950135106572881412ull, 15459713788809460423ull, + 3191479626847260029ull, 5453526139436211209ull, 12472683503909369230ull, + 6382959253694520058ull, 10907052278872422419ull, 6498622934109186844ull, + 12765918507389040117ull, 3367360484035293222ull, 12997245868218373689ull, + 7085092941068528618ull, 6734720968070586445ull, 7547747662727195763ull, + 14170185882137057236ull, 13469441936141172890ull, 15095495325454391526ull, + 9893627690564562857ull, 8492139798572794165ull, 11744246577199231436ull, + 1340511307419574098ull, 16984279597145588331ull, 5041749080688911256ull, + 2681022614839148197ull, 15521815120581625046ull, 10083498161377822512ull, + 5362045229678296395ull, 12596886167453698477ull, 1720252249046093408ull, + 10724090459356592791ull, 6747028261197845338ull, 3440504498092186817ull, + 3001436845003633966ull, 13494056522395690676ull, 6881008996184373635ull, + 6002873690007267933ull, 8541368971081829736ull, 13762017992368747270ull, + 12005747380014535866ull, 17082737942163659473ull, 9077291911027942925ull, + 5564750686319520117ull, 15718731810617767330ull, 18154583822055885850ull, + 11129501372639040235ull, 12990719547525983045ull, 17862423570402220085ull, + 3812258671568528855ull, 7534695021342414475ull, 17278103067094888554ull, + 7624517343137057710ull, 15069390042684828951ull, 16109462060480225492ull, + 15249034686274115421ull, 11692036011660106287ull, 13772180047250899369ull, + 12051325298838679227ull, 4937327949610660959ull, 9097616020792247123ull, + 5655906523967806838ull, 9874655899221321918ull, 18195232041584494246ull, + 11311813047935613677ull, 1302567724733092221ull, 17943720009459436876ull, + 4176882022161675738ull, 2605135449466184443ull, 17440695945209322137ull, + 8353764044323351476ull, 5210270898932368887ull, 16434647816709092659ull, + 16707528088646702952ull, 10420541797864737775ull, 14422551559708633703ull, + 14968312103583854289ull, 2394339522019923935ull, 10398359045707715790ull, + 11489880133458156962ull, 4788679044039847871ull, 2349974017705879964ull, + 4533016193206762308ull, 9577358088079695742ull, 4699948035411759929ull, + 9066032386413524617ull, 707972102449839868ull, 9399896070823519859ull, + 18132064772827049234ull, 1415944204899679737ull, 353048067937488103ull, + 17817385471944546852ull, 2831888409799359474ull, 706096135874976207ull, + 17188026870179542088ull, 5663776819598718948ull, 1412192271749952415ull, + 15929309666649532560ull, 11327553639197437896ull, 2824384543499904830ull, + 13411875259589513505ull, 4208363204685324176ull, 5648769086999809661ull, + 8377006445469475394ull, 8416726409370648352ull, 11297538173999619322ull, + 16754012890938950788ull, 16833452818741296705ull, 4148332274289687028ull, + 15061281708168349961ull, 15220161563773041794ull, 8296664548579374057ull, + 11675819342627148307ull, 11993579053836531972ull, 16593329097158748114ull, + 4904894611544744999ull, 5540414033963512329ull, 14739914120607944612ull, + 9809789223089489998ull, 11080828067927024659ull, 11033084167506337609ull, + 1172834372469428381ull, 3714912062144497703ull, 3619424261303123603ull, + 2345668744938856762ull, 7429824124288995406ull, 7238848522606247207ull, + 4691337489877713524ull, 14859648248577990812ull, 14477697045212494414ull, + 9382674979755427049ull, 11272552423446430009ull, 10508650016715437212ull, + 318605885801302483ull, 4098360773183308403ull, 2570555959721322809ull, + 637211771602604966ull, 8196721546366616806ull, 5141111919442645618ull, + 1274423543205209932ull, 16393443092733233612ull, 10282223838885291236ull, + 2548847086410419865ull, 14340142111756915609ull, 2117703604061030856ull, + 5097694172820839731ull, 10233540149804279602ull, 4235407208122061712ull, + 10195388345641679463ull, 2020336225899007588ull, 8470814416244123425ull, + 1944032617573807310ull, 4040672451798015176ull, 16941628832488246850ull, + 3888065235147614620ull, 8081344903596030353ull, 15436513591266942084ull, + 7776130470295229240ull, 16162689807192060707ull, 12426283108824332552ull, + 15552260940590458481ull, 13878635540674569799ull, 6405822143939113489ull, + 12657777807471365347ull, 9310527007639587982ull, 12811644287878226978ull, + 6868811541233179079ull, 174309941569624349ull, 7176544502046902341ull, + 13737623082466358158ull, 348619883139248698ull, 14353089004093804683ull, + 9028502091223164700ull, 697239766278497397ull, 10259433934478057751ull, + 18057004182446329400ull, 1394479532556994795ull, 2072123795246563887ull, + 17667264291183107184ull, 2788959065113989590ull, 4144247590493127775ull, + 16887784508656662752ull, 5577918130227979180ull, 8288495180986255551ull, + 15328824943603773888ull, 11155836260455958360ull, 16576990361972511102ull, + 12210905813497996161ull, 3864928447202365105ull, 14707236650235470588ull, + 5975067553286440706ull, 7729856894404730211ull, 10967729226761389560ull, + 11950135106572881412ull, 15459713788809460423ull, 3488714379813227505ull, + 5453526139436211209ull, 12472683503909369230ull, 6977428759626455010ull, + 10907052278872422419ull, 6498622934109186844ull, 13954857519252910021ull, + 3367360484035293222ull, 12997245868218373689ull, 9462970964796268427ull, + 6734720968070586445ull, 7547747662727195763ull, 479197855882985239ull, + 13469441936141172890ull, 15095495325454391526ull, 958395711765970478ull, + 8492139798572794165ull, 11744246577199231436ull, 1916791423531940957ull, + 16984279597145588331ull, 5041749080688911256ull, 3833582847063881915ull, + 15521815120581625046ull, 10083498161377822512ull, 7667165694127763831ull, + 12596886167453698477ull, 1720252249046093408ull, 15334331388255527663ull, + 6747028261197845338ull, 3440504498092186817ull, 12221918702801503710ull, + 13494056522395690676ull, 6881008996184373635ull, 5997093331893455805ull, + 8541368971081829736ull, 13762017992368747270ull, 11994186663786911611ull, + 17082737942163659473ull, 9077291911027942925ull, 5541629253864271607ull, + 15718731810617767330ull, 18154583822055885850ull, 11083258507728543215ull, + 12990719547525983045ull, 17862423570402220085ull, 3719772941747534815ull, + 7534695021342414475ull, 17278103067094888554ull, 7439545883495069631ull, + 15069390042684828951ull, 16109462060480225492ull, 14879091766990139262ull, + 11692036011660106287ull, 13772180047250899369ull, 11311439460270726908ull, + 4937327949610660959ull, 9097616020792247123ull, 4176134846831902201ull, + 9874655899221321918ull, 18195232041584494246ull, 8352269693663804402ull, + 1302567724733092221ull, 17943720009459436876ull, 16704539387327608804ull, + 2605135449466184443ull, 17440695945209322137ull, 14962334700945665993ull, + 5210270898932368887ull, 16434647816709092659ull, 11477925328181780370ull, + 10420541797864737775ull, 14422551559708633703ull, 4509106582654009125ull, + 2394339522019923935ull, 10398359045707715790ull, 9018213165308018250ull, + 4788679044039847871ull, 2349974017705879964ull, 18036426330616036500ull, + 9577358088079695742ull, 4699948035411759929ull, 17626108587522521384ull, + 707972102449839868ull, 9399896070823519859ull, 16805473101335491152ull, + 1415944204899679737ull, 353048067937488103ull, 15164202128961430688ull, + 2831888409799359474ull, 706096135874976207ull, 11881660184213309761ull, + 5663776819598718948ull, 1412192271749952415ull, 5316576294717067907ull, + 11327553639197437896ull, 2824384543499904830ull, 10633152589434135815ull, + 4208363204685324176ull, 5648769086999809661ull, 2819561105158720014ull, + 8416726409370648352ull, 11297538173999619322ull, 5639122210317440029ull, + 16833452818741296705ull, 4148332274289687028ull, 11278244420634880059ull, + 15220161563773041794ull, 8296664548579374057ull, 4109744767560208502ull, + 11993579053836531972ull, 16593329097158748114ull, 8219489535120417004ull, + 5540414033963512329ull, 14739914120607944612ull, 16438979070240834008ull, + 11080828067927024659ull, 11033084167506337609ull, 14431214066772116401ull, + 3714912062144497703ull, 3619424261303123603ull, 10415684059834681187ull, + 7429824124288995406ull, 7238848522606247207ull, 2384624045959810759ull, + 14859648248577990812ull, 14477697045212494414ull, 4769248091919621519ull, + 11272552423446430009ull, 10508650016715437212ull, 9538496183839243039ull, + 4098360773183308403ull, 2570555959721322809ull, 630248293968934463ull, + 8196721546366616806ull, 5141111919442645618ull, 1260496587937868927ull, + 16393443092733233612ull, 10282223838885291236ull, 2520993175875737855ull, + 14340142111756915609ull, 2117703604061030856ull, 5041986351751475711ull, + 10233540149804279602ull, 4235407208122061712ull, 10083972703502951423ull, + 2020336225899007588ull, 8470814416244123425ull, 1721201333296351230ull, + 4040672451798015176ull, 16941628832488246850ull, 3442402666592702460ull, + 8081344903596030353ull, 15436513591266942084ull, 6884805333185404920ull, + 16162689807192060707ull, 12426283108824332552ull, 13769610666370809841ull, + 13878635540674569799ull, 6405822143939113489ull, 9092477259032068066ull, + 9310527007639587982ull, 12811644287878226978ull, 18184954518064136132ull, + 174309941569624349ull, 7176544502046902341ull, 17923164962418720649ull, + 348619883139248698ull, 14353089004093804683ull, 17399585851127889682ull, + 697239766278497397ull, 10259433934478057751ull, 16352427628546227749ull, + 1394479532556994795ull, 2072123795246563887ull, 14258111183382903883ull, + 2788959065113989590ull, 4144247590493127775ull, 10069478293056256151ull, + 5577918130227979180ull, 8288495180986255551ull, 1692212512402960687ull, + 11155836260455958360ull, 16576990361972511102ull, 3384425024805921375ull, + 3864928447202365105ull, 14707236650235470588ull, 6768850049611842751ull, + 7729856894404730211ull, 10967729226761389560ull, 13537700099223685503ull, + 15459713788809460423ull, 3488714379813227505ull, 8628656124737819391ull, + 12472683503909369230ull, 6977428759626455010ull, 17257312249475638783ull, + 6498622934109186844ull, 13954857519252910021ull, 16067880425241725951ull, + 12997245868218373689ull, 9462970964796268427ull, 13689016776773900287ull, + 7547747662727195763ull, 479197855882985239ull, 8931289479838248959ull, + 15095495325454391526ull, 958395711765970478ull, 17862578959676497919ull, + 11744246577199231436ull, 1916791423531940957ull, 17278413845643444222ull, + 5041749080688911256ull, 3833582847063881915ull, 16110083617577336829ull, + 10083498161377822512ull, 7667165694127763831ull, 13773423161445122043ull, + 1720252249046093408ull, 15334331388255527663ull, 9100102249180692471ull, + 3440504498092186817ull, 12221918702801503710ull, 18200204498361384943ull, + 6881008996184373635ull, 5997093331893455805ull, 17953664923013218270ull, + 13762017992368747270ull, 11994186663786911611ull, 17460585772316884924ull, + 9077291911027942925ull, 5541629253864271607ull, 16474427470924218232ull, + 18154583822055885850ull, 11083258507728543215ull, 14502110868138884848ull, + 17862423570402220085ull, 3719772941747534815ull, 10557477662568218080ull, + 17278103067094888554ull, 7439545883495069631ull, 2668211251426884544ull, + 16109462060480225492ull, 14879091766990139262ull, 5336422502853769089ull, + 13772180047250899369ull, 11311439460270726908ull, 10672845005707538178ull, + 9097616020792247123ull, 4176134846831902201ull, 2898945937705524741ull, + 18195232041584494246ull, 8352269693663804402ull, 5797891875411049483ull, + 17943720009459436876ull, 16704539387327608804ull, 11595783750822098966ull, + 17440695945209322137ull, 14962334700945665993ull, 4744823427934646316ull, + 16434647816709092659ull, 11477925328181780370ull, 9489646855869292633ull, + 14422551559708633703ull, 4509106582654009125ull, 532549638029033651ull, + 10398359045707715790ull, 9018213165308018250ull, 1065099276058067302ull, + 2349974017705879964ull, 18036426330616036500ull, 2130198552116134604ull, + 4699948035411759929ull, 17626108587522521384ull, 4260397104232269208ull, + 9399896070823519859ull, 16805473101335491152ull, 8520794208464538416ull, + 353048067937488103ull, 15164202128961430688ull, 17041588416929076832ull, + 706096135874976207ull, 11881660184213309761ull, 15636432760148602048ull, + 1412192271749952415ull, 5316576294717067907ull, 12826121446587652480ull, + 2824384543499904830ull, 10633152589434135815ull, 7205498819465753345ull, + 5648769086999809661ull, 2819561105158720014ull, 14410997638931506691ull, + 11297538173999619322ull, 5639122210317440029ull, 10375251204153461767ull, + 4148332274289687028ull, 11278244420634880059ull, 2303758334597371919ull, + 8296664548579374057ull, 4109744767560208502ull, 4607516669194743839ull, + 16593329097158748114ull, 8219489535120417004ull, 9215033338389487679ull, + 14739914120607944612ull, 16438979070240834008ull, 18430066676778975359ull, + 11033084167506337609ull, 14431214066772116401ull, 18413389279848399102ull, + 3619424261303123603ull, 10415684059834681187ull, 18380034485987246589ull, + 7238848522606247207ull, 2384624045959810759ull, 18313324898264941563ull, + 14477697045212494414ull, 4769248091919621519ull, 18179905722820331511ull, + 10508650016715437212ull, 9538496183839243039ull, 17913067371931111407ull, + 2570555959721322809ull, 630248293968934463ull, 17379390670152671198ull, + 5141111919442645618ull, 1260496587937868927ull, 16312037266595790780ull, + 10282223838885291236ull, 2520993175875737855ull, 14177330459482029945ull, + 2117703604061030856ull, 5041986351751475711ull, 9907916845254508274ull, + 4235407208122061712ull, 10083972703502951423ull, 1369089616799464933ull, + 8470814416244123425ull, 1721201333296351230ull, 2738179233598929867ull, + 16941628832488246850ull, 3442402666592702460ull, 5476358467197859735ull, + 15436513591266942084ull, 6884805333185404920ull, 10952716934395719471ull, + 12426283108824332552ull, 13769610666370809841ull, 3458689795081887326ull, + 6405822143939113489ull, 9092477259032068066ull, 6917379590163774652ull, + 12811644287878226978ull, 18184954518064136132ull, 13834759180327549304ull, + 7176544502046902341ull, 17923164962418720649ull, 9222774286945546993ull, + 14353089004093804683ull, 17399585851127889682ull, 18445548573891093986ull, + 10259433934478057751ull, 16352427628546227749ull, 18444353074072636356ull, + 2072123795246563887ull, 14258111183382903883ull, 18441962074435721096ull, + 4144247590493127775ull, 10069478293056256151ull, 18437180075161890577ull, + 8288495180986255551ull, 1692212512402960687ull, 18427616076614229539ull, + 16576990361972511102ull, 3384425024805921375ull, 18408488079518907462ull, + 14707236650235470588ull, 6768850049611842751ull, 18370232085328263308ull, + 10967729226761389560ull, 13537700099223685503ull, 18293720096946975000ull, + 3488714379813227505ull, 8628656124737819391ull, 18140696120184398385ull, + 6977428759626455010ull, 17257312249475638783ull, 17834648166659245154ull, + 13954857519252910021ull, 16067880425241725951ull, 17222552259608938693ull, + 9462970964796268427ull, 13689016776773900287ull, 15998360445508325771ull, + 479197855882985239ull, 8931289479838248959ull, 13549976817307099926ull, + 958395711765970478ull, 17862578959676497919ull, 8653209560904648237ull, + 1916791423531940957ull, 17278413845643444222ull, 17306419121809296474ull, + 3833582847063881915ull, 16110083617577336829ull, 16166094169909041333ull, + 7667165694127763831ull, 13773423161445122043ull, 13885444266108531051ull, + 15334331388255527663ull, 9100102249180692471ull, 9324144458507510486ull, + 12221918702801503710ull, 18200204498361384943ull, 201544843305469357ull, + 5997093331893455805ull, 17953664923013218270ull, 403089686610938714ull, + 11994186663786911611ull, 17460585772316884924ull, 806179373221877428ull, + 5541629253864271607ull, 16474427470924218232ull, 1612358746443754856ull, + 11083258507728543215ull, 14502110868138884848ull, 3224717492887509712ull, + 3719772941747534815ull, 10557477662568218080ull, 6449434985775019424ull, + 7439545883495069631ull, 2668211251426884544ull, 12898869971550038849ull, + 14879091766990139262ull, 5336422502853769089ull, 7350995869390526082ull, + 11311439460270726908ull, 10672845005707538178ull, 14701991738781052165ull, + 4176134846831902201ull, 2898945937705524741ull, 10957239403852552714ull, + 8352269693663804402ull, 5797891875411049483ull, 3467734733995553812ull, + 16704539387327608804ull, 11595783750822098966ull, 6935469467991107625ull, + 14962334700945665993ull, 4744823427934646316ull, 13870938935982215251ull, + 11477925328181780370ull, 9489646855869292633ull, 9295133798254878886ull, + 4509106582654009125ull, 532549638029033651ull, 143523522800206157ull, + 9018213165308018250ull, 1065099276058067302ull, 287047045600412315ull, + 18036426330616036500ull, 2130198552116134604ull, 574094091200824630ull, + 17626108587522521384ull, 4260397104232269208ull, 1148188182401649261ull, + 16805473101335491152ull, 8520794208464538416ull, 2296376364803298522ull, + 15164202128961430688ull, 17041588416929076832ull, 4592752729606597044ull, + 11881660184213309761ull, 15636432760148602048ull, 9185505459213194088ull, + 5316576294717067907ull, 12826121446587652480ull, 18371010918426388177ull, + 10633152589434135815ull, 7205498819465753345ull, 18295277763143224739ull, + 2819561105158720014ull, 14410997638931506691ull, 18143811452576897863ull, + 5639122210317440029ull, 10375251204153461767ull, 17840878831444244111ull, + 11278244420634880059ull, 2303758334597371919ull, 17235013589178936607ull, + 4109744767560208502ull, 4607516669194743839ull, 16023283104648321598ull, + 8219489535120417004ull, 9215033338389487679ull, 13599822135587091581ull, + 16438979070240834008ull, 18430066676778975359ull, 8752900197464631547ull, + 14431214066772116401ull, 18413389279848399102ull, 17505800394929263094ull, + 10415684059834681187ull, 18380034485987246589ull, 16564856716148974573ull, + 2384624045959810759ull, 18313324898264941563ull, 14682969358588397531ull, + 4769248091919621519ull, 18179905722820331511ull, 10919194643467243446ull, + 9538496183839243039ull, 17913067371931111407ull, 3391645213224935277ull, + 630248293968934463ull, 17379390670152671198ull, 6783290426449870554ull, + 1260496587937868927ull, 16312037266595790780ull, 13566580852899741108ull, + 2520993175875737855ull, 14177330459482029945ull, 8686417632089930601ull, + 5041986351751475711ull, 9907916845254508274ull, 17372835264179861203ull, + 10083972703502951423ull, 1369089616799464933ull, 16298926454650170790ull, + 1721201333296351230ull, 2738179233598929867ull, 14151108835590789965ull, + 3442402666592702460ull, 5476358467197859735ull, 9855473597472028315ull, + 6884805333185404920ull, 10952716934395719471ull, 1264203121234505014ull, + 13769610666370809841ull, 3458689795081887326ull, 2528406242469010028ull, + 9092477259032068066ull, 6917379590163774652ull, 5056812484938020057ull, + 18184954518064136132ull, 13834759180327549304ull, 10113624969876040115ull, + 17923164962418720649ull, 9222774286945546993ull, 1780505866042528615ull, + 17399585851127889682ull, 18445548573891093986ull, 3561011732085057231ull, + 16352427628546227749ull, 18444353074072636356ull, 7122023464170114463ull, + 14258111183382903883ull, 18441962074435721096ull, 14244046928340228927ull, + 10069478293056256151ull, 18437180075161890577ull, 10041349782970906238ull, + 1692212512402960687ull, 18427616076614229539ull, 1635955492232260861ull, + 3384425024805921375ull, 18408488079518907462ull, 3271910984464521723ull, + 6768850049611842751ull, 18370232085328263308ull, 6543821968929043446ull, + 13537700099223685503ull, 18293720096946975000ull, 13087643937858086892ull, + 8628656124737819391ull, 18140696120184398385ull, 7728543802006622169ull, + 17257312249475638783ull, 17834648166659245154ull, 15457087604013244339ull, + 16067880425241725951ull, 17222552259608938693ull, 12467431134316937063ull, + 13689016776773900287ull, 15998360445508325771ull, 6488118194924322511ull, + 8931289479838248959ull, 13549976817307099926ull, 12976236389848645022ull, + 17862578959676497919ull, 8653209560904648237ull, 7505728705987738428ull, + 17278413845643444222ull, 17306419121809296474ull, 15011457411975476857ull, + 16110083617577336829ull, 16166094169909041333ull, 11576170750241402098ull, + 13773423161445122043ull, 13885444266108531051ull, 4705597426773252580ull, + 9100102249180692471ull, 9324144458507510486ull, 9411194853546505161ull, + 18200204498361384943ull, 201544843305469357ull, 375645633383458707ull, + 17953664923013218270ull, 403089686610938714ull, 751291266766917415ull, + 17460585772316884924ull, 806179373221877428ull, 1502582533533834831ull, + 16474427470924218232ull, 1612358746443754856ull, 3005165067067669663ull, + 14502110868138884848ull, 3224717492887509712ull, 6010330134135339326ull, + 10557477662568218080ull, 6449434985775019424ull, 12020660268270678652ull, + 2668211251426884544ull, 12898869971550038849ull, 5594576462831805689ull, + 5336422502853769089ull, 7350995869390526082ull, 11189152925663611378ull, + 10672845005707538178ull, 14701991738781052165ull, 3931561777617671141ull, + 2898945937705524741ull, 10957239403852552714ull, 7863123555235342283ull, + 5797891875411049483ull, 3467734733995553812ull, 15726247110470684566ull, + 11595783750822098966ull, 6935469467991107625ull, 13005750147231817516ull, + 4744823427934646316ull, 13870938935982215251ull, 7564756220754083416ull, + 9489646855869292633ull, 9295133798254878886ull, 15129512441508166832ull, + 532549638029033651ull, 143523522800206157ull, 11812280809306782049ull, + 1065099276058067302ull, 287047045600412315ull, 5177817544904012482ull, + 2130198552116134604ull, 574094091200824630ull, 10355635089808024964ull, + 4260397104232269208ull, 1148188182401649261ull, 2264526105906498313ull, + 8520794208464538416ull, 2296376364803298522ull, 4529052211812996627ull, + 17041588416929076832ull, 4592752729606597044ull, 9058104423625993254ull, + 15636432760148602048ull, 9185505459213194088ull, 18116208847251986509ull, + 12826121446587652480ull, 18371010918426388177ull, 17785673620794421403ull, + 7205498819465753345ull, 18295277763143224739ull, 17124603167879291190ull, + 14410997638931506691ull, 18143811452576897863ull, 15802462262049030765ull, + 10375251204153461767ull, 17840878831444244111ull, 13158180450388509915ull, + 2303758334597371919ull, 17235013589178936607ull, 7869616827067468215ull, + 4607516669194743839ull, 16023283104648321598ull, 15739233654134936430ull, + 9215033338389487679ull, 13599822135587091581ull, 13031723234560321245ull, + 18430066676778975359ull, 8752900197464631547ull, 7616702395411090874ull, + 18413389279848399102ull, 17505800394929263094ull, 15233404790822181748ull, + 18380034485987246589ull, 16564856716148974573ull, 12020065507934811881ull, + 18313324898264941563ull, 14682969358588397531ull, 5593386942160072147ull, + 18179905722820331511ull, 10919194643467243446ull, 11186773884320144295ull, + 17913067371931111407ull, 3391645213224935277ull, 3926803694930736975ull, + 17379390670152671198ull, 6783290426449870554ull, 7853607389861473950ull, + 16312037266595790780ull, 13566580852899741108ull, 15707214779722947901ull, + 14177330459482029945ull, 8686417632089930601ull, 12967685485736344186ull, + 9907916845254508274ull, 17372835264179861203ull, 7488626897763136756ull, + 1369089616799464933ull, 16298926454650170790ull, 14977253795526273512ull, + 2738179233598929867ull, 14151108835590789965ull, 11507763517342995409ull, + 5476358467197859735ull, 9855473597472028315ull, 4568782960976439203ull, + 10952716934395719471ull, 1264203121234505014ull, 9137565921952878406ull, + 3458689795081887326ull, 2528406242469010028ull, 18275131843905756812ull, + 6917379590163774652ull, 5056812484938020057ull, 18103519614101962008ull, + 13834759180327549304ull, 10113624969876040115ull, 17760295154494372401ull, + 9222774286945546993ull, 1780505866042528615ull, 17073846235279193187ull, + 18445548573891093986ull, 3561011732085057231ull, 15700948396848834759ull, + 18444353074072636356ull, 7122023464170114463ull, 12955152719988117903ull, + 18441962074435721096ull, 14244046928340228927ull, 7463561366266684191ull, + 18437180075161890577ull, 10041349782970906238ull, 14927122732533368383ull, + 18427616076614229539ull, 1635955492232260861ull, 11407501391357185150ull, + 18408488079518907462ull, 3271910984464521723ull, 4368258709004818685ull, + 18370232085328263308ull, 6543821968929043446ull, 8736517418009637371ull, + 18293720096946975000ull, 13087643937858086892ull, 17473034836019274742ull, + 18140696120184398385ull, 7728543802006622169ull, 16499325598328997868ull, + 17834648166659245154ull, 15457087604013244339ull, 14551907122948444121ull, + 17222552259608938693ull, 12467431134316937063ull, 10657070172187336627ull, + 15998360445508325771ull, 6488118194924322511ull, 2867396270665121638ull, + 13549976817307099926ull, 12976236389848645022ull, 5734792541330243277ull, + 8653209560904648237ull, 7505728705987738428ull, 11469585082660486554ull, + 17306419121809296474ull, 15011457411975476857ull, 4492426091611421492ull, + 16166094169909041333ull, 11576170750241402098ull, 8984852183222842985ull, + 13885444266108531051ull, 4705597426773252580ull, 17969704366445685971ull, + 9324144458507510486ull, 9411194853546505161ull, 17492664659181820327ull, + 201544843305469357ull, 375645633383458707ull, 16538585244654089039ull, + 403089686610938714ull, 751291266766917415ull, 14630426415598626462ull, + 806179373221877428ull, 1502582533533834831ull, 10814108757487701308ull, + 1612358746443754856ull, 3005165067067669663ull, 3181473441265851001ull, + 3224717492887509712ull, 6010330134135339326ull, 6362946882531702002ull, + 6449434985775019424ull, 12020660268270678652ull, 12725893765063404005ull, + 12898869971550038849ull, 5594576462831805689ull, 7005043456417256395ull, + 7350995869390526082ull, 11189152925663611378ull, 14010086912834512791ull, + 14701991738781052165ull, 3931561777617671141ull, 9573429751959473967ull, + 10957239403852552714ull, 7863123555235342283ull, 700115430209396319ull, + 3467734733995553812ull, 15726247110470684566ull, 1400230860418792639ull, + 6935469467991107625ull, 13005750147231817516ull, 2800461720837585279ull, + 13870938935982215251ull, 7564756220754083416ull, 5600923441675170559ull, + 9295133798254878886ull, 15129512441508166832ull, 11201846883350341118ull, + 143523522800206157ull, 11812280809306782049ull, 3956949692991130621ull, + 287047045600412315ull, 5177817544904012482ull, 7913899385982261242ull, + 574094091200824630ull, 10355635089808024964ull, 15827798771964522485ull, + 1148188182401649261ull, 2264526105906498313ull, 13208853470219493354ull, + 2296376364803298522ull, 4529052211812996627ull, 7970962866729435092ull, + 4592752729606597044ull, 9058104423625993254ull, 15941925733458870184ull, + 9185505459213194088ull, 18116208847251986509ull, 13437107393208188753ull, + 18371010918426388177ull, 17785673620794421403ull, 8427470712706825890ull, + 18295277763143224739ull, 17124603167879291190ull, 16854941425413651781ull, + 18143811452576897863ull, 15802462262049030765ull, 15263138777117751947ull, + 17840878831444244111ull, 13158180450388509915ull, 12079533480525952278ull, + 17235013589178936607ull, 7869616827067468215ull, 5712322887342352941ull, + 16023283104648321598ull, 15739233654134936430ull, 11424645774684705882ull, + 13599822135587091581ull, 13031723234560321245ull, 4402547475659860149ull, + 8752900197464631547ull, 7616702395411090874ull, 8805094951319720299ull, + 17505800394929263094ull, 15233404790822181748ull, 17610189902639440599ull, + 16564856716148974573ull, 12020065507934811881ull, 16773635731569329582ull, + 14682969358588397531ull, 5593386942160072147ull, 15100527389429107549ull, + 10919194643467243446ull, 11186773884320144295ull, 11754310705148663482ull, + 3391645213224935277ull, 3926803694930736975ull, 5061877336587775349ull, + 6783290426449870554ull, 7853607389861473950ull, 10123754673175550698ull, + 13566580852899741108ull, 15707214779722947901ull, 1800765272641549780ull, + 8686417632089930601ull, 12967685485736344186ull, 3601530545283099561ull, + 17372835264179861203ull, 7488626897763136756ull, 7203061090566199122ull, + 16298926454650170790ull, 14977253795526273512ull, 14406122181132398244ull, + 14151108835590789965ull, 11507763517342995409ull, 10365500288555244873ull, + 9855473597472028315ull, 4568782960976439203ull, 2284256503400938131ull, + 1264203121234505014ull, 9137565921952878406ull, 4568513006801876263ull, + 2528406242469010028ull, 18275131843905756812ull, 9137026013603752527ull, + 5056812484938020057ull, 18103519614101962008ull, 18274052027207505054ull, + 10113624969876040115ull, 17760295154494372401ull, 18101359980705458493ull, + 1780505866042528615ull, 17073846235279193187ull, 17755975887701365371ull, + 3561011732085057231ull, 15700948396848834759ull, 17065207701693179127ull, + 7122023464170114463ull, 12955152719988117903ull, 15683671329676806638ull, + 14244046928340228927ull, 7463561366266684191ull, 12920598585644061661ull, + 10041349782970906238ull, 14927122732533368383ull, 7394453097578571706ull, + 1635955492232260861ull, 11407501391357185150ull, 14788906195157143413ull, + 3271910984464521723ull, 4368258709004818685ull, 11131068316604735211ull, + 6543821968929043446ull, 8736517418009637371ull, 3815392559499918806ull, + 13087643937858086892ull, 17473034836019274742ull, 7630785118999837612ull, + 7728543802006622169ull, 16499325598328997868ull, 15261570237999675224ull, + 15457087604013244339ull, 14551907122948444121ull, 12076396402289798833ull, + 12467431134316937063ull, 10657070172187336627ull, 5706048730870046051ull, + 6488118194924322511ull, 2867396270665121638ull, 11412097461740092103ull, + 12976236389848645022ull, 5734792541330243277ull, 4377450849770632591ull, + 7505728705987738428ull, 11469585082660486554ull, 8754901699541265183ull, + 15011457411975476857ull, 4492426091611421492ull, 17509803399082530367ull, + 11576170750241402098ull, 8984852183222842985ull, 16572862724455509118ull, + 4705597426773252580ull, 17969704366445685971ull, 14698981375201466621ull, + 9411194853546505161ull, 17492664659181820327ull, 10951218676693381626ull, + 375645633383458707ull, 16538585244654089039ull, 3455693279677211637ull, + 751291266766917415ull, 14630426415598626462ull, 6911386559354423275ull, + 1502582533533834831ull, 10814108757487701308ull, 13822773118708846551ull, + 3005165067067669663ull, 3181473441265851001ull, 9198802163708141487ull, + 6010330134135339326ull, 6362946882531702002ull, 18397604327416282975ull, + 12020660268270678652ull, 12725893765063404005ull, 18348464581123014334ull, + 5594576462831805689ull, 7005043456417256395ull, 18250185088536477052ull, + 11189152925663611378ull, 14010086912834512791ull, 18053626103363402489ull, + 3931561777617671141ull, 9573429751959473967ull, 17660508133017253362ull, + 7863123555235342283ull, 700115430209396319ull, 16874272192324955109ull, + 15726247110470684566ull, 1400230860418792639ull, 15301800310940358603ull, + 13005750147231817516ull, 2800461720837585279ull, 12156856548171165591ull, + 7564756220754083416ull, 5600923441675170559ull, 5866969022632779567ull, + 15129512441508166832ull, 11201846883350341118ull, 11733938045265559135ull, + 11812280809306782049ull, 3956949692991130621ull, 5021132016821566654ull, + 5177817544904012482ull, 7913899385982261242ull, 10042264033643133308ull, + 10355635089808024964ull, 15827798771964522485ull, 1637783993576715000ull, + 2264526105906498313ull, 13208853470219493354ull, 3275567987153430001ull, + 4529052211812996627ull, 7970962866729435092ull, 6551135974306860002ull, + 9058104423625993254ull, 15941925733458870184ull, 13102271948613720005ull, + 18116208847251986509ull, 13437107393208188753ull, 7757799823517888395ull, + 17785673620794421403ull, 8427470712706825890ull, 15515599647035776791ull, + 17124603167879291190ull, 16854941425413651781ull, 12584455220362001967ull, + 15802462262049030765ull, 15263138777117751947ull, 6722166367014452318ull, + 13158180450388509915ull, 12079533480525952278ull, 13444332734028904637ull, + 7869616827067468215ull, 5712322887342352941ull, 8441921394348257659ull, + 15739233654134936430ull, 11424645774684705882ull, 16883842788696515318ull, + 13031723234560321245ull, 4402547475659860149ull, 15320941503683479020ull, + 7616702395411090874ull, 8805094951319720299ull, 12195138933657406425ull, + 15233404790822181748ull, 17610189902639440599ull, 5943533793605261235ull, + 12020065507934811881ull, 16773635731569329582ull, 11887067587210522471ull, + 5593386942160072147ull, 15100527389429107549ull, 5327391100711493327ull, + 11186773884320144295ull, 11754310705148663482ull, 10654782201422986654ull, + 3926803694930736975ull, 5061877336587775349ull, 2862820329136421693ull, + 7853607389861473950ull, 10123754673175550698ull, 5725640658272843386ull, + 15707214779722947901ull, 1800765272641549780ull, 11451281316545686772ull, + 12967685485736344186ull, 3601530545283099561ull, 4455818559381821928ull, + 7488626897763136756ull, 7203061090566199122ull, 8911637118763643856ull, + 14977253795526273512ull, 14406122181132398244ull, 17823274237527287712ull, + 11507763517342995409ull, 10365500288555244873ull, 17199804401345023809ull, + 4568782960976439203ull, 2284256503400938131ull, 15952864728980496003ull, + 9137565921952878406ull, 4568513006801876263ull, 13458985384251440391ull, + 18275131843905756812ull, 9137026013603752527ull, 8471226694793329166ull, + 18103519614101962008ull, 18274052027207505054ull, 16942453389586658332ull, + 17760295154494372401ull, 18101359980705458493ull, 15438162705463765049ull, + 17073846235279193187ull, 17755975887701365371ull, 12429581337217978483ull, + 15700948396848834759ull, 17065207701693179127ull, 6412418600726405351ull, + 12955152719988117903ull, 15683671329676806638ull, 12824837201452810702ull, + 7463561366266684191ull, 12920598585644061661ull, 7202930329196069788ull, + 14927122732533368383ull, 7394453097578571706ull, 14405860658392139577ull, + 11407501391357185150ull, 14788906195157143413ull, 10364977243074727539ull, + 4368258709004818685ull, 11131068316604735211ull, 2283210412439903463ull, + 8736517418009637371ull, 3815392559499918806ull, 4566420824879806927ull, + 17473034836019274742ull, 7630785118999837612ull, 9132841649759613855ull, + 16499325598328997868ull, 15261570237999675224ull, 18265683299519227710ull, + 14551907122948444121ull, 12076396402289798833ull, 18084622525328903805ull, + 10657070172187336627ull, 5706048730870046051ull, 17722500976948255995ull, + 2867396270665121638ull, 11412097461740092103ull, 16998257880186960375ull, + 5734792541330243277ull, 4377450849770632591ull, 15549771686664369135ull, + 11469585082660486554ull, 8754901699541265183ull, 12652799299619186654ull, + 4492426091611421492ull, 17509803399082530367ull, 6858854525528821692ull, + 8984852183222842985ull, 16572862724455509118ull, 13717709051057643384ull, + 17969704366445685971ull, 14698981375201466621ull, 8988674028405735153ull, + 17492664659181820327ull, 10951218676693381626ull, 17977348056811470306ull, + 16538585244654089039ull, 3455693279677211637ull, 17507952039913388997ull, + 14630426415598626462ull, 6911386559354423275ull, 16569160006117226378ull, + 10814108757487701308ull, 13822773118708846551ull, 14691575938524901140ull, + 3181473441265851001ull, 9198802163708141487ull, 10936407803340250665ull, + 6362946882531702002ull, 18397604327416282975ull, 3426071532970949714ull, + 12725893765063404005ull, 18348464581123014334ull, 6852143065941899429ull, + 7005043456417256395ull, 18250185088536477052ull, 13704286131883798858ull, + 14010086912834512791ull, 18053626103363402489ull, 8961828190058046100ull, + 9573429751959473967ull, 17660508133017253362ull, 17923656380116092201ull, + 700115430209396319ull, 16874272192324955109ull, 17400568686522632786ull, + 1400230860418792639ull, 15301800310940358603ull, 16354393299335713957ull, + 2800461720837585279ull, 12156856548171165591ull, 14262042524961876298ull, + 5600923441675170559ull, 5866969022632779567ull, 10077340976214200980ull, + 11201846883350341118ull, 11733938045265559135ull, 1707937878718850345ull, + 3956949692991130621ull, 5021132016821566654ull, 3415875757437700690ull, + 7913899385982261242ull, 10042264033643133308ull, 6831751514875401380ull, + 15827798771964522485ull, 1637783993576715000ull, 13663503029750802761ull, + 13208853470219493354ull, 3275567987153430001ull, 8880261985792053906ull, + 7970962866729435092ull, 6551135974306860002ull, 17760523971584107813ull, + 15941925733458870184ull, 13102271948613720005ull, 17074303869458664011ull, + 13437107393208188753ull, 7757799823517888395ull, 15701863665207776407ull, + 8427470712706825890ull, 15515599647035776791ull, 12956983256706001198ull, + 16854941425413651781ull, 12584455220362001967ull, 7467222439702450781ull, + 15263138777117751947ull, 6722166367014452318ull, 14934444879404901562ull, + 12079533480525952278ull, 13444332734028904637ull, 11422145685100251509ull, + 5712322887342352941ull, 8441921394348257659ull, 4397547296490951402ull, + 11424645774684705882ull, 16883842788696515318ull, 8795094592981902804ull, + 4402547475659860149ull, 15320941503683479020ull, 17590189185963805609ull, + 8805094951319720299ull, 12195138933657406425ull, 16733634298218059603ull, + 17610189902639440599ull, 5943533793605261235ull, 15020524522726567590ull, + 16773635731569329582ull, 11887067587210522471ull, 11594304971743583565ull, + 15100527389429107549ull, 5327391100711493327ull, 4741865869777615514ull, + 11754310705148663482ull, 10654782201422986654ull, 9483731739555231029ull, + 5061877336587775349ull, 2862820329136421693ull, 520719405400910443ull, + 10123754673175550698ull, 5725640658272843386ull, 1041438810801820887ull, + 1800765272641549780ull, 11451281316545686772ull, 2082877621603641775ull, + 3601530545283099561ull, 4455818559381821928ull, 4165755243207283551ull, + 7203061090566199122ull, 8911637118763643856ull, 8331510486414567103ull, + 14406122181132398244ull, 17823274237527287712ull, 16663020972829134207ull, + 10365500288555244873ull, 17199804401345023809ull, 14879297871948716798ull, + 2284256503400938131ull, 15952864728980496003ull, 11311851670187881981ull, + 4568513006801876263ull, 13458985384251440391ull, 4176959266666212347ull, + 9137026013603752527ull, 8471226694793329166ull, 8353918533332424694ull, + 18274052027207505054ull, 16942453389586658332ull, 16707837066664849389ull, + 18101359980705458493ull, 15438162705463765049ull, 14968930059620147162ull, + 17755975887701365371ull, 12429581337217978483ull, 11491116045530742709ull, + 17065207701693179127ull, 6412418600726405351ull, 4535488017351933803ull, + 15683671329676806638ull, 12824837201452810702ull, 9070976034703867607ull, + 12920598585644061661ull, 7202930329196069788ull, 18141952069407735215ull, + 7394453097578571706ull, 14405860658392139577ull, 17837160065105918815ull, + 14788906195157143413ull, 10364977243074727539ull, 17227576056502286015ull, + 11131068316604735211ull, 2283210412439903463ull, 16008408039295020414ull, + 3815392559499918806ull, 4566420824879806927ull, 13570072004880489213ull, + 7630785118999837612ull, 9132841649759613855ull, 8693399936051426811ull, + 15261570237999675224ull, 18265683299519227710ull, 17386799872102853622ull, + 12076396402289798833ull, 18084622525328903805ull, 16326855670496155628ull, + 5706048730870046051ull, 17722500976948255995ull, 14206967267282759640ull, + 11412097461740092103ull, 16998257880186960375ull, 9967190460855967665ull, + 4377450849770632591ull, 15549771686664369135ull, 1487636848002383714ull, + 8754901699541265183ull, 12652799299619186654ull, 2975273696004767428ull, + 17509803399082530367ull, 6858854525528821692ull, 5950547392009534856ull, + 16572862724455509118ull, 13717709051057643384ull, 11901094784019069713ull, + 14698981375201466621ull, 8988674028405735153ull, 5355445494328587811ull, + 10951218676693381626ull, 17977348056811470306ull, 10710890988657175623ull, + 3455693279677211637ull, 17507952039913388997ull, 2975037903604799631ull, + 6911386559354423275ull, 16569160006117226378ull, 5950075807209599263ull, + 13822773118708846551ull, 14691575938524901140ull, 11900151614419198527ull, + 9198802163708141487ull, 10936407803340250665ull, 5353559155128845438ull, + 18397604327416282975ull, 3426071532970949714ull, 10707118310257690876ull, + 18348464581123014334ull, 6852143065941899429ull, 2967492546805830136ull, + 18250185088536477052ull, 13704286131883798858ull, 5934985093611660273ull, + 18053626103363402489ull, 8961828190058046100ull, 11869970187223320547ull, + 17660508133017253362ull, 17923656380116092201ull, 5293196300737089478ull, + 16874272192324955109ull, 17400568686522632786ull, 10586392601474178957ull, + 15301800310940358603ull, 16354393299335713957ull, 2726041129238806298ull, + 12156856548171165591ull, 14262042524961876298ull, 5452082258477612597ull, + 5866969022632779567ull, 10077340976214200980ull, 10904164516955225194ull, + 11733938045265559135ull, 1707937878718850345ull, 3361584960200898773ull, + 5021132016821566654ull, 3415875757437700690ull, 6723169920401797547ull, + 10042264033643133308ull, 6831751514875401380ull, 13446339840803595095ull, + 1637783993576715000ull, 13663503029750802761ull, 8445935607897638574ull, + 3275567987153430001ull, 8880261985792053906ull, 16891871215795277149ull, + 6551135974306860002ull, 17760523971584107813ull, 15336998357881002682ull, + 13102271948613720005ull, 17074303869458664011ull, 12227252642052453748ull, + 7757799823517888395ull, 15701863665207776407ull, 6007761210395355880ull, + 15515599647035776791ull, 12956983256706001198ull, 12015522420790711760ull, + 12584455220362001967ull, 7467222439702450781ull, 5584300767871871905ull, + 6722166367014452318ull, 14934444879404901562ull, 11168601535743743810ull, + 13444332734028904637ull, 11422145685100251509ull, 3890458997777936004ull, + 8441921394348257659ull, 4397547296490951402ull, 7780917995555872008ull, + 16883842788696515318ull, 8795094592981902804ull, 15561835991111744016ull, + 15320941503683479020ull, 17590189185963805609ull, 12676927908513936417ull, + 12195138933657406425ull, 16733634298218059603ull, 6907111743318321218ull, + 5943533793605261235ull, 15020524522726567590ull, 13814223486636642437ull, + 11887067587210522471ull, 11594304971743583565ull, 9181702899563733258ull, + 5327391100711493327ull, 4741865869777615514ull, 18363405799127466517ull, + 10654782201422986654ull, 9483731739555231029ull, 18280067524545381419ull, + 2862820329136421693ull, 520719405400910443ull, 18113390975381211222ull, + 5725640658272843386ull, 1041438810801820887ull, 17780037877052870828ull, + 11451281316545686772ull, 2082877621603641775ull, 17113331680396190040ull, +};; + +} // namespace npsr::trig::data + +#endif // NPSR_TRIG_DATA_REDUCTION_H diff --git a/npsr/trig/data/reduction.h.sol b/npsr/trig/data/reduction.h.sol new file mode 100644 index 0000000..9a1519a --- /dev/null +++ b/npsr/trig/data/reduction.h.sol @@ -0,0 +1,47 @@ +// Precompute int(2^exp × 4/π) with ~96-bit precision (f32) or ~192-bit precision (f64) +// and split them into three chunks: 32-bit chunks for single precision, 64-bit chunks for double precision. +// +// This generates a lookup table for large range reduction in trigonometric functions. +// The table is used to compute mantissa × (2^exp × 4/π) using wider integer multiplications for precision: +// - f32: 16×16 → 32-bit multiplications +// - f64: 32×32 → 64-bit multiplications +// +// For input x = mantissa × 2^exp, the algorithm becomes: +// x × 4/π = mantissa × table_lookup[exp], providing high precision without floating-point errors. +// +// Args: +// float_size: 32 for f32 or 64 for f64 +procedure ReductionTuble_(pT, pOffset) { + var r, i, j, $; + SetDisplay(decimal); + SetPrec(pT.kDigits * 3); + $.mask = 2^pT.kSize; + $.scalar = 4 / pi; + r = [||]; + for i from 0 to pT.kMaxExpBiased + 1 do { + $.exp_shift = i - pT.kBias + pOffset; + $._int = LeftShift($.scalar, $.exp_shift); + $.chunks = [||]; + for j in [|pT.kSize * 2, pT.kSize, 0|] do { + $.rshift = RightShift($._int, j); + $.apply_mask = mod($.rshift, $.mask); + $.chunks = $.chunks @ [|$.apply_mask|]; + }; + r = r @ $.chunks; + }; + r = ToStringCArray(r, pT.kCUintSFX, 3); + RestorePrec(); + RestoreDisplay(); + return r; +}; + +Append( + "template constexpr T kLargeReductionTable[] = {};", + "template <> constexpr uint32_t kLargeReductionTable[] = " @ + ReductionTuble_(Float32, 70) @ ";", + "", + "template <> constexpr uint64_t kLargeReductionTable[] = " @ + ReductionTuble_(Float64, 137) @ ";", + "" +); +WriteCPPHeader("npsr::trig::data"); diff --git a/npsr/trig/data/small.h b/npsr/trig/data/small.h deleted file mode 100644 index e94e130..0000000 --- a/npsr/trig/data/small.h +++ /dev/null @@ -1,25 +0,0 @@ -// Do not edit this file, it is generated by npsr/trig/data/small.h.py -// use `spin generate -f` to force regeneration -#ifndef NPSR_TRIG_DATA_SMALL_H_PY -#define NPSR_TRIG_DATA_SMALL_H_PY -namespace npsr::trig::data { namespace { -constexpr double kHiSinKPi16Table[] ={ - 0, 0x1.8f8b83c69a60bp-3, 0x1.87de2a6aea963p-2, 0x1.1c73b39ae68c8p-1, - 0x1.6a09e667f3bcdp-1, 0x1.a9b66290ea1a3p-1, 0x1.d906bcf328d46p-1, 0x1.f6297cff75cbp-1, - 0x1p0, 0x1.f6297cff75cbp-1, 0x1.d906bcf328d46p-1, 0x1.a9b66290ea1a3p-1, - 0x1.6a09e667f3bcdp-1, 0x1.1c73b39ae68c8p-1, 0x1.87de2a6aea963p-2, 0x1.8f8b83c69a60bp-3, -}; -constexpr double kHiCosKPi16Table[] ={ - 0x1p0, 0x1.f6297cff75cbp-1, 0x1.d906bcf328d46p-1, 0x1.a9b66290ea1a3p-1, - 0x1.6a09e667f3bcdp-1, 0x1.1c73b39ae68c8p-1, 0x1.87de2a6aea963p-2, 0x1.8f8b83c69a60bp-3, - 0, -0x1.8f8b83c69a60bp-3, -0x1.87de2a6aea963p-2, -0x1.1c73b39ae68c8p-1, - -0x1.6a09e667f3bcdp-1, -0x1.a9b66290ea1a3p-1, -0x1.d906bcf328d46p-1, -0x1.f6297cff75cbp-1, -}; -constexpr double kPackedLowSinCosKPi16Table[] ={ - 0, 0x1.56217bc626d19p-56, 0x1.457e6bc672cedp-56, 0x1.9f6303c8b25ddp-60, - -0x1.bdd34bc8bdd34p-55, 0x1.b25dd3c39f63p-55, -0x1.72ced3c7457e6p-57, -0x1.26d193c756217p-57, - 0, 0x1.26d193c756217p-57, 0x1.72ced3c7457e6p-57, -0x1.b25dd3c39f63p-55, - 0x1.bdd34bc8bdd34p-55, -0x1.9f6303c8b25ddp-60, -0x1.457e6bc672cedp-56, -0x1.56217bc626d19p-56, -}; -}} // namespace {namespace} -#endif // NPSR_TRIG_DATA_SMALL_H_PY diff --git a/npsr/trig/data/small.h.py b/npsr/trig/data/small.h.py deleted file mode 100644 index de28d04..0000000 --- a/npsr/trig/data/small.h.py +++ /dev/null @@ -1,64 +0,0 @@ -from generator import c_array, c_header, sollya - - -def gen_kpi16(float_size, func): - cast = "single" if float_size == 32 else "double" - return sollya( - f""" - prec = {float_size*3}; - display = hexadecimal; - cast = {cast}(x); - func = {func}(x); - pi16 = pi / 16; - for k from 0 to 15 do {{ - cast(func(k * pi16)); - }}; - """ - ) - - -def gen_pack_func(clo, slo): - combined = (clo & 0xFFFFFFFF00000000) | ((slo >> 32) & 0xFFFFFFFF) - return f"0x{combined:016x}" - - -def gen_kpi16_low_pack(): - ints = sollya( - f""" - prec = {64*3}; - display = hexadecimal; - pi16 = pi / 16; - for k from 0 to 15 do {{ - shi = double(sin(k * pi16)); - chi = double(cos(k * pi16)); - slo = double(sin(k * pi16) - shi); - clo = double(cos(k * pi16) - chi); - printdouble(clo); - printdouble(slo); - }}; - """, - as_int=0x10, - ) - packed = [gen_pack_func(clo, slo) for clo, slo in zip(ints[::2], ints[1::2])] - ints = sollya( - f""" - prec = {64*3}; - display = hexadecimal; - packed = [|{','.join(packed)}|]; - for k from 0 to 15 do {{ - double(packed[k]); - }}; - """ - ) - return ints - - -print( - c_header( - "constexpr double kHiSinKPi16Table[] =" + c_array(gen_kpi16(64, "sin"), col=4), - "constexpr double kHiCosKPi16Table[] =" + c_array(gen_kpi16(64, "cos"), col=4), - "constexpr double kPackedLowSinCosKPi16Table[] =" - + c_array(gen_kpi16_low_pack(), col=4), - namespace="npsr::trig::data", - ) -) diff --git a/npsr/trig/large-inl.h b/npsr/trig/extended-inl.h similarity index 70% rename from npsr/trig/large-inl.h rename to npsr/trig/extended-inl.h index c3f4eb6..f84c791 100644 --- a/npsr/trig/large-inl.h +++ b/npsr/trig/extended-inl.h @@ -1,24 +1,25 @@ -#if defined(NPSR_TRIG_LARGE_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT -#ifdef NPSR_TRIG_LARGE_INL_H_ -#undef NPSR_TRIG_LARGE_INL_H_ +#include "hwy/base.h" +#if defined(NPSR_TRIG_EXTENDED_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TRIG_EXTENDED_INL_H_ +#undef NPSR_TRIG_EXTENDED_INL_H_ #else -#define NPSR_TRIG_LARGE_INL_H_ +#define NPSR_TRIG_EXTENDED_INL_H_ #endif #include "npsr/common.h" -#include "npsr/trig/data/large-aprox.h" -#include "npsr/trig/data/large-reduction.h" +#include "npsr/trig/data/data.h" HWY_BEFORE_NAMESPACE(); -namespace npsr::HWY_NAMESPACE::sincos { +namespace npsr::HWY_NAMESPACE::trig { template -HWY_API V LargeArg(V x) { - using namespace hwy; - using namespace hwy::HWY_NAMESPACE; - using trig::data::kCosApproxTable; - using trig::data::kLargeReductionTable; - using trig::data::kSinApproxTable; +HWY_API V Extended(V x) { + using namespace hn; + namespace data = ::npsr::trig::data; + using hwy::ExponentBits; + using hwy::MantissaBits; + using hwy::MantissaMask; + using hwy::SignMask; using D = DFromV; using DI = RebindToSigned; @@ -44,9 +45,9 @@ HWY_API V LargeArg(V x) { // Gather three parts of (4/π) × 2^exp from precomputed table // Generated by Python script with offset: 70 (F32) or 137 (F64) - VU u_p_hi = GatherIndex(du, kLargeReductionTable, i_table_idx); - VU u_p_med = GatherIndex(du, kLargeReductionTable + 1, i_table_idx); - VU u_p_lo = GatherIndex(du, kLargeReductionTable + 2, i_table_idx); + VU u_p_hi = GatherIndex(du, data::kLargeReductionTable, i_table_idx); + VU u_p_med = GatherIndex(du, data::kLargeReductionTable + 1, i_table_idx); + VU u_p_lo = GatherIndex(du, data::kLargeReductionTable + 2, i_table_idx); // ============================================================================= // PHASE 2: Extract and Normalize Mantissa @@ -136,8 +137,8 @@ HWY_API V LargeArg(V x) { VU u_result2 = And(u_sum2, u_low_mask); VU u_result3 = ShiftLeft(u_sum3); - VU u_reduce_lo = Add(u_sum1_shifted, u_result0); - VU u_reduce_hi = Add(u_result3, u_result2); + VU u_n_hi = Add(u_result3, u_result2); + VU u_n_lo = Add(u_sum1_shifted, u_result0); // ============================================================================= // PHASE 5: Extract Quotient and Fractional Parts @@ -146,7 +147,7 @@ HWY_API V LargeArg(V x) { // Extract integer quotient constexpr int kQuotientShift = ExponentBits() + 1; // 9 for F32, 12 for F64 - VU u_shifted_n = ShiftRight(u_reduce_hi); + VU u_shifted_n = ShiftRight(u_n_hi); // fractional shifts derived from magic constants // F32: 5, 18, 14 (sum = 37, total with quotient = 46 = 2×23) @@ -163,9 +164,12 @@ HWY_API V LargeArg(V x) { // Extract fractional parts constexpr TU kFracMidMask = (static_cast(1) << kFracMidShift) - 1; - VU u_frac_low_bits = And(u_reduce_lo, Set(du, kFracMidMask)); + VU u_frac_low_bits = And(u_n_lo, Set(du, kFracMidMask)); VU u_shifted_sig_lo = ShiftLeft(u_frac_low_bits); - VU u_frac_mid_bits = ShiftRight(u_reduce_lo); + VU u_frac_mid_bits = ShiftRight(u_n_lo); + constexpr TU kFracHighMask = + (static_cast(1) << (kFracHighShift - kFracLowShift)) - 1; + VU u_frac_high_bits = And(u_n_hi, Set(du, kFracHighMask)); // ============================================================================= // PHASE 6: Magic Number Conversion to Floating Point @@ -181,47 +185,60 @@ HWY_API V LargeArg(V x) { V shifter = Set(d, kIsSingle ? 0x1.8p15f : 0x1.8p43); V integer_part = Add(shifter, BitCast(d, u_quotient_signed)); - V n = Sub(integer_part, shifter); - V reduced_hi = Sub(BitCast(d, u_quotient_signed), n); + V n_hi = Sub(integer_part, shifter); + n_hi = Sub(BitCast(d, u_quotient_signed), n_hi); // constants for fractional parts - VU u_epsilon_low = BitCast(du, Set(d, kIsSingle ? 0x1p-46f : 0x1p-104)); - VU u_exp_low = Xor(u_sign_bit, u_epsilon_low); - VU u_frac_low_combined = Or(u_shifted_sig_lo, u_exp_low); - - constexpr TU kFracHighMask = - (static_cast(1) << (kFracHighShift - kFracLowShift)) - 1; - VU u_frac_high_bits = And(u_reduce_hi, Set(du, kFracHighMask)); - V shifter_lo = BitCast(d, u_exp_low); - V reduced_lo = Sub(BitCast(d, u_frac_low_combined), shifter_lo); - VU u_epsilon = BitCast(du, Set(d, kIsSingle ? 0x1p-23f : 0x1p-52)); VU u_exp_mid = Xor(u_sign_bit, u_epsilon); VU u_shifted_sig_mid = Or(ShiftLeft(u_frac_high_bits), u_frac_mid_bits); VU u_frac_mid_combined = Or(u_shifted_sig_mid, u_exp_mid); V shifter_mid = BitCast(d, u_exp_mid); - V reduced_med = Sub(BitCast(d, u_frac_mid_combined), shifter_mid); + V n_med = Sub(BitCast(d, u_frac_mid_combined), shifter_mid); + + VU u_epsilon_low = BitCast(du, Set(d, kIsSingle ? 0x1p-46f : 0x1p-104)); + VU u_exp_low = Xor(u_sign_bit, u_epsilon_low); + VU u_frac_low_combined = Or(u_shifted_sig_lo, u_exp_low); + + V exp_low = BitCast(d, u_exp_low); + V frac_low_combined = BitCast(d, u_frac_low_combined); + + V n = Add(n_hi, n_med); + V n_lo = Sub(n_hi, n); + n_lo = Add(n_med, n_lo); + n_lo = Add(n_lo, Sub(frac_low_combined, exp_low)); // ============================================================================= // PHASE 7: Convert to Radians // ============================================================================= - // High-precision 2π constants - V _2pu_lead = Set(d, kIsSingle ? 0x1.921fb6p2f : 0x1.921fb54442d18p+2); - V _2pu_trail = Set(d, kIsSingle ? -0x1.777a5cp-23f : 0x1.1a62633145c07p-52); - - // Compensated summation - V r_hi = Add(reduced_hi, reduced_med); - V reduced_hu_err = Sub(reduced_hi, r_hi); - V reduced_med_corr = Add(reduced_med, reduced_hu_err); - V r_lo = Add(reduced_med_corr, reduced_lo); - // Multiply by π with error compensation (Cody-Waite multiplication) - V red_hi = Mul(r_hi, _2pu_lead); - V mult_error = MulSub(r_hi, _2pu_lead, red_hi); - V red_lo_final_part = MulAdd(_2pu_trail, r_hi, mult_error); - V red_lo_final = MulAdd(_2pu_lead, r_lo, red_lo_final_part); + constexpr auto kPiMul2 = data::kPiMul2; + const V pi2_hi = Set(d, kPiMul2[0]); + const V pi2_med = Set(d, kPiMul2[1]); + + V r = Mul(pi2_hi, n); + V r_lo, r_w0, r_w1; + if constexpr (!kNativeFMA && kIsSingle) { + using DW = RepartitionToWide; + using DH = Half; + using VW = Vec; + const DW dw; + const DH dh; + VW pi2_whi = Set(dw, data::kPiMul2[0]); + VW r0 = Mul(pi2_whi, PromoteUpperTo(dw, n)); + VW r1 = Mul(pi2_whi, PromoteLowerTo(dw, n)); + VW r_lo_w0 = Sub(r0, PromoteUpperTo(dw, r)); + VW r_lo_w1 = Sub(r1, PromoteLowerTo(dw, r)); + r_lo = Combine(d, DemoteTo(dh, r_lo_w0), DemoteTo(dh, r_lo_w1)); + r_w0 = BitCast(d, r0); + r_w1 = BitCast(d, r1); + } else { + r_lo = MulSub(pi2_hi, n, r); + r_lo = MulAdd(pi2_med, n, r_lo); + } + r_lo = MulAdd(pi2_hi, n_lo, r_lo); // ============================================================================= // PHASE 8: Small Argument Handling @@ -230,72 +247,66 @@ HWY_API V LargeArg(V x) { const V min_input = Set(d, static_cast(0x1p-20)); const auto ismall_arg = Gt(min_input, abx); - V r = IfThenElse(ismall_arg, x, red_hi); - V e = IfThenElse(ismall_arg, Zero(d), red_lo_final); + r = IfThenElse(ismall_arg, x, r); + r_lo = IfThenElse(ismall_arg, Zero(d), r_lo); + V r2 = Mul(r, r); + + // ============================================================================= + // PHASE 9: Table Lookup + // ============================================================================= + + const T *table_base = + IS_COS ? data::kCosApproxTable : data::kSinApproxTable; // Calculate table index VU u_n_mask = Set(du, kIsSingle ? 0xFF : 0x1FF); VU u_index = And(BitCast(du, integer_part), u_n_mask); VI u_table_index = BitCast(di, ShiftLeft<2>(u_index)); - // ============================================================================= - // PHASE 9: Table Lookup - // ============================================================================= - - const T *table_base = IS_COS ? kCosApproxTable : kSinApproxTable; + const V deriv_hi = GatherIndex(d, table_base, u_table_index); + const V sigma = GatherIndex(d, table_base + 1, u_table_index); + const V func_hi = GatherIndex(d, table_base + 2, u_table_index); + const V func_lo = GatherIndex(d, table_base + 3, u_table_index); + const V deriv = Add(deriv_hi, sigma); - // Gather table values: [deriv_error, sin_hi, sin_lo, deriv] - // Based on Sollya script: p0=deriv_error, p1=sin_hi, p2=sin_lo, - // p3=deriv - V deriv_error = GatherIndex(d, table_base, u_table_index); - V deriv = GatherIndex(d, table_base + 1, u_table_index); - V sin_hi = GatherIndex(d, table_base + 2, u_table_index); - V sin_lo = GatherIndex(d, table_base + 3, u_table_index); // ============================================================================= // PHASE 10: Final Assembly // ============================================================================= + V res_lo = NegMulAdd(func_hi, r, deriv); + res_lo = MulAdd(res_lo, r_lo, func_lo); + V res_hi_lo = MulAdd(sigma, r, func_hi); + V res_hi = MulAdd(deriv_hi, r, res_hi_lo); - V r2 = Mul(r, r); - // Apply first-order correction: sin_hi + deriv × r - V first_order = MulAdd(deriv, r, sin_hi); - V linear_error = MulAdd(deriv, r, Sub(sin_hi, first_order)); - - // Apply derivative error correction - V deriv_corrected = MulAdd(r, deriv_error, first_order); - V deriv_correction_error = - MulAdd(r, deriv_error, Sub(first_order, deriv_corrected)); - V total_linear_error = Add(deriv_correction_error, linear_error); + V sum_cor = MulAdd(sigma, r, Sub(func_hi, res_hi_lo)); + V deriv_hi_r_cor = MulAdd(deriv_hi, r, Sub(res_hi_lo, res_hi)); + deriv_hi_r_cor = Add(deriv_hi_r_cor, sum_cor); + res_lo = Add(res_lo, deriv_hi_r_cor); // Polynomial corrections V s2 = Set(d, kIsSingle ? 0x1.1110b8p-7f : 0x1.1110fabb3551cp-7); V s1 = Set(d, kIsSingle ? -0x1.555556p-3f : -0x1.5555555554448p-3); V sin_poly = MulAdd(s2, r2, s1); - sin_poly = Mul(sin_poly, r2); sin_poly = Mul(sin_poly, r); + sin_poly = Mul(sin_poly, r2); - V c2 = Set(d, kIsSingle ? 0x1.5554f8p-5f : 0x1.5555555554ccfp-5); - V c1 = Set(d, static_cast(-0.5)); + V c1 = Set(d, kIsSingle ? 0x1.5554f8p-5f : 0x1.5555555554ccfp-5); + const V neg_half = Set(d, static_cast(-0.5)); V cos_poly; if constexpr (kIsSingle) { - cos_poly = MulAdd(c2, r2, c1); + cos_poly = MulAdd(c1, r2, neg_half); } else { - V c3 = Set(d, -0x1.6c16ab163b2d7p-10); - cos_poly = MulAdd(c3, r2, c2); - cos_poly = MulAdd(r2, cos_poly, c1); + V c2 = Set(d, -0x1.6c16ab163b2d7p-10); + cos_poly = MulAdd(c2, r2, c1); + cos_poly = MulAdd(cos_poly, r2, neg_half); } cos_poly = Mul(cos_poly, r2); - // Apply cross-term corrections - V func_deriv_sum = Add(deriv_error, deriv); - V corr1 = NegMulAdd(sin_hi, r, func_deriv_sum); - // Apply remaining corrections - V corr = MulAdd(corr1, e, sin_lo); - V poly_correction = MulAdd(func_deriv_sum, sin_poly, total_linear_error); - V cos_correction = MulAdd(sin_hi, cos_poly, corr); - V final_correction = Add(cos_correction, poly_correction); - return Add(deriv_corrected, final_correction); + + res_lo = MulAdd(sin_poly, deriv, res_lo); + res_lo = MulAdd(cos_poly, func_hi, res_lo); + return Add(res_hi, res_lo); } // NOLINTNEXTLINE(google-readability-namespace-comments) -} // namespace npsr::HWY_NAMESPACE::sincos +} // namespace npsr::HWY_NAMESPACE::trig HWY_AFTER_NAMESPACE(); -#endif // NPSR_TRIG_LARGE_INL_H_ +#endif // NPSR_TRIG_EXTENDED_INL_H_ diff --git a/npsr/trig/small-inl.h b/npsr/trig/high-inl.h similarity index 62% rename from npsr/trig/small-inl.h rename to npsr/trig/high-inl.h index 4e47ff6..271e197 100644 --- a/npsr/trig/small-inl.h +++ b/npsr/trig/high-inl.h @@ -1,140 +1,23 @@ #include "npsr/common.h" -#include "npsr/trig/data/small.h" +#include "npsr/trig/data/data.h" #include "npsr/utils-inl.h" -#if defined(NPSR_TRIG_SMALL_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT -#ifdef NPSR_TRIG_SMALL_INL_H_ -#undef NPSR_TRIG_SMALL_INL_H_ +#if defined(NPSR_TRIG_HIGH_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TRIG_HIGH_INL_H_ +#undef NPSR_TRIG_HIGH_INL_H_ #else -#define NPSR_TRIG_SMALL_INL_H_ +#define NPSR_TRIG_HIGH_INL_H_ #endif HWY_BEFORE_NAMESPACE(); -namespace npsr::HWY_NAMESPACE::sincos { - -using namespace hwy; -using namespace hwy::HWY_NAMESPACE; +namespace npsr::HWY_NAMESPACE::trig { template )> -HWY_API V SmallPolyLow(V r, V r2) { - const DFromV d; - const V c9 = Set(d, IS_COS ? 0x1.5d866ap-19f : 0x1.5dbdfp-19f); - const V c7 = Set(d, IS_COS ? -0x1.9f6d9ep-13 : -0x1.9f6ffep-13f); - const V c5 = Set(d, IS_COS ? 0x1.110ec8p-7 : 0x1.110eccp-7f); - const V c3 = Set(d, -0x1.55554cp-3f); - V poly = MulAdd(c9, r2, c7); - poly = MulAdd(r2, poly, c5); - poly = MulAdd(r2, poly, c3); - if constexpr (IS_COS) { - // Although this path handles cosine, we have already transformed the - // input using the identity: cos(x) = sin(x + π/2) This means we're no - // longer directly evaluating a cosine Taylor series; instead, we evaluate - // the sine approximation polynomial at (x + π/2). - // - // The sine approximation has the general form: - // sin(r) ≈ r + r³ · P(r²) - // - // So, we compute: - // r³ = r · r² - // sin(r) ≈ r + r³ · poly - // - // This formulation preserves accuracy by computing the highest order - // terms last, which benefits from FMA to reduce rounding error. - V r3 = Mul(r2, r); - poly = MulAdd(r3, poly, r); - } else { - poly = Mul(poly, r2); - poly = MulAdd(r, poly, r); - } - return poly; -} +HWY_INLINE V High(V x) { + using namespace hn; + namespace data = ::npsr::trig::data; -template )> -HWY_API V SmallPolyLow(V r, V r2) { - const DFromV d; - const V c15 = Set(d, -0x1.9f1517e9f65fp-41); - const V c13 = Set(d, 0x1.60e6bee01d83ep-33); - const V c11 = Set(d, -0x1.ae6355aaa4a53p-26); - const V c9 = Set(d, 0x1.71de3806add1ap-19); - const V c7 = Set(d, -0x1.a01a019a659ddp-13); - const V c5 = Set(d, 0x1.111111110a573p-7); - const V c3 = Set(d, -0x1.55555555554a8p-3); - - V poly = MulAdd(c15, r2, c13); - poly = MulAdd(r2, poly, c11); - poly = MulAdd(r2, poly, c9); - poly = MulAdd(r2, poly, c7); - poly = MulAdd(r2, poly, c5); - poly = MulAdd(r2, poly, c3); - return poly; -} - -template -HWY_API V SmallArgLow(V x) { - const DFromV d; - const RebindToUnsigned du; - using T = TFromV; - // Load frequently used constants as vector registers - const V abs_mask = BitCast(d, Set(du, SignMask() - 1)); - const V x_abs = And(abs_mask, x); - const V x_sign = AndNot(x_abs, x); - - constexpr bool kIsSingle = std::is_same_v; - // Transform cosine to sine using identity: cos(x) = sin(x + π/2) - const V half_pi = Set(d, kIsSingle ? 0x1.921fb6p0f : 0x1.921fb54442d18p0); - V x_trans = x_abs; - if constexpr (IS_COS) { - x_trans = Add(x_abs, half_pi); - } - // check zero input/subnormal for cosine (cos(~0) = 1) - const auto is_cos_near_zero = Eq(x_trans, half_pi); - - // Compute N = round(x/π) using "magic number" technique - // and stores integer part in mantissa - const V inv_pi = Set(d, kIsSingle ? 0x1.45f306p-2f : 0x1.45f306dc9c883p-2); - const V magic_round = Set(d, kIsSingle ? 0x1.8p23f : 0x1.8p52); - V n_biased = MulAdd(x_trans, inv_pi, magic_round); - V n = Sub(n_biased, magic_round); - // Adjust quotient for cosine (accounts for π/2 phase shift) - if constexpr (IS_COS) { - // For cosine, we computed N = round((x + π/2)/π) but need N' for x: - // N = round((x + π/2)/π) = round(x/π + 0.5) - // This is often 1 more than round(x/π), so we subtract 0.5: - // N' = N - 0.5 - n = Sub(n, Set(d, static_cast(0.5))); - } - // Use Cody-Waite method with triple-precision PI - const V pi_hi = Set(d, kIsSingle ? 0x1.921fb6p1f : 0x1.921fb54442d18p+1); - const V pi_med = - Set(d, kIsSingle ? -0x1.777a5cp-24f : 0x1.c1cd129024e09p-106); - const V pi_lo = Set(d, kIsSingle ? -0x1.ee59dap-49f : 0x1.1a62633145c06p-53); - V r = NegMulAdd(n, pi_hi, x_abs); - if constexpr (kIsSingle) { - r = NegMulAdd(n, pi_med, r); - } - r = NegMulAdd(n, pi_lo, r); - V r2 = Mul(r, r); - V poly = SmallPolyLow(r, r2); - if constexpr (!kIsSingle) { - V r_mid = NegMulAdd(n, pi_med, r); - V r2_corr = Mul(r2, r_mid); - poly = MulAdd(r2_corr, poly, r_mid); - } - // Extract octant sign information from quotient and flip the sign bit - poly = Xor(poly, - BitCast(d, ShiftLeft(BitCast(du, n_biased)))); - if constexpr (IS_COS) { - poly = IfThenElse(is_cos_near_zero, Set(d, static_cast(1.0)), poly); - } else { - // Restore original sign for sine (odd function) - poly = Xor(poly, x_sign); - } - return poly; -} - -template )> -HWY_INLINE V SmallArg(V x) { using T = TFromV; using D = DFromV; using DU = RebindToUnsigned; @@ -152,7 +35,7 @@ HWY_INLINE V SmallArg(V x) { const V x_sign = AndNot(x_abs, x); // Transform cosine to sine using identity: cos(x) = sin(x + π/2) - const V half_pi = Set(d, 0x1.921fb6p0f); + const V half_pi = Set(d, data::kHalfPi); V x_trans = x_abs; if constexpr (IS_COS) { x_trans = Add(x_abs, half_pi); @@ -160,11 +43,9 @@ HWY_INLINE V SmallArg(V x) { // check zero input/subnormal for cosine (cos(~0) = 1) const auto is_cos_near_zero = Eq(x_trans, half_pi); - // Compute N = round(input/π) using "magic number" technique - // Adding 2^23 forces rounding and stores integer part in mantissa - const V inv_pi = Set(d, 0x1.45f306p-2f); + // Compute N = round(input/π) const V magic_round = Set(d, 0x1.8p23f); - V n_biased = MulAdd(x_trans, inv_pi, magic_round); + V n_biased = MulAdd(x_trans, Set(d, data::kInvPi), magic_round); V n = Sub(n_biased, magic_round); // Adjust quotient for cosine (accounts for π/2 phase shift) @@ -177,10 +58,9 @@ HWY_INLINE V SmallArg(V x) { } auto WideCal = [](VW nh, VW xh_abs) -> VW { const DFromV dw; - const VW pi_hi = Set(dw, 0x1.921fb5444p1); - const VW pi_lo = Set(dw, 0x1.68c234c4c6629p-38); - - VW r = NegMulAdd(nh, pi_lo, NegMulAdd(nh, pi_hi, xh_abs)); + constexpr auto kPiPrec35 = data::kPiPrec35; + VW r = NegMulAdd(nh, Set(dw, kPiPrec35[0]), xh_abs); + r = NegMulAdd(nh, Set(dw, kPiPrec35[1]), r); VW r2 = Mul(r, r); // Polynomial coefficients for sin(r) approximation on [-π/2, π/2] @@ -188,7 +68,6 @@ HWY_INLINE V SmallArg(V x) { const VW c7 = Set(dw, -0x1.9f6ffeea73463p-13); const VW c5 = Set(dw, 0x1.110ed3804ca96p-7); const VW c3 = Set(dw, -0x1.55554bc836587p-3); - VW poly = MulAdd(c9, r2, c7); poly = MulAdd(r2, poly, c5); poly = MulAdd(r2, poly, c3); @@ -199,6 +78,7 @@ HWY_INLINE V SmallArg(V x) { VW poly_lo = WideCal(PromoteLowerTo(dw, n), PromoteLowerTo(dw, x_abs)); VW poly_up = WideCal(PromoteUpperTo(dw, n), PromoteUpperTo(dw, x_abs)); + V poly = Combine(d, DemoteTo(dh, poly_up), DemoteTo(dh, poly_lo)); // Extract octant sign information from quotient and flip the sign bit poly = Xor(poly, @@ -234,10 +114,9 @@ HWY_INLINE V SmallArg(V x) { * */ template )> -HWY_INLINE V SmallArg(V x) { - using trig::data::kHiCosKPi16Table; - using trig::data::kHiSinKPi16Table; - using trig::data::kPackedLowSinCosKPi16Table; +HWY_INLINE V High(V x) { + using namespace hn; + namespace data = ::npsr::trig::data; using T = TFromV; using D = DFromV; @@ -247,15 +126,10 @@ HWY_INLINE V SmallArg(V x) { const D d; const DU du; - // Constants for range reduction - constexpr T kInvPi = 0x1.45f306dc9c883p2; // 16/π for range reduction - constexpr T kPi16High = 0x1.921fb54442d18p-3; // π/16 high precision part - constexpr T kPi16Low = 0x1.1a62633p-57; // π/16 low precision part - constexpr T kPi16Tiny = 0x1.45c06e0e68948p-89; // π/16 tiny precision part // Step 1: Range reduction - find n such that x = n*(π/16) + r, where |r| < // π/16 V magic = Set(d, 0x1.8p52); - V n_biased = MulAdd(x, Set(d, kInvPi), magic); + V n_biased = MulAdd(x, Set(d, data::k16DivPi), magic); V n = Sub(n_biased, magic); // Extract integer index for table lookup (n mod 16) @@ -263,23 +137,32 @@ HWY_INLINE V SmallArg(V x) { VU table_idx = And(n_int, Set(du, 0xF)); // Mask to get n mod 16 // Step 2: Load precomputed sine/cosine values for n mod 16 - V sin_hi = LutX2(kHiSinKPi16Table, table_idx); - V cos_hi = LutX2(kHiCosKPi16Table, table_idx); + V sin_hi = LutX2(data::kHiSinKPi16Table, table_idx); + V cos_hi = LutX2(data::kHiCosKPi16Table, table_idx); // Note: cos_lo and sin_lo are packed together (32 bits each) to save memory. // cos_lo can be used as-is since it's in the upper bits, sin_lo needs // extraction. The precision loss is negligible for the final result. // see lut-inl.h.py for the table generation code. - V cos_lo = LutX2(kPackedLowSinCosKPi16Table, table_idx); + V cos_lo = LutX2(data::kPackedLowSinCosKPi16Table, table_idx); // Extract sin_low from packed format (upper 32 bits) V sin_lo = BitCast(d, ShiftLeft<32>(BitCast(du, cos_lo))); // Step 3: Multi-precision computation of remainder r - V r_hi = NegMulAdd(n, Set(d, kPi16High), x); // r = x - n*(π/16)_high - V r_mid = NegMulAdd(n, Set(d, kPi16Low), r_hi); // Subtract low part - V r = NegMulAdd(n, Set(d, kPi16Tiny), r_mid); // Subtract tiny part + // r = x - n*(π/16)_high + constexpr auto kPiDiv16Prec29 = data::kPiDiv16Prec29; + V r_hi = NegMulAdd(n, Set(d, kPiDiv16Prec29[0]), x); + if constexpr (!kNativeFMA) { + // For F64, we need to handle the low precision part separately + r_hi = NegMulAdd(n, Set(d, kPiDiv16Prec29[3]), r_hi); + } + const V pi16_med = Set(d, kPiDiv16Prec29[1]); + const V pi16_lo = Set(d, kPiDiv16Prec29[2]); + V r_med = NegMulAdd(n, pi16_med, r_hi); + V r = NegMulAdd(n, pi16_lo, r_med); + // Compute low precision part of r for extra accuracy - V term = NegMulAdd(Set(d, kPi16Low), n, Sub(r_hi, r_mid)); - V r_lo = MulAdd(Set(d, kPi16Tiny), n, Sub(r, r_mid)); + V term = NegMulAdd(pi16_med, n, Sub(r_hi, r_med)); + V r_lo = MulAdd(pi16_lo, n, Sub(r, r_med)); r_lo = Sub(term, r_lo); // Step 4: Polynomial approximation @@ -411,8 +294,8 @@ HWY_INLINE V SmallArg(V x) { return result; } // NOLINTNEXTLINE(google-readability-namespace-comments) -} // namespace npsr::HWY_NAMESPACE::sincos +} // namespace npsr::HWY_NAMESPACE::trig HWY_AFTER_NAMESPACE(); -#endif // NPSR_TRIG_SMALL_INL_H_ +#endif // NPSR_TRIG_HIGH_INL_H_ diff --git a/npsr/trig/inl.h b/npsr/trig/inl.h index fa4e372..229c525 100644 --- a/npsr/trig/inl.h +++ b/npsr/trig/inl.h @@ -1,6 +1,7 @@ #include "npsr/common.h" -#include "npsr/trig/large-inl.h" -#include "npsr/trig/small-inl.h" +#include "npsr/trig/extended-inl.h" +#include "npsr/trig/high-inl.h" +#include "npsr/trig/low-inl.h" #if defined(NPSR_TRIG_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT #ifdef NPSR_TRIG_INL_H_ @@ -11,7 +12,7 @@ HWY_BEFORE_NAMESPACE(); -namespace npsr::HWY_NAMESPACE::sincos { +namespace npsr::HWY_NAMESPACE::trig { template HWY_API V SinCos(Prec &prec, V x) { using namespace hwy::HWY_NAMESPACE; @@ -19,16 +20,16 @@ HWY_API V SinCos(Prec &prec, V x) { const DFromV d; V ret; if constexpr (Prec::kLowAccuracy) { - ret = SmallArgLow(x); + ret = Low(x); } else { - ret = SmallArg(x); + ret = High(x); } if constexpr (Prec::kLargeArgument) { // Identify inputs requiring extended precision (very large arguments) auto has_large_arg = Gt(Abs(x), Set(d, kIsSingle ? 10000.0f : 16777216.0)); if (HWY_UNLIKELY(!AllFalse(d, has_large_arg))) { // Use extended precision algorithm for large arguments - ret = IfThenElse(has_large_arg, LargeArg(x), ret); + ret = IfThenElse(has_large_arg, Extended(x), ret); } } if constexpr (Prec::kSpecialCases || Prec::kExceptions) { @@ -40,16 +41,16 @@ HWY_API V SinCos(Prec &prec, V x) { } return ret; } -} // namespace npsr::HWY_NAMESPACE::sincos +} // namespace npsr::HWY_NAMESPACE::trig namespace npsr::HWY_NAMESPACE { template HWY_API V Sin(Prec &prec, V x) { - return sincos::SinCos(prec, x); + return trig::SinCos(prec, x); } template HWY_API V Cos(Prec &prec, V x) { - return sincos::SinCos(prec, x); + return trig::SinCos(prec, x); } } // namespace npsr::HWY_NAMESPACE diff --git a/npsr/trig/low-inl.h b/npsr/trig/low-inl.h new file mode 100644 index 0000000..e8cc815 --- /dev/null +++ b/npsr/trig/low-inl.h @@ -0,0 +1,151 @@ +#include "npsr/common.h" +#include "npsr/trig/data/data.h" +#include "npsr/utils-inl.h" + +#if defined(NPSR_TRIG_LOW_INL_H_) == defined(HWY_TARGET_TOGGLE) // NOLINT +#ifdef NPSR_TRIG_LOW_INL_H_ +#undef NPSR_TRIG_LOW_INL_H_ +#else +#define NPSR_TRIG_LOW_INL_H_ +#endif + +HWY_BEFORE_NAMESPACE(); + +namespace npsr::HWY_NAMESPACE::trig { + +template )> +HWY_API V PolyLow(V r, V r2) { + using namespace hn; + + const DFromV d; + const V c9 = Set(d, IS_COS ? 0x1.5d866ap-19f : 0x1.5dbdfp-19f); + const V c7 = Set(d, IS_COS ? -0x1.9f6d9ep-13 : -0x1.9f6ffep-13f); + const V c5 = Set(d, IS_COS ? 0x1.110ec8p-7 : 0x1.110eccp-7f); + const V c3 = Set(d, -0x1.55554cp-3f); + V poly = MulAdd(c9, r2, c7); + poly = MulAdd(r2, poly, c5); + poly = MulAdd(r2, poly, c3); + if constexpr (IS_COS) { + // Although this path handles cosine, we have already transformed the + // input using the identity: cos(x) = sin(x + π/2) This means we're no + // longer directly evaluating a cosine Taylor series; instead, we evaluate + // the sine approximation polynomial at (x + π/2). + // + // The sine approximation has the general form: + // sin(r) ≈ r + r³ · P(r²) + // + // So, we compute: + // r³ = r · r² + // sin(r) ≈ r + r³ · poly + // + // This formulation preserves accuracy by computing the highest order + // terms last, which benefits from FMA to reduce rounding error. + V r3 = Mul(r2, r); + poly = MulAdd(r3, poly, r); + } else { + poly = Mul(poly, r2); + poly = MulAdd(r, poly, r); + } + return poly; +} + +template )> +HWY_API V PolyLow(V r, V r2) { + using namespace hn; + + const DFromV d; + const V c15 = Set(d, -0x1.9f1517e9f65fp-41); + const V c13 = Set(d, 0x1.60e6bee01d83ep-33); + const V c11 = Set(d, -0x1.ae6355aaa4a53p-26); + const V c9 = Set(d, 0x1.71de3806add1ap-19); + const V c7 = Set(d, -0x1.a01a019a659ddp-13); + const V c5 = Set(d, 0x1.111111110a573p-7); + const V c3 = Set(d, -0x1.55555555554a8p-3); + V poly = MulAdd(c15, r2, c13); + poly = MulAdd(r2, poly, c11); + poly = MulAdd(r2, poly, c9); + poly = MulAdd(r2, poly, c7); + poly = MulAdd(r2, poly, c5); + poly = MulAdd(r2, poly, c3); + return poly; +} + +template +HWY_API V Low(V x) { + using namespace hn; + using hwy::SignMask; + namespace data = ::npsr::trig::data; + + const DFromV d; + const RebindToUnsigned du; + using T = TFromV; + // Load frequently used constants as vector registers + const V abs_mask = BitCast(d, Set(du, SignMask() - 1)); + const V x_abs = And(abs_mask, x); + const V x_sign = AndNot(x_abs, x); + + constexpr bool kIsSingle = std::is_same_v; + // Transform cosine to sine using identity: cos(x) = sin(x + π/2) + const V half_pi = Set(d, data::kHalfPi); + V x_trans = x_abs; + if constexpr (IS_COS) { + x_trans = Add(x_abs, half_pi); + } + // check zero input/subnormal for cosine (cos(~0) = 1) + const auto is_cos_near_zero = Eq(x_trans, half_pi); + + // Compute N = round(x/π) using "magic number" technique + // and stores integer part in mantissa + const V magic_round = Set(d, kIsSingle ? 0x1.8p23f : 0x1.8p52); + V n_biased = MulAdd(x_trans, Set(d, data::kInvPi), magic_round); + V n = Sub(n_biased, magic_round); + + // Adjust quotient for cosine (accounts for π/2 phase shift) + if constexpr (IS_COS) { + // For cosine, we computed N = round((x + π/2)/π) but need N' for x: + // N = round((x + π/2)/π) = round(x/π + 0.5) + // This is often 1 more than round(x/π), so we subtract 0.5: + // N' = N - 0.5 + n = Sub(n, Set(d, static_cast(0.5))); + } + // Use Cody-Waite method with triple-precision PI + constexpr auto kPi = data::kPi; + + V r = NegMulAdd(n, Set(d, kPi[0]), x_abs); + r = NegMulAdd(n, Set(d, kPi[1]), r); + V r_lo = NegMulAdd(n, Set(d, kPi[2]), r); + if constexpr (!kNativeFMA) { + if (!kIsSingle) { + r = r_lo; + } + r_lo = NegMulAdd(n, Set(d, kPi[3]), r_lo); + } + + if (kIsSingle) { + r = r_lo; + } + V r2 = Mul(r, r); + V poly = PolyLow(r, r2); + + if (!kIsSingle) { + V r2_corr = Mul(r2, r_lo); + poly = MulAdd(r2_corr, poly, r_lo); + } + + // Extract octant sign information from quotient and flip the sign bit + poly = Xor(poly, + BitCast(d, ShiftLeft(BitCast(du, n_biased)))); + if constexpr (IS_COS) { + poly = IfThenElse(is_cos_near_zero, Set(d, static_cast(1.0)), poly); + } else { + // Restore original sign for sine (odd function) + poly = Xor(poly, x_sign); + } + return poly; +} +// NOLINTNEXTLINE(google-readability-namespace-comments) +} // namespace npsr::HWY_NAMESPACE::trig + +HWY_AFTER_NAMESPACE(); + +#endif // NPSR_TRIG_LOW_INL_H_ diff --git a/npsr/trig/tests/__init__.py b/npsr/trig/tests/__init__.py deleted file mode 100644 index e69de29..0000000 diff --git a/npsr/trig/tests/data/__init__.py b/npsr/trig/tests/data/__init__.py deleted file mode 100644 index e69de29..0000000 diff --git a/npsr/trig/tests/data/large.py b/npsr/trig/tests/data/large.py deleted file mode 100644 index 2cd89cf..0000000 --- a/npsr/trig/tests/data/large.py +++ /dev/null @@ -1,12982 +0,0 @@ -from numpy_sr import Vec, bitcast, float32_t, float64_t, uint32_t, uint64_t - -sin_float64_t = [ - -################ chunk 0 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5434d, 0x4073a28c59d54329, 0x4083a28c59d5433b, 0x4083a28c59d5433b, 0x4083a28c59d5433b, - 0x4083a28c59d54344, 0x4083a28c59d54332, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4e1, 0x408d73d286bfe4d0, 0x4093a28c59d5433b, - 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433f, 0x4093a28c59d54337, 0x40988b2f704a940a, 0x40988b2f704a940a, 0x40988b2f704a940a, 0x40988b2f704a940e, - 0x40988b2f704a9405, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4dd, 0x409d73d286bfe4d4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, - 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad6, 0x40a12e3ace9a9ad1, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433d, 0x40a3a28c59d54339, - 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba5, 0x40a616dde50feba0, 0x40a88b2f704a940a, 0x40a88b2f704a940a, 0x40a88b2f704a940a, - 0x40a88b2f704a940c, 0x40a88b2f704a9408, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c73, 0x40aaff80fb853c6f, 0x40ad73d286bfe4d8, - 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4db, 0x40ad73d286bfe4d6, 0x40afe82411fa8d40, 0x40afe82411fa8d40, 0x40afe82411fa8d40, 0x40afe82411fa8d42, - 0x40afe82411fa8d3e, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad5, 0x40b12e3ace9a9ad2, 0x40b268639437ef07, 0x40b268639437ef07, - 0x40b268639437ef07, 0x40b268639437ef08, 0x40b268639437ef06, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433c, 0x40b3a28c59d5433a, - 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f729770, 0x40b4dcb51f72976e, 0x40b616dde50feba2, 0x40b616dde50feba2, 0x40b616dde50feba2, - 0x40b616dde50feba3, 0x40b616dde50feba1, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd7, 0x40b75106aaad3fd5, 0x40b88b2f704a940a, - 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940b, 0x40b88b2f704a9409, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, 0x40b9c55835e7e83e, - 0x40b9c55835e7e83c, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c72, 0x40baff80fb853c70, 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, - 0x40bc39a9c12290a5, 0x40bc39a9c12290a6, 0x40bc39a9c12290a4, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4da, 0x40bd73d286bfe4d7, - 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390d, 0x40beadfb4c5d390b, 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, - 0x40bfe82411fa8d41, 0x40bfe82411fa8d3f, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0b9, 0x40c12e3ace9a9ad4, - 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad3, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, 0x40c1cb4f316944ee, - 0x40c1cb4f316944ed, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef08, 0x40c268639437ef07, 0x40c30577f7069921, 0x40c30577f7069921, - 0x40c30577f7069921, 0x40c30577f7069922, 0x40c30577f7069921, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433c, 0x40c3a28c59d5433a, - 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed54, 0x40c4dcb51f72976f, 0x40c4dcb51f72976f, 0x40c4dcb51f72976f, - 0x40c4dcb51f72976f, 0x40c4dcb51f72976e, 0x40c579c982414188, 0x40c579c982414188, 0x40c579c982414188, 0x40c579c982414189, 0x40c579c982414188, 0x40c616dde50feba2, - 0x40c616dde50feba2, 0x40c616dde50feba2, 0x40c616dde50feba3, 0x40c616dde50feba2, 0x40c6b3f247de95bc, 0x40c6b3f247de95bc, 0x40c6b3f247de95bc, 0x40c6b3f247de95bd, - 0x40c6b3f247de95bc, 0x40c75106aaad3fd6, 0x40c75106aaad3fd6, 0x40c75106aaad3fd6, 0x40c75106aaad3fd7, 0x40c75106aaad3fd5, 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9f0, - 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9ef, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a9409, - 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e23, 0x40c9c55835e7e83d, 0x40c9c55835e7e83d, 0x40c9c55835e7e83d, - 0x40c9c55835e7e83e, 0x40c9c55835e7e83d, 0x40ca626c98b69257, 0x40ca626c98b69257, 0x40ca626c98b69257, 0x40ca626c98b69258, 0x40ca626c98b69257, 0x40caff80fb853c71, - 0x40caff80fb853c71, 0x40caff80fb853c71, 0x40caff80fb853c72, 0x40caff80fb853c71, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, - 0x40cb9c955e53e68a, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a4, 0x40ccd6be23f13abf, 0x40ccd6be23f13abf, - 0x40ccd6be23f13abf, 0x40ccd6be23f13abf, 0x40ccd6be23f13abe, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d9, 0x40cd73d286bfe4d8, - 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef3, 0x40ce10e6e98e8ef2, 0x40ceadfb4c5d390c, 0x40ceadfb4c5d390c, 0x40ceadfb4c5d390c, - 0x40ceadfb4c5d390d, 0x40ceadfb4c5d390c, 0x40cf4b0faf2be326, 0x40cf4b0faf2be326, 0x40cf4b0faf2be326, 0x40cf4b0faf2be327, 0x40cf4b0faf2be325, 0x40cfe82411fa8d40, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ce1b19140c0c0d5, 0x3ce1b19140c0c0d5, 0x3ce1b19140c0c0d5, 0x3d7208d8c8a06060, 0xbd71f727375f9fa0, 0x3cf1b19140c0c0d5, 0x3cf1b19140c0c0d5, 0x3cf1b19140c0c0d5, - 0x3d7211b19140c0c1, 0xbd71ee4e6ebf3f3f, 0xbd2caeb4c3dbdbd8, 0xbd2caeb4c3dbdbd8, 0xbd2caeb4c3dbdbd8, 0x3d711a8a59e12121, 0xbd70e575a61ededf, 0x3d01b19140c0c0d5, - 0x3d01b19140c0c0d5, 0x3d01b19140c0c0d5, 0x3d70236322818182, 0xbd6fb939bafcfcfd, 0x3d32c3beb21e1e21, 0x3d32c3beb21e1e21, 0x3d32c3beb21e1e21, 0x3d712c3beb21e1e2, - 0xbd72d3c414de1e1e, 0xbd3caeb4c3dbdbd8, 0xbd3caeb4c3dbdbd8, 0xbd3caeb4c3dbdbd8, 0x3d723514b3c24242, 0xbd71caeb4c3dbdbe, 0x3d49ef6be3151517, 0x3d49ef6be3151517, - 0x3d49ef6be3151517, 0x3d733ded7c62a2a3, 0xbd74c212839d5d5d, 0x3d11b19140c0c0d5, 0x3d11b19140c0c0d5, 0x3d11b19140c0c0d5, 0x3d7046c645030303, 0xbd6f727375f9f9f9, - 0xbd45830792e4e4e2, 0xbd45830792e4e4e2, 0xbd45830792e4e4e2, 0x3d754f9f0da36364, 0xbd72b060f25c9c9c, 0x3d42c3beb21e1e21, 0x3d42c3beb21e1e21, 0x3d42c3beb21e1e21, - 0x3d725877d643c3c4, 0xbd6b4f1053787878, 0xbd23d5ec237b7b6e, 0xbd23d5ec237b7b6e, 0xbd23d5ec237b7b6e, 0x3d6ec2a13dc84849, 0xbd709eaf611bdbdb, 0xbd4caeb4c3dbdbd8, - 0xbd4caeb4c3dbdbd8, 0xbd4caeb4c3dbdbd8, 0x3d746a2967848485, 0xbd7395d6987b7b7b, 0x3d373023024e4e57, 0x3d373023024e4e57, 0x3d373023024e4e57, 0x3d7173023024e4e5, - 0xbd6d19fb9fb63635, 0x3d59ef6be3151517, 0x3d59ef6be3151517, 0x3d59ef6be3151517, 0x3d767bdaf8c54546, 0xbd798425073ababa, 0xbd51ed30fa696967, 0xbd51ed30fa696967, - 0xbd51ed30fa696967, 0x3d67096782cb4b4c, 0xbd747b4c3e9a5a5a, 0x3d21b19140c0c0d5, 0x3d21b19140c0c0d5, 0x3d21b19140c0c0d5, 0x3d708d8c8a060607, 0xbd6ee4e6ebf3f3f3, - 0x3d5659954a99999c, 0x3d5659954a99999c, 0x3d5659954a99999c, 0x3d75966552a66667, 0xbd64d3355ab33332, 0xbd55830792e4e4e2, 0xbd55830792e4e4e2, 0xbd55830792e4e4e2, - 0x3d653e7c368d8d8f, 0xbd7560c1e4b93939, 0xbd15fa4706363606, 0xbd15fa4706363606, 0xbd15fa4706363606, 0x3d6f502dc7ce4e50, 0xbd7057e91c18d8d8, 0x3d52c3beb21e1e21, - 0x3d52c3beb21e1e21, 0x3d52c3beb21e1e21, 0x3d74b0efac878788, 0xbd669e20a6f0f0ef, 0xbd5918de2b60605d, 0xbd5918de2b60605d, 0xbd5918de2b60605d, 0x3d637390ea4fcfd1, - 0xbd7646378ad81817, 0xbd33d5ec237b7b6e, 0xbd33d5ec237b7b6e, 0xbd33d5ec237b7b6e, 0x3d6d85427b909092, 0xbd713d5ec237b7b7, 0x3d4e5bd03345454d, 0x3d4e5bd03345454d, - 0x3d4e5bd03345454d, 0x3d73cb7a0668a8aa, 0xbd68690bf32eaead, 0xbd5caeb4c3dbdbd8, 0xbd5caeb4c3dbdbd8, 0xbd5caeb4c3dbdbd8, 0x3d78d452cf09090a, 0xbd772bad30f6f6f6, - 0xbd4116a342b4b4ad, 0xbd4116a342b4b4ad, 0xbd4116a342b4b4ad, 0x3d6bba572f52d2d5, 0xbd7222d468569696, 0x3d473023024e4e57, 0x3d473023024e4e57, 0x3d473023024e4e57, - 0x3d72e6046049c9cb, 0xbd6a33f73f6c6c6a, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0xbd781122d715d5d5, 0x3d69ef6be3151517, - 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0xbd73084a0e757574, 0xbd6bfee28baa2a28, 0xbd6bfee28baa2a28, 0xbd6bfee28baa2a28, 0x3d72008eba2aeaec, - 0xbd6bfee28baa2a28, 0xbd61ed30fa696967, 0xbd61ed30fa696967, 0xbd61ed30fa696967, 0x3d77096782cb4b4c, 0xbd61ed30fa696967, 0xbd4f6dfda4a2a299, 0xbd4f6dfda4a2a299, - 0xbd4f6dfda4a2a299, 0x3d7c12404b6babad, 0xbd4f6dfda4a2a299, 0x3d31b19140c0c0d5, 0x3d31b19140c0c0d5, 0x3d31b19140c0c0d5, 0x3d808d8c8a060607, 0xbd7ee4e6ebf3f3f3, - 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0xbd79dc0e23539392, 0x3d6659954a99999c, 0x3d6659954a99999c, 0x3d6659954a99999c, - 0x3d6659954a99999c, 0xbd74d3355ab33332, 0xbd6f94b92425a5a3, 0xbd6f94b92425a5a3, 0xbd6f94b92425a5a3, 0x3d7035a36ded2d2f, 0xbd6f94b92425a5a3, 0xbd65830792e4e4e2, - 0xbd65830792e4e4e2, 0xbd65830792e4e4e2, 0x3d753e7c368d8d8f, 0xbd65830792e4e4e2, 0xbd56e2ac03484842, 0xbd56e2ac03484842, 0xbd56e2ac03484842, 0x3d7a4754ff2dedef, - 0xbd56e2ac03484842, 0xbd25fa4706363606, 0xbd25fa4706363606, 0xbd25fa4706363606, 0x3d7f502dc7ce4e50, 0xbd8057e91c18d8d8, 0x3d51641a41babac1, 0x3d51641a41babac1, - 0x3d51641a41babac1, 0x3d51641a41babac1, 0xbd7ba6f96f915150, 0x3d62c3beb21e1e21, 0x3d62c3beb21e1e21, 0x3d62c3beb21e1e21, 0x3d62c3beb21e1e21, 0xbd769e20a6f0f0ef, - 0x3d6cd570435edee2, 0x3d6cd570435edee2, 0x3d6cd570435edee2, 0x3d6cd570435edee2, 0xbd719547de50908f, 0xbd6918de2b60605d, 0xbd6918de2b60605d, 0xbd6918de2b60605d, - 0x3d737390ea4fcfd1, 0xbd6918de2b60605d, 0xbd5e0e59343f3f38, 0xbd5e0e59343f3f38, 0xbd5e0e59343f3f38, 0x3d787c69b2f03032, 0xbd5e0e59343f3f38, 0xbd43d5ec237b7b6e, - 0xbd43d5ec237b7b6e, 0xbd43d5ec237b7b6e, 0x3d7d85427b909092, 0xbd43d5ec237b7b6e, 0x3d4470da21878796, 0x3d4470da21878796, 0x3d4470da21878796, 0x3d4470da21878796, - 0xbd7d71e4bbcf0f0d, 0x3d5e5bd03345454d, 0x3d5e5bd03345454d, 0x3d5e5bd03345454d, 0x3d5e5bd03345454d, 0xbd78690bf32eaead, 0x3d693f99aae36367, 0x3d693f99aae36367, - 0x3d693f99aae36367, 0x3d693f99aae36367, 0xbd7360332a8e4e4c, 0xbd6caeb4c3dbdbd8, 0xbd6caeb4c3dbdbd8, 0xbd6caeb4c3dbdbd8, 0x3d71a8a59e121214, 0xbd6caeb4c3dbdbd8, - 0xbd629d03329b1b17, 0xbd629d03329b1b17, 0xbd629d03329b1b17, 0x3d76b17e66b27274, 0xbd629d03329b1b17, 0xbd5116a342b4b4ad, 0xbd5116a342b4b4ad, 0xbd5116a342b4b4ad, - 0x3d7bba572f52d2d5, 0xbd5116a342b4b4ad, 0x3d2865fefe6666a7, 0x3d2865fefe6666a7, 0x3d2865fefe6666a7, 0x3d806197fbf9999b, 0xbd7f3cd0080ccccb, 0x3d573023024e4e57, -] )) ), - -################ chunk 512 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40cfe82411fa8d40, 0x40cfe82411fa8d40, 0x40cfe82411fa8d40, 0x40cfe82411fa8d3f, 0x40d0429c3a649bad, 0x40d0429c3a649bad, 0x40d0429c3a649bad, 0x40d0429c3a649bad, - 0x40d0429c3a649bad, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0b9, 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c7, - 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c6, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad3, - 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe0, 0x40d1cb4f316944ed, 0x40d1cb4f316944ed, 0x40d1cb4f316944ed, - 0x40d1cb4f316944ee, 0x40d1cb4f316944ed, 0x40d219d962d099fa, 0x40d219d962d099fa, 0x40d219d962d099fa, 0x40d219d962d099fb, 0x40d219d962d099fa, 0x40d268639437ef07, - 0x40d268639437ef07, 0x40d268639437ef07, 0x40d268639437ef08, 0x40d268639437ef07, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, - 0x40d2b6edc59f4414, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d35402286dee2e, 0x40d35402286dee2e, - 0x40d35402286dee2e, 0x40d35402286dee2e, 0x40d35402286dee2e, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, - 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, - 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4261, 0x40d4dcb51f72976f, - 0x40d4dcb51f72976f, 0x40d4dcb51f72976f, 0x40d4dcb51f72976f, 0x40d4dcb51f72976e, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, - 0x40d52b3f50d9ec7b, 0x40d579c982414188, 0x40d579c982414188, 0x40d579c982414188, 0x40d579c982414189, 0x40d579c982414188, 0x40d5c853b3a89695, 0x40d5c853b3a89695, - 0x40d5c853b3a89695, 0x40d5c853b3a89696, 0x40d5c853b3a89695, 0x40d616dde50feba2, 0x40d616dde50feba2, 0x40d616dde50feba2, 0x40d616dde50feba3, 0x40d616dde50feba2, - 0x40d66568167740af, 0x40d66568167740af, 0x40d66568167740af, 0x40d66568167740b0, 0x40d66568167740af, 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, - 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d75106aaad3fd6, - 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, - 0x40d79f90dc1494e3, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, - 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a9409, - 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e916, 0x40d92843d3193e24, 0x40d92843d3193e24, 0x40d92843d3193e24, - 0x40d92843d3193e24, 0x40d92843d3193e23, 0x40d976ce04809330, 0x40d976ce04809330, 0x40d976ce04809330, 0x40d976ce04809331, 0x40d976ce04809330, 0x40d9c55835e7e83d, - 0x40d9c55835e7e83d, 0x40d9c55835e7e83d, 0x40d9c55835e7e83e, 0x40d9c55835e7e83d, 0x40da13e2674f3d4a, 0x40da13e2674f3d4a, 0x40da13e2674f3d4a, 0x40da13e2674f3d4b, - 0x40da13e2674f3d4a, 0x40da626c98b69257, 0x40da626c98b69257, 0x40da626c98b69257, 0x40da626c98b69258, 0x40da626c98b69257, 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, - 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, - 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db9c955e53e68b, 0x40db9c955e53e68b, 0x40db9c955e53e68b, - 0x40db9c955e53e68b, 0x40db9c955e53e68b, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dc39a9c12290a5, - 0x40dc39a9c12290a5, 0x40dc39a9c12290a5, 0x40dc39a9c12290a5, 0x40dc39a9c12290a4, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, - 0x40dc8833f289e5b1, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abe, 0x40dd254855588fcc, 0x40dd254855588fcc, - 0x40dd254855588fcc, 0x40dd254855588fcc, 0x40dd254855588fcb, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d9, 0x40dd73d286bfe4d8, - 0x40ddc25cb82739e5, 0x40ddc25cb82739e5, 0x40ddc25cb82739e5, 0x40ddc25cb82739e6, 0x40ddc25cb82739e5, 0x40de10e6e98e8ef2, 0x40de10e6e98e8ef2, 0x40de10e6e98e8ef2, - 0x40de10e6e98e8ef3, 0x40de10e6e98e8ef2, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40deadfb4c5d390c, - 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40defc857dc48e19, 0x40defc857dc48e19, 0x40defc857dc48e19, 0x40defc857dc48e19, - 0x40defc857dc48e19, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df9999e0933833, 0x40df9999e0933833, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d573023024e4e57, 0x3d573023024e4e57, 0x3d573023024e4e57, 0xbd7a33f73f6c6c6a, 0x3d65a9c31267e7ec, 0x3d65a9c31267e7ec, 0x3d65a9c31267e7ec, 0x3d65a9c31267e7ec, - 0x3d65a9c31267e7ec, 0x3d6fbb74a3a8a8ad, 0x3d6fbb74a3a8a8ad, 0x3d6fbb74a3a8a8ad, 0x3d6fbb74a3a8a8ad, 0xbd881122d715d5d5, 0x3d74e6931a74b4b7, 0x3d74e6931a74b4b7, - 0x3d74e6931a74b4b7, 0x3d74e6931a74b4b7, 0xbd858cb672c5a5a5, 0x3d79ef6be3151517, 0x3d79ef6be3151517, 0x3d79ef6be3151517, 0x3d79ef6be3151517, 0xbd83084a0e757574, - 0x3d7ef844abb57578, 0x3d7ef844abb57578, 0x3d7ef844abb57578, 0x3d7ef844abb57578, 0xbd8083ddaa254544, 0xbd7bfee28baa2a28, 0xbd7bfee28baa2a28, 0xbd7bfee28baa2a28, - 0x3d82008eba2aeaec, 0xbd7bfee28baa2a28, 0xbd76f609c309c9c7, 0xbd76f609c309c9c7, 0xbd76f609c309c9c7, 0x3d8484fb1e7b1b1c, 0xbd76f609c309c9c7, 0xbd71ed30fa696967, - 0xbd71ed30fa696967, 0xbd71ed30fa696967, 0x3d87096782cb4b4c, 0xbd71ed30fa696967, 0xbd69c8b06392120d, 0xbd69c8b06392120d, 0xbd69c8b06392120d, 0xbd69c8b06392120d, - 0xbd69c8b06392120d, 0xbd5f6dfda4a2a299, 0xbd5f6dfda4a2a299, 0xbd5f6dfda4a2a299, 0xbd5f6dfda4a2a299, 0xbd5f6dfda4a2a299, 0xbd4695350442422e, 0xbd4695350442422e, - 0xbd4695350442422e, 0xbd4695350442422e, 0xbd4695350442422e, 0x3d41b19140c0c0d5, 0x3d41b19140c0c0d5, 0x3d41b19140c0c0d5, 0x3d41b19140c0c0d5, 0x3d41b19140c0c0d5, - 0x3d5cfc2bc2e1e1ec, 0x3d5cfc2bc2e1e1ec, 0x3d5cfc2bc2e1e1ec, 0x3d5cfc2bc2e1e1ec, 0x3d5cfc2bc2e1e1ec, 0x3d688fc772b1b1b7, 0x3d688fc772b1b1b7, 0x3d688fc772b1b1b7, - 0x3d688fc772b1b1b7, 0x3d688fc772b1b1b7, 0x3d7150bc81f9393c, 0x3d7150bc81f9393c, 0x3d7150bc81f9393c, 0x3d7150bc81f9393c, 0xbd8757a1bf036362, 0x3d7659954a99999c, - 0x3d7659954a99999c, 0x3d7659954a99999c, 0x3d7659954a99999c, 0xbd84d3355ab33332, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, - 0xbd824ec8f6630302, 0xbd7f94b92425a5a3, 0xbd7f94b92425a5a3, 0xbd7f94b92425a5a3, 0x3d8035a36ded2d2f, 0xbd7f94b92425a5a3, 0xbd7a8be05b854542, 0xbd7a8be05b854542, - 0xbd7a8be05b854542, 0x3d82ba0fd23d5d5f, 0xbd7a8be05b854542, 0xbd75830792e4e4e2, 0xbd75830792e4e4e2, 0xbd75830792e4e4e2, 0x3d853e7c368d8d8f, 0xbd75830792e4e4e2, - 0xbd707a2eca448482, 0xbd707a2eca448482, 0xbd707a2eca448482, 0x3d87c2e89addbdbf, 0xbd707a2eca448482, 0xbd66e2ac03484842, 0xbd66e2ac03484842, 0xbd66e2ac03484842, - 0xbd66e2ac03484842, 0xbd66e2ac03484842, 0xbd59a1f4e40f0f03, 0xbd59a1f4e40f0f03, 0xbd59a1f4e40f0f03, 0xbd59a1f4e40f0f03, 0xbd59a1f4e40f0f03, 0xbd35fa4706363606, - 0xbd35fa4706363606, 0xbd35fa4706363606, 0xbd35fa4706363606, 0xbd35fa4706363606, 0x3d4d49a2c1e7e800, 0x3d4d49a2c1e7e800, 0x3d4d49a2c1e7e800, 0x3d4d49a2c1e7e800, - 0x3d4d49a2c1e7e800, 0x3d61641a41babac1, 0x3d61641a41babac1, 0x3d61641a41babac1, 0x3d61641a41babac1, 0x3d61641a41babac1, 0x3d6b75cbd2fb7b82, 0x3d6b75cbd2fb7b82, - 0x3d6b75cbd2fb7b82, 0x3d6b75cbd2fb7b82, 0x3d6b75cbd2fb7b82, 0x3d72c3beb21e1e21, 0x3d72c3beb21e1e21, 0x3d72c3beb21e1e21, 0x3d72c3beb21e1e21, 0xbd869e20a6f0f0ef, - 0x3d77cc977abe7e82, 0x3d77cc977abe7e82, 0x3d77cc977abe7e82, 0x3d77cc977abe7e82, 0xbd8419b442a0c0bf, 0x3d7cd570435edee2, 0x3d7cd570435edee2, 0x3d7cd570435edee2, - 0x3d7cd570435edee2, 0xbd819547de50908f, 0xbd7e21b6f400c0bd, 0xbd7e21b6f400c0bd, 0xbd7e21b6f400c0bd, 0x3d80ef2485ff9fa1, 0xbd7e21b6f400c0bd, 0xbd7918de2b60605d, - 0xbd7918de2b60605d, 0xbd7918de2b60605d, 0x3d837390ea4fcfd1, 0xbd7918de2b60605d, 0xbd74100562bffffd, 0xbd74100562bffffd, 0xbd74100562bffffd, 0x3d85f7fd4ea00002, - 0xbd74100562bffffd, 0xbd6e0e59343f3f38, 0xbd6e0e59343f3f38, 0xbd6e0e59343f3f38, 0x3d887c69b2f03032, 0xbd6e0e59343f3f38, 0xbd63fca7a2fe7e78, 0xbd63fca7a2fe7e78, - 0xbd63fca7a2fe7e78, 0xbd63fca7a2fe7e78, 0xbd63fca7a2fe7e78, 0xbd53d5ec237b7b6e, 0xbd53d5ec237b7b6e, 0xbd53d5ec237b7b6e, 0xbd53d5ec237b7b6e, 0xbd53d5ec237b7b6e, - 0x3cf35dbfc1818507, 0x3cf35dbfc1818507, 0x3cf35dbfc1818507, 0x3cf35dbfc1818507, 0x3cf35dbfc1818507, 0x3d5470da21878796, 0x3d5470da21878796, 0x3d5470da21878796, - 0x3d5470da21878796, 0x3d5470da21878796, 0x3d644a1ea204848c, 0x3d644a1ea204848c, 0x3d644a1ea204848c, 0x3d644a1ea204848c, 0x3d644a1ea204848c, 0x3d6e5bd03345454d, - 0x3d6e5bd03345454d, 0x3d6e5bd03345454d, 0x3d6e5bd03345454d, 0xbd88690bf32eaead, 0x3d7436c0e2430307, 0x3d7436c0e2430307, 0x3d7436c0e2430307, 0x3d7436c0e2430307, - 0xbd85e49f8ede7e7d, 0x3d793f99aae36367, 0x3d793f99aae36367, 0x3d793f99aae36367, 0x3d793f99aae36367, 0xbd8360332a8e4e4c, 0x3d7e48727383c3c8, 0x3d7e48727383c3c8, - 0x3d7e48727383c3c8, 0x3d7e48727383c3c8, 0xbd80dbc6c63e1e1c, 0xbd7caeb4c3dbdbd8, 0xbd7caeb4c3dbdbd8, 0xbd7caeb4c3dbdbd8, 0x3d81a8a59e121214, 0xbd7caeb4c3dbdbd8, - 0xbd77a5dbfb3b7b78, 0xbd77a5dbfb3b7b78, 0xbd77a5dbfb3b7b78, 0x3d842d1202624244, 0xbd77a5dbfb3b7b78, 0xbd729d03329b1b17, 0xbd729d03329b1b17, 0xbd729d03329b1b17, - 0x3d86b17e66b27274, 0xbd729d03329b1b17, 0xbd6b2854d3f5756e, 0xbd6b2854d3f5756e, 0xbd6b2854d3f5756e, 0xbd6b2854d3f5756e, 0xbd6b2854d3f5756e, 0xbd6116a342b4b4ad, - 0xbd6116a342b4b4ad, 0xbd6116a342b4b4ad, 0xbd6116a342b4b4ad, 0xbd6116a342b4b4ad, 0xbd4c13c6c5cfcfb0, 0xbd4c13c6c5cfcfb0, 0xbd4c13c6c5cfcfb0, 0xbd4c13c6c5cfcfb0, - 0xbd4c13c6c5cfcfb0, 0x3d3865fefe6666a7, 0x3d3865fefe6666a7, 0x3d3865fefe6666a7, 0x3d3865fefe6666a7, 0x3d3865fefe6666a7, 0x3d5a3ce2e21b1b2b, 0x3d5a3ce2e21b1b2b, -] )) ), - -################ chunk 1024 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40df9999e0933833, 0x40df9999e0933833, 0x40df9999e0933833, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, - 0x40e01b5721b0f126, 0x40e01b5721b0f126, 0x40e01b5721b0f126, 0x40e01b5721b0f127, 0x40e01b5721b0f126, 0x40e0429c3a649bad, 0x40e0429c3a649bad, 0x40e0429c3a649bad, - 0x40e0429c3a649bad, 0x40e0429c3a649bad, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e091266bcbf0ba, - 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, - 0x40e0b86b847f9b40, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, - 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad3, - 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e17cc50001efe1, 0x40e17cc50001efe1, 0x40e17cc50001efe1, - 0x40e17cc50001efe1, 0x40e17cc50001efe0, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1cb4f316944ed, - 0x40e1cb4f316944ed, 0x40e1cb4f316944ed, 0x40e1cb4f316944ee, 0x40e1cb4f316944ed, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, - 0x40e1f2944a1cef74, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e2411e7b844481, 0x40e2411e7b844481, - 0x40e2411e7b844481, 0x40e2411e7b844481, 0x40e2411e7b844481, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, - 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, - 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e30577f7069921, - 0x40e30577f7069921, 0x40e30577f7069921, 0x40e30577f7069921, 0x40e30577f7069921, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, - 0x40e32cbd0fba43a7, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e37b47412198b5, 0x40e37b47412198b5, - 0x40e37b47412198b5, 0x40e37b47412198b5, 0x40e37b47412198b4, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, - 0x40e3c9d17288edc1, 0x40e3c9d17288edc1, 0x40e3c9d17288edc1, 0x40e3c9d17288edc2, 0x40e3c9d17288edc1, 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, - 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e43fa0bca3ed55, - 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e466e5d55797db, 0x40e466e5d55797db, 0x40e466e5d55797db, 0x40e466e5d55797db, - 0x40e466e5d55797db, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e4b57006beece8, 0x40e4b57006beece8, - 0x40e4b57006beece8, 0x40e4b57006beece8, 0x40e4b57006beece8, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, - 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7c, - 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7b, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e579c982414188, - 0x40e579c982414188, 0x40e579c982414188, 0x40e579c982414189, 0x40e579c982414188, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, - 0x40e5a10e9af4ec0f, 0x40e5c853b3a89695, 0x40e5c853b3a89695, 0x40e5c853b3a89695, 0x40e5c853b3a89696, 0x40e5c853b3a89695, 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, - 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, - 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e66568167740af, 0x40e66568167740af, 0x40e66568167740af, - 0x40e66568167740af, 0x40e66568167740af, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e6b3f247de95bc, - 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6db3760924043, 0x40e6db3760924043, 0x40e6db3760924043, 0x40e6db3760924043, - 0x40e6db3760924043, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e729c191f99550, 0x40e729c191f99550, - 0x40e729c191f99550, 0x40e729c191f99550, 0x40e729c191f9954f, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, - 0x40e7784bc360ea5c, 0x40e7784bc360ea5c, 0x40e7784bc360ea5c, 0x40e7784bc360ea5d, 0x40e7784bc360ea5c, 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d5a3ce2e21b1b2b, 0x3d5a3ce2e21b1b2b, 0x3d5a3ce2e21b1b2b, 0x3d673023024e4e57, 0x3d673023024e4e57, 0x3d673023024e4e57, 0x3d673023024e4e57, 0x3d673023024e4e57, - 0xbd87af8adb1c3c3a, 0xbd87af8adb1c3c3a, 0xbd87af8adb1c3c3a, 0x3d94283a9271e1e3, 0xbd87af8adb1c3c3a, 0x3d75a9c31267e7ec, 0x3d75a9c31267e7ec, 0x3d75a9c31267e7ec, - 0x3d75a9c31267e7ec, 0x3d75a9c31267e7ec, 0xbd82a6b2127bdbda, 0xbd82a6b2127bdbda, 0xbd82a6b2127bdbda, 0xbd82a6b2127bdbda, 0xbd82a6b2127bdbda, 0x3d7fbb74a3a8a8ad, - 0x3d7fbb74a3a8a8ad, 0x3d7fbb74a3a8a8ad, 0x3d7fbb74a3a8a8ad, 0x3d7fbb74a3a8a8ad, 0xbd7b3bb293b6f6f3, 0xbd7b3bb293b6f6f3, 0xbd7b3bb293b6f6f3, 0xbd7b3bb293b6f6f3, - 0xbd7b3bb293b6f6f3, 0x3d84e6931a74b4b7, 0x3d84e6931a74b4b7, 0x3d84e6931a74b4b7, 0x3d84e6931a74b4b7, 0x3d84e6931a74b4b7, 0xbd712a0102763632, 0xbd712a0102763632, - 0xbd712a0102763632, 0xbd712a0102763632, 0xbd712a0102763632, 0x3d89ef6be3151517, 0x3d89ef6be3151517, 0x3d89ef6be3151517, 0x3d89ef6be3151517, 0xbd93084a0e757574, - 0xbd5c613dc4d5d5c4, 0xbd5c613dc4d5d5c4, 0xbd5c613dc4d5d5c4, 0xbd5c613dc4d5d5c4, 0xbd5c613dc4d5d5c4, 0x3d8ef844abb57578, 0x3d8ef844abb57578, 0x3d8ef844abb57578, - 0x3d8ef844abb57578, 0xbd9083ddaa254544, 0x3d47cb11005a5a7f, 0x3d47cb11005a5a7f, 0x3d47cb11005a5a7f, 0x3d47cb11005a5a7f, 0x3d47cb11005a5a7f, 0xbd8bfee28baa2a28, - 0xbd8bfee28baa2a28, 0xbd8bfee28baa2a28, 0x3d92008eba2aeaec, 0xbd8bfee28baa2a28, 0x3d6a162762981821, 0x3d6a162762981821, 0x3d6a162762981821, 0x3d6a162762981821, - 0x3d6a162762981821, 0xbd86f609c309c9c7, 0xbd86f609c309c9c7, 0xbd86f609c309c9c7, 0xbd86f609c309c9c7, 0xbd86f609c309c9c7, 0x3d771cc5428cccd2, 0x3d771cc5428cccd2, - 0x3d771cc5428cccd2, 0x3d771cc5428cccd2, 0x3d771cc5428cccd2, 0xbd81ed30fa696967, 0xbd81ed30fa696967, 0xbd81ed30fa696967, 0xbd81ed30fa696967, 0xbd81ed30fa696967, - 0x3d80973b69e6c6c9, 0x3d80973b69e6c6c9, 0x3d80973b69e6c6c9, 0x3d80973b69e6c6c9, 0x3d80973b69e6c6c9, 0xbd79c8b06392120d, 0xbd79c8b06392120d, 0xbd79c8b06392120d, - 0xbd79c8b06392120d, 0xbd79c8b06392120d, 0x3d85a0143287272a, 0x3d85a0143287272a, 0x3d85a0143287272a, 0x3d85a0143287272a, 0x3d85a0143287272a, 0xbd6f6dfda4a2a299, - 0xbd6f6dfda4a2a299, 0xbd6f6dfda4a2a299, 0xbd6f6dfda4a2a299, 0xbd6f6dfda4a2a299, 0x3d8aa8ecfb27878a, 0x3d8aa8ecfb27878a, 0x3d8aa8ecfb27878a, 0x3d8aa8ecfb27878a, - 0xbd92ab89826c3c3b, 0xbd5695350442422e, 0xbd5695350442422e, 0xbd5695350442422e, 0xbd5695350442422e, 0xbd5695350442422e, 0x3d8fb1c5c3c7e7ea, 0x3d8fb1c5c3c7e7ea, - 0x3d8fb1c5c3c7e7ea, 0x3d8fb1c5c3c7e7ea, 0xbd90271d1e1c0c0b, 0x3d51b19140c0c0d5, 0x3d51b19140c0c0d5, 0x3d51b19140c0c0d5, 0x3d51b19140c0c0d5, 0x3d51b19140c0c0d5, - 0xbd8b45617397b7b5, 0xbd8b45617397b7b5, 0xbd8b45617397b7b5, 0x3d925d4f46342425, 0xbd8b45617397b7b5, 0x3d6cfc2bc2e1e1ec, 0x3d6cfc2bc2e1e1ec, 0x3d6cfc2bc2e1e1ec, - 0x3d6cfc2bc2e1e1ec, 0x3d6cfc2bc2e1e1ec, 0xbd863c88aaf75755, 0xbd863c88aaf75755, 0xbd863c88aaf75755, 0xbd863c88aaf75755, 0xbd863c88aaf75755, 0x3d788fc772b1b1b7, - 0x3d788fc772b1b1b7, 0x3d788fc772b1b1b7, 0x3d788fc772b1b1b7, 0x3d788fc772b1b1b7, 0xbd8133afe256f6f4, 0xbd8133afe256f6f4, 0xbd8133afe256f6f4, 0xbd8133afe256f6f4, - 0xbd8133afe256f6f4, 0x3d8150bc81f9393c, 0x3d8150bc81f9393c, 0x3d8150bc81f9393c, 0x3d8150bc81f9393c, 0x3d8150bc81f9393c, 0xbd7855ae336d2d28, 0xbd7855ae336d2d28, - 0xbd7855ae336d2d28, 0xbd7855ae336d2d28, 0xbd7855ae336d2d28, 0x3d8659954a99999c, 0x3d8659954a99999c, 0x3d8659954a99999c, 0x3d8659954a99999c, 0x3d8659954a99999c, - 0xbd6c87f94458d8ce, 0xbd6c87f94458d8ce, 0xbd6c87f94458d8ce, 0xbd6c87f94458d8ce, 0xbd6c87f94458d8ce, 0x3d8b626e1339f9fd, 0x3d8b626e1339f9fd, 0x3d8b626e1339f9fd, - 0x3d8b626e1339f9fd, 0xbd924ec8f6630302, 0xbd50c92c43aeae99, 0xbd50c92c43aeae99, 0xbd50c92c43aeae99, 0xbd50c92c43aeae99, 0xbd50c92c43aeae99, 0xbd8f94b92425a5a3, - 0xbd8f94b92425a5a3, 0xbd8f94b92425a5a3, 0x3d9035a36ded2d2f, 0xbd8f94b92425a5a3, 0x3d577d9a0154546b, 0x3d577d9a0154546b, 0x3d577d9a0154546b, 0x3d577d9a0154546b, - 0x3d577d9a0154546b, 0xbd8a8be05b854542, 0xbd8a8be05b854542, 0xbd8a8be05b854542, 0x3d92ba0fd23d5d5f, 0xbd8a8be05b854542, 0x3d6fe230232babb7, 0x3d6fe230232babb7, - 0x3d6fe230232babb7, 0x3d6fe230232babb7, 0x3d6fe230232babb7, 0xbd85830792e4e4e2, 0xbd85830792e4e4e2, 0xbd85830792e4e4e2, 0xbd85830792e4e4e2, 0xbd85830792e4e4e2, - 0x3d7a02c9a2d6969c, 0x3d7a02c9a2d6969c, 0x3d7a02c9a2d6969c, 0x3d7a02c9a2d6969c, 0x3d7a02c9a2d6969c, 0xbd807a2eca448482, 0xbd807a2eca448482, 0xbd807a2eca448482, - 0xbd807a2eca448482, 0xbd807a2eca448482, 0x3d820a3d9a0babaf, 0x3d820a3d9a0babaf, 0x3d820a3d9a0babaf, 0x3d820a3d9a0babaf, 0x3d820a3d9a0babaf, 0xbd76e2ac03484842, - 0xbd76e2ac03484842, 0xbd76e2ac03484842, 0xbd76e2ac03484842, 0xbd76e2ac03484842, 0x3d87131662ac0c0f, 0x3d87131662ac0c0f, 0x3d87131662ac0c0f, 0x3d87131662ac0c0f, - 0x3d87131662ac0c0f, 0xbd69a1f4e40f0f03, 0xbd69a1f4e40f0f03, 0xbd69a1f4e40f0f03, 0xbd69a1f4e40f0f03, 0xbd69a1f4e40f0f03, 0x3d8c1bef2b4c6c6f, 0x3d8c1bef2b4c6c6f, - 0x3d8c1bef2b4c6c6f, 0x3d8c1bef2b4c6c6f, 0xbd91f2086a59c9c8, 0xbd45fa4706363606, 0xbd45fa4706363606, 0xbd45fa4706363606, 0xbd45fa4706363606, 0xbd45fa4706363606, - 0xbd8edb380c133330, 0xbd8edb380c133330, 0xbd8edb380c133330, 0x3d909263f9f66668, 0xbd8edb380c133330, 0x3d5d49a2c1e7e800, 0x3d5d49a2c1e7e800, 0x3d5d49a2c1e7e800, -] )) ), - -################ chunk 1536 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f6a, 0x40e7c6d5f4c83f69, 0x40e7ee1b0d7be9f0, - 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e81560262f9476, 0x40e81560262f9476, 0x40e81560262f9476, 0x40e81560262f9476, - 0x40e81560262f9476, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e863ea5796e983, 0x40e863ea5796e983, - 0x40e863ea5796e983, 0x40e863ea5796e983, 0x40e863ea5796e983, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, - 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e917, - 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e916, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e92843d3193e24, - 0x40e92843d3193e24, 0x40e92843d3193e24, 0x40e92843d3193e24, 0x40e92843d3193e23, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, - 0x40e94f88ebcce8aa, 0x40e976ce04809330, 0x40e976ce04809330, 0x40e976ce04809330, 0x40e976ce04809331, 0x40e976ce04809330, 0x40e99e131d343db7, 0x40e99e131d343db7, - 0x40e99e131d343db7, 0x40e99e131d343db7, 0x40e99e131d343db7, 0x40e9c55835e7e83d, 0x40e9c55835e7e83d, 0x40e9c55835e7e83d, 0x40e9c55835e7e83e, 0x40e9c55835e7e83d, - 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, - 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea626c98b69257, - 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, - 0x40ea89b1b16a3cde, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40ead83be2d191eb, 0x40ead83be2d191eb, - 0x40ead83be2d191eb, 0x40ead83be2d191eb, 0x40ead83be2d191ea, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, - 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f7, 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, - 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, 0x40eb755045a03c04, 0x40eb755045a03c04, 0x40eb755045a03c04, 0x40eb755045a03c05, 0x40eb755045a03c04, 0x40eb9c955e53e68b, - 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40ebc3da77079111, 0x40ebc3da77079111, 0x40ebc3da77079111, 0x40ebc3da77079112, - 0x40ebc3da77079111, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, - 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, - 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, - 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecd6be23f13abf, - 0x40ecd6be23f13abf, 0x40ecd6be23f13abf, 0x40ecd6be23f13abf, 0x40ecd6be23f13abe, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, - 0x40ecfe033ca4e545, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcb, 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, - 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d9, 0x40ed73d286bfe4d8, - 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40edc25cb82739e5, 0x40edc25cb82739e5, 0x40edc25cb82739e5, - 0x40edc25cb82739e6, 0x40edc25cb82739e5, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ee10e6e98e8ef2, - 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee382c02423979, 0x40ee382c02423979, 0x40ee382c02423979, 0x40ee382c02423979, - 0x40ee382c02423979, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee86b633a98e86, 0x40ee86b633a98e86, - 0x40ee86b633a98e86, 0x40ee86b633a98e86, 0x40ee86b633a98e86, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, - 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e392, 0x40eefc857dc48e19, 0x40eefc857dc48e19, 0x40eefc857dc48e19, - 0x40eefc857dc48e19, 0x40eefc857dc48e19, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca9678389f, 0x40ef4b0faf2be326, - 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef7254c7df8dac, 0x40ef7254c7df8dac, 0x40ef7254c7df8dac, 0x40ef7254c7df8dad, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d5d49a2c1e7e800, 0x3d5d49a2c1e7e800, 0xbd89d25f4372d2d0, 0xbd89d25f4372d2d0, 0xbd89d25f4372d2d0, 0x3d9316d05e469698, 0xbd89d25f4372d2d0, 0x3d71641a41babac1, - 0x3d71641a41babac1, 0x3d71641a41babac1, 0x3d71641a41babac1, 0x3d71641a41babac1, 0xbd84c9867ad2726f, 0xbd84c9867ad2726f, 0xbd84c9867ad2726f, 0xbd84c9867ad2726f, - 0xbd84c9867ad2726f, 0x3d7b75cbd2fb7b82, 0x3d7b75cbd2fb7b82, 0x3d7b75cbd2fb7b82, 0x3d7b75cbd2fb7b82, 0x3d7b75cbd2fb7b82, 0xbd7f815b6464241e, 0xbd7f815b6464241e, - 0xbd7f815b6464241e, 0xbd7f815b6464241e, 0xbd7f815b6464241e, 0x3d82c3beb21e1e21, 0x3d82c3beb21e1e21, 0x3d82c3beb21e1e21, 0x3d82c3beb21e1e21, 0x3d82c3beb21e1e21, - 0xbd756fa9d323635d, 0xbd756fa9d323635d, 0xbd756fa9d323635d, 0xbd756fa9d323635d, 0xbd756fa9d323635d, 0x3d87cc977abe7e82, 0x3d87cc977abe7e82, 0x3d87cc977abe7e82, - 0x3d87cc977abe7e82, 0xbd9419b442a0c0bf, 0xbd66bbf083c54538, 0xbd66bbf083c54538, 0xbd66bbf083c54538, 0xbd66bbf083c54538, 0xbd66bbf083c54538, 0x3d8cd570435edee2, - 0x3d8cd570435edee2, 0x3d8cd570435edee2, 0x3d8cd570435edee2, 0xbd919547de50908f, 0xbd34c46b0a1e1db6, 0xbd34c46b0a1e1db6, 0xbd34c46b0a1e1db6, 0xbd34c46b0a1e1db6, - 0xbd34c46b0a1e1db6, 0xbd8e21b6f400c0bd, 0xbd8e21b6f400c0bd, 0xbd8e21b6f400c0bd, 0x3d90ef2485ff9fa1, 0xbd8e21b6f400c0bd, 0x3d618ad5c13dbdcb, 0x3d618ad5c13dbdcb, - 0x3d618ad5c13dbdcb, 0x3d618ad5c13dbdcb, 0x3d618ad5c13dbdcb, 0xbd8918de2b60605d, 0xbd8918de2b60605d, 0xbd8918de2b60605d, 0x3d937390ea4fcfd1, 0xbd8918de2b60605d, - 0x3d72d71c71df9fa6, 0x3d72d71c71df9fa6, 0x3d72d71c71df9fa6, 0x3d72d71c71df9fa6, 0x3d72d71c71df9fa6, 0xbd84100562bffffd, 0xbd84100562bffffd, 0xbd84100562bffffd, - 0xbd84100562bffffd, 0xbd84100562bffffd, 0x3d7ce8ce03206067, 0x3d7ce8ce03206067, 0x3d7ce8ce03206067, 0x3d7ce8ce03206067, 0x3d7ce8ce03206067, 0xbd7e0e59343f3f38, - 0xbd7e0e59343f3f38, 0xbd7e0e59343f3f38, 0xbd7e0e59343f3f38, 0xbd7e0e59343f3f38, 0x3d837d3fca309094, 0x3d837d3fca309094, 0x3d837d3fca309094, 0x3d837d3fca309094, - 0x3d837d3fca309094, 0xbd73fca7a2fe7e78, 0xbd73fca7a2fe7e78, 0xbd73fca7a2fe7e78, 0xbd73fca7a2fe7e78, 0xbd73fca7a2fe7e78, 0x3d88861892d0f0f4, 0x3d88861892d0f0f4, - 0x3d88861892d0f0f4, 0x3d88861892d0f0f4, 0xbd93bcf3b6978786, 0xbd63d5ec237b7b6e, 0xbd63d5ec237b7b6e, 0xbd63d5ec237b7b6e, 0xbd63d5ec237b7b6e, 0xbd63d5ec237b7b6e, - 0x3d8d8ef15b715155, 0x3d8d8ef15b715155, 0x3d8d8ef15b715155, 0x3d8d8ef15b715155, 0xbd91388752475756, 0x3d035dbfc1818507, 0x3d035dbfc1818507, 0x3d035dbfc1818507, - 0x3d035dbfc1818507, 0x3d035dbfc1818507, 0xbd8d6835dbee4e4b, 0xbd8d6835dbee4e4b, 0xbd8d6835dbee4e4b, 0x3d914be51208d8db, 0xbd8d6835dbee4e4b, 0x3d6470da21878796, - 0x3d6470da21878796, 0x3d6470da21878796, 0x3d6470da21878796, 0x3d6470da21878796, 0xbd885f5d134dedea, 0xbd885f5d134dedea, 0xbd885f5d134dedea, 0x3d93d0517659090b, - 0xbd885f5d134dedea, 0x3d744a1ea204848c, 0x3d744a1ea204848c, 0x3d744a1ea204848c, 0x3d744a1ea204848c, 0x3d744a1ea204848c, 0xbd8356844aad8d8a, 0xbd8356844aad8d8a, - 0xbd8356844aad8d8a, 0xbd8356844aad8d8a, 0xbd8356844aad8d8a, 0x3d7e5bd03345454d, 0x3d7e5bd03345454d, 0x3d7e5bd03345454d, 0x3d7e5bd03345454d, 0x3d7e5bd03345454d, - 0xbd7c9b57041a5a53, 0xbd7c9b57041a5a53, 0xbd7c9b57041a5a53, 0xbd7c9b57041a5a53, 0xbd7c9b57041a5a53, 0x3d8436c0e2430307, 0x3d8436c0e2430307, 0x3d8436c0e2430307, - 0x3d8436c0e2430307, 0x3d8436c0e2430307, 0xbd7289a572d99992, 0xbd7289a572d99992, 0xbd7289a572d99992, 0xbd7289a572d99992, 0xbd7289a572d99992, 0x3d893f99aae36367, - 0x3d893f99aae36367, 0x3d893f99aae36367, 0x3d893f99aae36367, 0xbd9360332a8e4e4c, 0xbd60efe7c331b1a3, 0xbd60efe7c331b1a3, 0xbd60efe7c331b1a3, 0xbd60efe7c331b1a3, - 0xbd60efe7c331b1a3, 0x3d8e48727383c3c8, 0x3d8e48727383c3c8, 0x3d8e48727383c3c8, 0x3d8e48727383c3c8, 0xbd90dbc6c63e1e1c, 0x3d399bdafa7e7ef7, 0x3d399bdafa7e7ef7, - 0x3d399bdafa7e7ef7, 0x3d399bdafa7e7ef7, 0x3d399bdafa7e7ef7, 0xbd8caeb4c3dbdbd8, 0xbd8caeb4c3dbdbd8, 0xbd8caeb4c3dbdbd8, 0x3d91a8a59e121214, 0xbd8caeb4c3dbdbd8, - 0x3d6756de81d15161, 0x3d6756de81d15161, 0x3d6756de81d15161, 0x3d6756de81d15161, 0x3d6756de81d15161, 0xbd87a5dbfb3b7b78, 0xbd87a5dbfb3b7b78, 0xbd87a5dbfb3b7b78, - 0x3d942d1202624244, 0xbd87a5dbfb3b7b78, 0x3d75bd20d2296971, 0x3d75bd20d2296971, 0x3d75bd20d2296971, 0x3d75bd20d2296971, 0x3d75bd20d2296971, 0xbd829d03329b1b17, - 0xbd829d03329b1b17, 0xbd829d03329b1b17, 0xbd829d03329b1b17, 0xbd829d03329b1b17, 0x3d7fced2636a2a32, 0x3d7fced2636a2a32, 0x3d7fced2636a2a32, 0x3d7fced2636a2a32, - 0x3d7fced2636a2a32, 0xbd7b2854d3f5756e, 0xbd7b2854d3f5756e, 0xbd7b2854d3f5756e, 0xbd7b2854d3f5756e, 0xbd7b2854d3f5756e, 0x3d84f041fa557579, 0x3d84f041fa557579, - 0x3d84f041fa557579, 0x3d84f041fa557579, 0x3d84f041fa557579, 0xbd7116a342b4b4ad, 0xbd7116a342b4b4ad, 0xbd7116a342b4b4ad, 0xbd7116a342b4b4ad, 0xbd7116a342b4b4ad, - 0x3d89f91ac2f5d5da, 0x3d89f91ac2f5d5da, 0x3d89f91ac2f5d5da, 0x3d89f91ac2f5d5da, 0xbd9303729e851513, 0xbd5c13c6c5cfcfb0, 0xbd5c13c6c5cfcfb0, 0xbd5c13c6c5cfcfb0, - 0xbd5c13c6c5cfcfb0, 0xbd5c13c6c5cfcfb0, 0x3d8f01f38b96363a, 0x3d8f01f38b96363a, 0x3d8f01f38b96363a, 0x3d8f01f38b96363a, 0xbd907f063a34e4e3, 0x3d4865fefe6666a7, - 0x3d4865fefe6666a7, 0x3d4865fefe6666a7, 0x3d4865fefe6666a7, 0x3d4865fefe6666a7, 0xbd8bf533abc96965, 0xbd8bf533abc96965, 0xbd8bf533abc96965, 0x3d9205662a1b4b4d, -] )) ), - -################ chunk 2048 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40ef7254c7df8dac, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40efc0def946e2b9, 0x40efc0def946e2b9, - 0x40efc0def946e2b9, 0x40efc0def946e2b9, 0x40efc0def946e2b9, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, - 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f01b5721b0f126, 0x40f01b5721b0f126, 0x40f01b5721b0f126, - 0x40f01b5721b0f126, 0x40f01b5721b0f126, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f0429c3a649bad, - 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, - 0x40f0563ec6be70f0, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f07d83df721b77, 0x40f07d83df721b77, - 0x40f07d83df721b77, 0x40f07d83df721b77, 0x40f07d83df721b76, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, - 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, - 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, 0x40f0cc0e10d97083, 0x40f0cc0e10d97083, 0x40f0cc0e10d97083, 0x40f0cc0e10d97084, 0x40f0cc0e10d97083, 0x40f0dfb09d3345c7, - 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, - 0x40f0f353298d1b0a, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f11a984240c590, 0x40f11a984240c590, - 0x40f11a984240c590, 0x40f11a984240c590, 0x40f11a984240c590, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, - 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f1557fe74e455a, 0x40f1557fe74e455a, 0x40f1557fe74e455a, - 0x40f1557fe74e455a, 0x40f1557fe74e455a, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f17cc50001efe1, - 0x40f17cc50001efe1, 0x40f17cc50001efe1, 0x40f17cc50001efe1, 0x40f17cc50001efe0, 0x40f190678c5bc524, 0x40f190678c5bc524, 0x40f190678c5bc524, 0x40f190678c5bc524, - 0x40f190678c5bc524, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, - 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, 0x40f1cb4f316944ed, 0x40f1cb4f316944ed, 0x40f1cb4f316944ed, 0x40f1cb4f316944ee, 0x40f1cb4f316944ed, - 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, - 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f219d962d099fa, - 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, - 0x40f22d7bef2a6f3e, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f254c107de19c4, 0x40f254c107de19c4, - 0x40f254c107de19c4, 0x40f254c107de19c4, 0x40f254c107de19c4, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, - 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44a, 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, - 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2b6edc59f4414, - 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2ca9051f91957, 0x40f2ca9051f91957, 0x40f2ca9051f91957, 0x40f2ca9051f91958, - 0x40f2ca9051f91957, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, - 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, - 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, - 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f35402286dee2e, - 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, - 0x40f367a4b4c7c371, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b4, 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, - 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbd8bf533abc96965, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0xbd86ec5ae3290905, 0xbd86ec5ae3290905, - 0xbd86ec5ae3290905, 0xbd86ec5ae3290905, 0xbd86ec5ae3290905, 0x3d773023024e4e57, 0x3d773023024e4e57, 0x3d773023024e4e57, 0x3d773023024e4e57, 0x3d773023024e4e57, - 0xbd81e3821a88a8a5, 0xbd81e3821a88a8a5, 0xbd81e3821a88a8a5, 0xbd81e3821a88a8a5, 0xbd81e3821a88a8a5, 0xbd97af8adb1c3c3a, 0xbd97af8adb1c3c3a, 0xbd97af8adb1c3c3a, - 0xbd97af8adb1c3c3a, 0xbd97af8adb1c3c3a, 0x3d9992ab570bdbde, 0x3d9992ab570bdbde, 0x3d9992ab570bdbde, 0x3d9992ab570bdbde, 0x3d9992ab570bdbde, 0x3d85a9c31267e7ec, - 0x3d85a9c31267e7ec, 0x3d85a9c31267e7ec, 0x3d85a9c31267e7ec, 0x3d85a9c31267e7ec, 0xbd6f4742251f9f8f, 0xbd6f4742251f9f8f, 0xbd6f4742251f9f8f, 0xbd6f4742251f9f8f, - 0xbd6f4742251f9f8f, 0xbd92a6b2127bdbda, 0xbd92a6b2127bdbda, 0xbd92a6b2127bdbda, 0xbd92a6b2127bdbda, 0xbd92a6b2127bdbda, 0x3d9e9b841fac3c3e, 0x3d9e9b841fac3c3e, - 0x3d9e9b841fac3c3e, 0x3d9e9b841fac3c3e, 0xbda0b23df029e1e1, 0x3d8fbb74a3a8a8ad, 0x3d8fbb74a3a8a8ad, 0x3d8fbb74a3a8a8ad, 0x3d8fbb74a3a8a8ad, 0x3d8fbb74a3a8a8ad, - 0x3d51ff083fc6c6e9, 0x3d51ff083fc6c6e9, 0x3d51ff083fc6c6e9, 0x3d51ff083fc6c6e9, 0x3d51ff083fc6c6e9, 0xbd8b3bb293b6f6f3, 0xbd8b3bb293b6f6f3, 0xbd8b3bb293b6f6f3, - 0xbd8b3bb293b6f6f3, 0xbd8b3bb293b6f6f3, 0xbd9c5ba317b36361, 0xbd9c5ba317b36361, 0xbd9c5ba317b36361, 0x3da1d22e74264e4f, 0xbd9c5ba317b36361, 0x3d94e6931a74b4b7, - 0x3d94e6931a74b4b7, 0x3d94e6931a74b4b7, 0x3d94e6931a74b4b7, 0x3d94e6931a74b4b7, 0x3d78a3253273333c, 0x3d78a3253273333c, 0x3d78a3253273333c, 0x3d78a3253273333c, - 0x3d78a3253273333c, 0xbd812a0102763632, 0xbd812a0102763632, 0xbd812a0102763632, 0xbd812a0102763632, 0xbd812a0102763632, 0xbd9752ca4f130301, 0xbd9752ca4f130301, - 0xbd9752ca4f130301, 0xbd9752ca4f130301, 0xbd9752ca4f130301, 0x3d99ef6be3151517, 0x3d99ef6be3151517, 0x3d99ef6be3151517, 0x3d99ef6be3151517, 0x3d99ef6be3151517, - 0x3d8663442a7a5a5f, 0x3d8663442a7a5a5f, 0x3d8663442a7a5a5f, 0x3d8663442a7a5a5f, 0x3d8663442a7a5a5f, 0xbd6c613dc4d5d5c4, 0xbd6c613dc4d5d5c4, 0xbd6c613dc4d5d5c4, - 0xbd6c613dc4d5d5c4, 0xbd6c613dc4d5d5c4, 0xbd9249f18672a2a0, 0xbd9249f18672a2a0, 0xbd9249f18672a2a0, 0xbd9249f18672a2a0, 0xbd9249f18672a2a0, 0x3d9ef844abb57578, - 0x3d9ef844abb57578, 0x3d9ef844abb57578, 0x3d9ef844abb57578, 0xbda083ddaa254544, 0x3d903a7adddd8d90, 0x3d903a7adddd8d90, 0x3d903a7adddd8d90, 0x3d903a7adddd8d90, - 0x3d903a7adddd8d90, 0x3d57cb11005a5a7f, 0x3d57cb11005a5a7f, 0x3d57cb11005a5a7f, 0x3d57cb11005a5a7f, 0x3d57cb11005a5a7f, 0xbd8a82317ba48480, 0xbd8a82317ba48480, - 0xbd8a82317ba48480, 0xbd8a82317ba48480, 0xbd8a82317ba48480, 0xbd9bfee28baa2a28, 0xbd9bfee28baa2a28, 0xbd9bfee28baa2a28, 0x3da2008eba2aeaec, 0xbd9bfee28baa2a28, - 0x3d954353a67dedf0, 0x3d954353a67dedf0, 0x3d954353a67dedf0, 0x3d954353a67dedf0, 0x3d954353a67dedf0, 0x3d7a162762981821, 0x3d7a162762981821, 0x3d7a162762981821, - 0x3d7a162762981821, 0x3d7a162762981821, 0xbd80707fea63c3bf, 0xbd80707fea63c3bf, 0xbd80707fea63c3bf, 0xbd80707fea63c3bf, 0xbd80707fea63c3bf, 0xbd96f609c309c9c7, - 0xbd96f609c309c9c7, 0xbd96f609c309c9c7, 0xbd96f609c309c9c7, 0xbd96f609c309c9c7, 0x3d9a4c2c6f1e4e51, 0x3d9a4c2c6f1e4e51, 0x3d9a4c2c6f1e4e51, 0x3d9a4c2c6f1e4e51, - 0x3d9a4c2c6f1e4e51, 0x3d871cc5428cccd2, 0x3d871cc5428cccd2, 0x3d871cc5428cccd2, 0x3d871cc5428cccd2, 0x3d871cc5428cccd2, 0xbd697b39648c0bf9, 0xbd697b39648c0bf9, - 0xbd697b39648c0bf9, 0xbd697b39648c0bf9, 0xbd697b39648c0bf9, 0xbd91ed30fa696967, 0xbd91ed30fa696967, 0xbd91ed30fa696967, 0xbd91ed30fa696967, 0xbd91ed30fa696967, - 0x3d9f550537beaeb1, 0x3d9f550537beaeb1, 0x3d9f550537beaeb1, 0x3d9f550537beaeb1, 0xbda0557d6420a8a7, 0x3d90973b69e6c6c9, 0x3d90973b69e6c6c9, 0x3d90973b69e6c6c9, - 0x3d90973b69e6c6c9, 0x3d90973b69e6c6c9, 0x3d5d9719c0edee14, 0x3d5d9719c0edee14, 0x3d5d9719c0edee14, 0x3d5d9719c0edee14, 0x3d5d9719c0edee14, 0xbd89c8b06392120d, - 0xbd89c8b06392120d, 0xbd89c8b06392120d, 0xbd89c8b06392120d, 0xbd89c8b06392120d, 0xbd9ba221ffa0f0ef, 0xbd9ba221ffa0f0ef, 0xbd9ba221ffa0f0ef, 0x3da22eef002f8789, - 0xbd9ba221ffa0f0ef, 0x3d95a0143287272a, 0x3d95a0143287272a, 0x3d95a0143287272a, 0x3d95a0143287272a, 0x3d95a0143287272a, 0x3d7b892992bcfd07, 0x3d7b892992bcfd07, - 0x3d7b892992bcfd07, 0x3d7b892992bcfd07, 0x3d7b892992bcfd07, 0xbd7f6dfda4a2a299, 0xbd7f6dfda4a2a299, 0xbd7f6dfda4a2a299, 0xbd7f6dfda4a2a299, 0xbd7f6dfda4a2a299, - 0xbd9699493700908e, 0xbd9699493700908e, 0xbd9699493700908e, 0xbd9699493700908e, 0xbd9699493700908e, 0x3d9aa8ecfb27878a, 0x3d9aa8ecfb27878a, 0x3d9aa8ecfb27878a, - 0x3d9aa8ecfb27878a, 0x3d9aa8ecfb27878a, 0x3d87d6465a9f3f44, 0x3d87d6465a9f3f44, 0x3d87d6465a9f3f44, 0x3d87d6465a9f3f44, 0x3d87d6465a9f3f44, 0xbd6695350442422e, - 0xbd6695350442422e, 0xbd6695350442422e, 0xbd6695350442422e, 0xbd6695350442422e, 0xbd9190706e60302e, 0xbd9190706e60302e, 0xbd9190706e60302e, 0xbd9190706e60302e, - 0xbd9190706e60302e, 0x3d9fb1c5c3c7e7ea, 0x3d9fb1c5c3c7e7ea, 0x3d9fb1c5c3c7e7ea, 0x3d9fb1c5c3c7e7ea, 0xbda0271d1e1c0c0b, 0x3d90f3fbf5f00003, 0x3d90f3fbf5f00003, - 0x3d90f3fbf5f00003, 0x3d90f3fbf5f00003, 0x3d90f3fbf5f00003, 0x3d61b19140c0c0d5, 0x3d61b19140c0c0d5, 0x3d61b19140c0c0d5, 0x3d61b19140c0c0d5, 0x3d61b19140c0c0d5, -] )) ), - -################ chunk 2560 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, - 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3f1168b3c9848, - 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f404b917966d8b, 0x40f404b917966d8b, 0x40f404b917966d8b, 0x40f404b917966d8b, - 0x40f404b917966d8b, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f42bfe304a1812, 0x40f42bfe304a1812, - 0x40f42bfe304a1812, 0x40f42bfe304a1812, 0x40f42bfe304a1812, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, - 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f466e5d55797db, 0x40f466e5d55797db, 0x40f466e5d55797db, - 0x40f466e5d55797db, 0x40f466e5d55797db, 0x40f47a8861b16d1e, 0x40f47a8861b16d1e, 0x40f47a8861b16d1e, 0x40f47a8861b16d1f, 0x40f47a8861b16d1e, 0x40f48e2aee0b4262, - 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, - 0x40f4a1cd7a6517a5, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4c9129318c22b, 0x40f4c9129318c22b, - 0x40f4c9129318c22b, 0x40f4c9129318c22b, 0x40f4c9129318c22b, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, - 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f503fa382641f5, 0x40f503fa382641f5, 0x40f503fa382641f5, - 0x40f503fa382641f5, 0x40f503fa382641f5, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f52b3f50d9ec7c, - 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, - 0x40f53ee1dd33c1bf, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f56626f5e76c45, 0x40f56626f5e76c45, - 0x40f56626f5e76c45, 0x40f56626f5e76c45, 0x40f56626f5e76c45, 0x40f579c982414188, 0x40f579c982414188, 0x40f579c982414188, 0x40f579c982414189, 0x40f579c982414188, - 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, - 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5c853b3a89695, - 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, - 0x40f5dbf640026bd9, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f6033b58b6165f, 0x40f6033b58b6165f, - 0x40f6033b58b6165f, 0x40f6033b58b6165f, 0x40f6033b58b6165f, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, - 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e5, 0x40f63e22fdc39629, 0x40f63e22fdc39629, 0x40f63e22fdc39629, - 0x40f63e22fdc39629, 0x40f63e22fdc39629, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f66568167740af, - 0x40f66568167740af, 0x40f66568167740af, 0x40f66568167740af, 0x40f66568167740af, 0x40f6790aa2d115f2, 0x40f6790aa2d115f2, 0x40f6790aa2d115f2, 0x40f6790aa2d115f3, - 0x40f6790aa2d115f2, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, - 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, - 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6db3760924043, 0x40f6db3760924043, 0x40f6db3760924043, - 0x40f6db3760924043, 0x40f6db3760924043, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f7027c7945eac9, - 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7161f059fc00c, 0x40f7161f059fc00c, 0x40f7161f059fc00c, 0x40f7161f059fc00c, - 0x40f7161f059fc00c, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f9954f, 0x40f73d641e536a93, 0x40f73d641e536a93, - 0x40f73d641e536a93, 0x40f73d641e536a93, 0x40f73d641e536a93, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, - 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f7784bc360ea5c, 0x40f7784bc360ea5c, 0x40f7784bc360ea5c, - 0x40f7784bc360ea5d, 0x40f7784bc360ea5c, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f79f90dc1494e3, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbd890f2f4b7f9f9b, 0xbd890f2f4b7f9f9b, 0xbd890f2f4b7f9f9b, 0xbd890f2f4b7f9f9b, 0xbd890f2f4b7f9f9b, 0xbd9b45617397b7b5, 0xbd9b45617397b7b5, 0xbd9b45617397b7b5, - 0xbd9b45617397b7b5, 0xbd9b45617397b7b5, 0x3d95fcd4be906063, 0x3d95fcd4be906063, 0x3d95fcd4be906063, 0x3d95fcd4be906063, 0x3d95fcd4be906063, 0x3d7cfc2bc2e1e1ec, - 0x3d7cfc2bc2e1e1ec, 0x3d7cfc2bc2e1e1ec, 0x3d7cfc2bc2e1e1ec, 0x3d7cfc2bc2e1e1ec, 0xbd7dfafb747dbdb3, 0xbd7dfafb747dbdb3, 0xbd7dfafb747dbdb3, 0xbd7dfafb747dbdb3, - 0xbd7dfafb747dbdb3, 0xbd963c88aaf75755, 0xbd963c88aaf75755, 0xbd963c88aaf75755, 0xbd963c88aaf75755, 0xbd963c88aaf75755, 0x3d9b05ad8730c0c3, 0x3d9b05ad8730c0c3, - 0x3d9b05ad8730c0c3, 0x3d9b05ad8730c0c3, 0x3d9b05ad8730c0c3, 0x3d888fc772b1b1b7, 0x3d888fc772b1b1b7, 0x3d888fc772b1b1b7, 0x3d888fc772b1b1b7, 0x3d888fc772b1b1b7, - 0xbd63af30a3f87864, 0xbd63af30a3f87864, 0xbd63af30a3f87864, 0xbd63af30a3f87864, 0xbd63af30a3f87864, 0xbd9133afe256f6f4, 0xbd9133afe256f6f4, 0xbd9133afe256f6f4, - 0xbd9133afe256f6f4, 0xbd9133afe256f6f4, 0xbd9ff179b02ededc, 0xbd9ff179b02ededc, 0xbd9ff179b02ededc, 0x3da0074327e89092, 0xbd9ff179b02ededc, 0x3d9150bc81f9393c, - 0x3d9150bc81f9393c, 0x3d9150bc81f9393c, 0x3d9150bc81f9393c, 0x3d9150bc81f9393c, 0x3d649795a10a8aa0, 0x3d649795a10a8aa0, 0x3d649795a10a8aa0, 0x3d649795a10a8aa0, - 0x3d649795a10a8aa0, 0xbd8855ae336d2d28, 0xbd8855ae336d2d28, 0xbd8855ae336d2d28, 0xbd8855ae336d2d28, 0xbd8855ae336d2d28, 0xbd9ae8a0e78e7e7c, 0xbd9ae8a0e78e7e7c, - 0xbd9ae8a0e78e7e7c, 0xbd9ae8a0e78e7e7c, 0xbd9ae8a0e78e7e7c, 0x3d9659954a99999c, 0x3d9659954a99999c, 0x3d9659954a99999c, 0x3d9659954a99999c, 0x3d9659954a99999c, - 0x3d7e6f2df306c6d2, 0x3d7e6f2df306c6d2, 0x3d7e6f2df306c6d2, 0x3d7e6f2df306c6d2, 0x3d7e6f2df306c6d2, 0xbd7c87f94458d8ce, 0xbd7c87f94458d8ce, 0xbd7c87f94458d8ce, - 0xbd7c87f94458d8ce, 0xbd7c87f94458d8ce, 0xbd95dfc81eee1e1b, 0xbd95dfc81eee1e1b, 0xbd95dfc81eee1e1b, 0xbd95dfc81eee1e1b, 0xbd95dfc81eee1e1b, 0x3d9b626e1339f9fd, - 0x3d9b626e1339f9fd, 0x3d9b626e1339f9fd, 0x3d9b626e1339f9fd, 0x3d9b626e1339f9fd, 0x3d8949488ac4242a, 0x3d8949488ac4242a, 0x3d8949488ac4242a, 0x3d8949488ac4242a, - 0x3d8949488ac4242a, 0xbd60c92c43aeae99, 0xbd60c92c43aeae99, 0xbd60c92c43aeae99, 0xbd60c92c43aeae99, 0xbd60c92c43aeae99, 0xbd90d6ef564dbdbb, 0xbd90d6ef564dbdbb, - 0xbd90d6ef564dbdbb, 0xbd90d6ef564dbdbb, 0xbd90d6ef564dbdbb, 0xbd9f94b92425a5a3, 0xbd9f94b92425a5a3, 0xbd9f94b92425a5a3, 0x3da035a36ded2d2f, 0xbd9f94b92425a5a3, - 0x3d91ad7d0e027275, 0x3d91ad7d0e027275, 0x3d91ad7d0e027275, 0x3d91ad7d0e027275, 0x3d91ad7d0e027275, 0x3d677d9a0154546b, 0x3d677d9a0154546b, 0x3d677d9a0154546b, - 0x3d677d9a0154546b, 0x3d677d9a0154546b, 0xbd879c2d1b5abab5, 0xbd879c2d1b5abab5, 0xbd879c2d1b5abab5, 0xbd879c2d1b5abab5, 0xbd879c2d1b5abab5, 0xbd9a8be05b854542, - 0xbd9a8be05b854542, 0xbd9a8be05b854542, 0xbd9a8be05b854542, 0xbd9a8be05b854542, 0x3d96b655d6a2d2d6, 0x3d96b655d6a2d2d6, 0x3d96b655d6a2d2d6, 0x3d96b655d6a2d2d6, - 0x3d96b655d6a2d2d6, 0x3d7fe230232babb7, 0x3d7fe230232babb7, 0x3d7fe230232babb7, 0x3d7fe230232babb7, 0x3d7fe230232babb7, 0xbd7b14f71433f3e9, 0xbd7b14f71433f3e9, - 0xbd7b14f71433f3e9, 0xbd7b14f71433f3e9, 0xbd7b14f71433f3e9, 0xbd95830792e4e4e2, 0xbd95830792e4e4e2, 0xbd95830792e4e4e2, 0xbd95830792e4e4e2, 0xbd95830792e4e4e2, - 0x3d9bbf2e9f433336, 0x3d9bbf2e9f433336, 0x3d9bbf2e9f433336, 0x3d9bbf2e9f433336, 0xbda22068b05e6665, 0x3d8a02c9a2d6969c, 0x3d8a02c9a2d6969c, 0x3d8a02c9a2d6969c, - 0x3d8a02c9a2d6969c, 0x3d8a02c9a2d6969c, 0xbd5bc64fc6c9c99c, 0xbd5bc64fc6c9c99c, 0xbd5bc64fc6c9c99c, 0xbd5bc64fc6c9c99c, 0xbd5bc64fc6c9c99c, 0xbd907a2eca448482, - 0xbd907a2eca448482, 0xbd907a2eca448482, 0xbd907a2eca448482, 0xbd907a2eca448482, 0xbd9f37f8981c6c6a, 0xbd9f37f8981c6c6a, 0xbd9f37f8981c6c6a, 0x3da06403b3f1c9cb, - 0xbd9f37f8981c6c6a, 0x3d920a3d9a0babaf, 0x3d920a3d9a0babaf, 0x3d920a3d9a0babaf, 0x3d920a3d9a0babaf, 0x3d920a3d9a0babaf, 0x3d6a639e619e1e35, 0x3d6a639e619e1e35, - 0x3d6a639e619e1e35, 0x3d6a639e619e1e35, 0x3d6a639e619e1e35, 0xbd86e2ac03484842, 0xbd86e2ac03484842, 0xbd86e2ac03484842, 0xbd86e2ac03484842, 0xbd86e2ac03484842, - 0xbd9a2f1fcf7c0c09, 0xbd9a2f1fcf7c0c09, 0xbd9a2f1fcf7c0c09, 0xbd9a2f1fcf7c0c09, 0xbd9a2f1fcf7c0c09, 0x3d97131662ac0c0f, 0x3d97131662ac0c0f, 0x3d97131662ac0c0f, - 0x3d97131662ac0c0f, 0x3d97131662ac0c0f, 0x3d80aa9929a8484e, 0x3d80aa9929a8484e, 0x3d80aa9929a8484e, 0x3d80aa9929a8484e, 0x3d80aa9929a8484e, 0xbd79a1f4e40f0f03, - 0xbd79a1f4e40f0f03, 0xbd79a1f4e40f0f03, 0xbd79a1f4e40f0f03, 0xbd79a1f4e40f0f03, 0xbd95264706dbaba9, 0xbd95264706dbaba9, 0xbd95264706dbaba9, 0xbd95264706dbaba9, - 0xbd95264706dbaba9, 0x3d9c1bef2b4c6c6f, 0x3d9c1bef2b4c6c6f, 0x3d9c1bef2b4c6c6f, 0x3d9c1bef2b4c6c6f, 0xbda1f2086a59c9c8, 0x3d8abc4abae9090f, 0x3d8abc4abae9090f, - 0x3d8abc4abae9090f, 0x3d8abc4abae9090f, 0x3d8abc4abae9090f, 0xbd55fa4706363606, 0xbd55fa4706363606, 0xbd55fa4706363606, 0xbd55fa4706363606, 0xbd55fa4706363606, - 0xbd901d6e3e3b4b48, 0xbd901d6e3e3b4b48, 0xbd901d6e3e3b4b48, 0xbd901d6e3e3b4b48, 0xbd901d6e3e3b4b48, 0xbd9edb380c133330, 0xbd9edb380c133330, 0xbd9edb380c133330, - 0x3da09263f9f66668, 0xbd9edb380c133330, 0x3d9266fe2614e4e8, 0x3d9266fe2614e4e8, 0x3d9266fe2614e4e8, 0x3d9266fe2614e4e8, 0x3d9266fe2614e4e8, 0x3d6d49a2c1e7e800, -] )) ), - -################ chunk 3072 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f7b333686e6a26, 0x40f7b333686e6a26, 0x40f7b333686e6a26, 0x40f7b333686e6a26, - 0x40f7b333686e6a26, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7da78812214ad, 0x40f7da78812214ad, - 0x40f7da78812214ad, 0x40f7da78812214ad, 0x40f7da78812214ad, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, - 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f81560262f9476, 0x40f81560262f9476, 0x40f81560262f9476, - 0x40f81560262f9476, 0x40f81560262f9476, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969b9, 0x40f83ca53ee33efd, - 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f85047cb3d1440, 0x40f85047cb3d1440, 0x40f85047cb3d1440, 0x40f85047cb3d1440, - 0x40f85047cb3d1440, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f8778ce3f0bec6, 0x40f8778ce3f0bec6, - 0x40f8778ce3f0bec6, 0x40f8778ce3f0bec7, 0x40f8778ce3f0bec6, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, - 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, - 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8d9b9a1b1e917, - 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, - 0x40f8ed5c2e0bbe5a, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f914a146bf68e0, 0x40f914a146bf68e0, - 0x40f914a146bf68e0, 0x40f914a146bf68e0, 0x40f914a146bf68e0, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e23, - 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, - 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f976ce04809330, - 0x40f976ce04809330, 0x40f976ce04809330, 0x40f976ce04809331, 0x40f976ce04809330, 0x40f98a7090da6874, 0x40f98a7090da6874, 0x40f98a7090da6874, 0x40f98a7090da6874, - 0x40f98a7090da6874, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, - 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, - 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, - 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa13e2674f3d4a, - 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, - 0x40fa2784f3a9128d, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, - 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, - 0x40fa760f2510679a, 0x40fa760f2510679a, 0x40fa760f2510679a, 0x40fa760f2510679b, 0x40fa760f2510679a, 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, - 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fab0f6ca1de764, - 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fac4995677bca7, 0x40fac4995677bca7, 0x40fac4995677bca7, 0x40fac4995677bca7, - 0x40fac4995677bca7, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40faebde6f2b672e, 0x40faebde6f2b672e, - 0x40faebde6f2b672e, 0x40faebde6f2b672e, 0x40faebde6f2b672e, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, - 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb26c61438e6f8, 0x40fb26c61438e6f8, 0x40fb26c61438e6f8, - 0x40fb26c61438e6f8, 0x40fb26c61438e6f7, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb4e0b2cec917e, - 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb61adb94666c1, 0x40fb61adb94666c1, 0x40fb61adb94666c1, 0x40fb61adb94666c1, - 0x40fb61adb94666c1, 0x40fb755045a03c04, 0x40fb755045a03c04, 0x40fb755045a03c04, 0x40fb755045a03c05, 0x40fb755045a03c04, 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d6d49a2c1e7e800, 0x3d6d49a2c1e7e800, 0x3d6d49a2c1e7e800, 0x3d6d49a2c1e7e800, 0xbd86292aeb35d5d0, 0xbd86292aeb35d5d0, 0xbd86292aeb35d5d0, 0xbd86292aeb35d5d0, - 0xbd86292aeb35d5d0, 0xbd99d25f4372d2d0, 0xbd99d25f4372d2d0, 0xbd99d25f4372d2d0, 0xbd99d25f4372d2d0, 0xbd99d25f4372d2d0, 0x3d976fd6eeb54548, 0x3d976fd6eeb54548, - 0x3d976fd6eeb54548, 0x3d976fd6eeb54548, 0x3d976fd6eeb54548, 0x3d81641a41babac1, 0x3d81641a41babac1, 0x3d81641a41babac1, 0x3d81641a41babac1, 0x3d81641a41babac1, - 0xbd782ef2b3ea2a1e, 0xbd782ef2b3ea2a1e, 0xbd782ef2b3ea2a1e, 0xbd782ef2b3ea2a1e, 0xbd782ef2b3ea2a1e, 0xbd94c9867ad2726f, 0xbd94c9867ad2726f, 0xbd94c9867ad2726f, - 0xbd94c9867ad2726f, 0xbd94c9867ad2726f, 0x3d9c78afb755a5a9, 0x3d9c78afb755a5a9, 0x3d9c78afb755a5a9, 0x3d9c78afb755a5a9, 0xbda1c3a824552d2c, 0x3d8b75cbd2fb7b82, - 0x3d8b75cbd2fb7b82, 0x3d8b75cbd2fb7b82, 0x3d8b75cbd2fb7b82, 0x3d8b75cbd2fb7b82, 0xbd502e3e45a2a270, 0xbd502e3e45a2a270, 0xbd502e3e45a2a270, 0xbd502e3e45a2a270, - 0xbd502e3e45a2a270, 0xbd8f815b6464241e, 0xbd8f815b6464241e, 0xbd8f815b6464241e, 0xbd8f815b6464241e, 0xbd8f815b6464241e, 0xbd9e7e778009f9f7, 0xbd9e7e778009f9f7, - 0xbd9e7e778009f9f7, 0x3da0c0c43ffb0305, 0xbd9e7e778009f9f7, 0x3d92c3beb21e1e21, 0x3d92c3beb21e1e21, 0x3d92c3beb21e1e21, 0x3d92c3beb21e1e21, 0x3d92c3beb21e1e21, - 0x3d7017d39118d8e6, 0x3d7017d39118d8e6, 0x3d7017d39118d8e6, 0x3d7017d39118d8e6, 0x3d7017d39118d8e6, 0xbd856fa9d323635d, 0xbd856fa9d323635d, 0xbd856fa9d323635d, - 0xbd856fa9d323635d, 0xbd856fa9d323635d, 0xbd99759eb7699996, 0xbd99759eb7699996, 0xbd99759eb7699996, 0xbd99759eb7699996, 0xbd99759eb7699996, 0x3d97cc977abe7e82, - 0x3d97cc977abe7e82, 0x3d97cc977abe7e82, 0x3d97cc977abe7e82, 0x3d97cc977abe7e82, 0x3d821d9b59cd2d34, 0x3d821d9b59cd2d34, 0x3d821d9b59cd2d34, 0x3d821d9b59cd2d34, - 0x3d821d9b59cd2d34, 0xbd76bbf083c54538, 0xbd76bbf083c54538, 0xbd76bbf083c54538, 0xbd76bbf083c54538, 0xbd76bbf083c54538, 0xbd946cc5eec93936, 0xbd946cc5eec93936, - 0xbd946cc5eec93936, 0xbd946cc5eec93936, 0xbd946cc5eec93936, 0x3d9cd570435edee2, 0x3d9cd570435edee2, 0x3d9cd570435edee2, 0x3d9cd570435edee2, 0xbda19547de50908f, - 0x3d8c2f4ceb0dedf4, 0x3d8c2f4ceb0dedf4, 0x3d8c2f4ceb0dedf4, 0x3d8c2f4ceb0dedf4, 0x3d8c2f4ceb0dedf4, 0xbd44c46b0a1e1db6, 0xbd44c46b0a1e1db6, 0xbd44c46b0a1e1db6, - 0xbd44c46b0a1e1db6, 0xbd44c46b0a1e1db6, 0xbd8ec7da4c51b1ab, 0xbd8ec7da4c51b1ab, 0xbd8ec7da4c51b1ab, 0xbd8ec7da4c51b1ab, 0xbd8ec7da4c51b1ab, 0xbd9e21b6f400c0bd, - 0xbd9e21b6f400c0bd, 0xbd9e21b6f400c0bd, 0x3da0ef2485ff9fa1, 0xbd9e21b6f400c0bd, 0x3d93207f3e27575b, 0x3d93207f3e27575b, 0x3d93207f3e27575b, 0x3d93207f3e27575b, - 0x3d93207f3e27575b, 0x3d718ad5c13dbdcb, 0x3d718ad5c13dbdcb, 0x3d718ad5c13dbdcb, 0x3d718ad5c13dbdcb, 0x3d718ad5c13dbdcb, 0xbd84b628bb10f0ea, 0xbd84b628bb10f0ea, - 0xbd84b628bb10f0ea, 0xbd84b628bb10f0ea, 0xbd84b628bb10f0ea, 0xbd9918de2b60605d, 0xbd9918de2b60605d, 0xbd9918de2b60605d, 0xbd9918de2b60605d, 0xbd9918de2b60605d, - 0x3d98295806c7b7bb, 0x3d98295806c7b7bb, 0x3d98295806c7b7bb, 0x3d98295806c7b7bb, 0x3d98295806c7b7bb, 0x3d82d71c71df9fa6, 0x3d82d71c71df9fa6, 0x3d82d71c71df9fa6, - 0x3d82d71c71df9fa6, 0x3d82d71c71df9fa6, 0xbd7548ee53a06053, 0xbd7548ee53a06053, 0xbd7548ee53a06053, 0xbd7548ee53a06053, 0xbd7548ee53a06053, 0xbd94100562bffffd, - 0xbd94100562bffffd, 0xbd94100562bffffd, 0xbd94100562bffffd, 0xbd94100562bffffd, 0x3d9d3230cf68181b, 0x3d9d3230cf68181b, 0x3d9d3230cf68181b, 0x3d9d3230cf68181b, - 0xbda166e7984bf3f2, 0x3d8ce8ce03206067, 0x3d8ce8ce03206067, 0x3d8ce8ce03206067, 0x3d8ce8ce03206067, 0x3d8ce8ce03206067, 0xbd3258b311eded15, 0xbd3258b311eded15, - 0xbd3258b311eded15, 0xbd3258b311eded15, 0xbd3258b311eded15, 0xbd8e0e59343f3f38, 0xbd8e0e59343f3f38, 0xbd8e0e59343f3f38, 0xbd8e0e59343f3f38, 0xbd8e0e59343f3f38, - 0xbd9dc4f667f78784, 0xbd9dc4f667f78784, 0xbd9dc4f667f78784, 0x3da11d84cc043c3e, 0xbd9dc4f667f78784, 0x3d937d3fca309094, 0x3d937d3fca309094, 0x3d937d3fca309094, - 0x3d937d3fca309094, 0x3d937d3fca309094, 0x3d72fdd7f162a2b0, 0x3d72fdd7f162a2b0, 0x3d72fdd7f162a2b0, 0x3d72fdd7f162a2b0, 0x3d72fdd7f162a2b0, 0xbd83fca7a2fe7e78, - 0xbd83fca7a2fe7e78, 0xbd83fca7a2fe7e78, 0xbd83fca7a2fe7e78, 0xbd83fca7a2fe7e78, 0xbd98bc1d9f572724, 0xbd98bc1d9f572724, 0xbd98bc1d9f572724, 0xbd98bc1d9f572724, - 0xbd98bc1d9f572724, 0x3d98861892d0f0f4, 0x3d98861892d0f0f4, 0x3d98861892d0f0f4, 0x3d98861892d0f0f4, 0x3d98861892d0f0f4, 0x3d83909d89f21219, 0x3d83909d89f21219, - 0x3d83909d89f21219, 0x3d83909d89f21219, 0x3d83909d89f21219, 0xbd73d5ec237b7b6e, 0xbd73d5ec237b7b6e, 0xbd73d5ec237b7b6e, 0xbd73d5ec237b7b6e, 0xbd73d5ec237b7b6e, - 0xbd93b344d6b6c6c3, 0xbd93b344d6b6c6c3, 0xbd93b344d6b6c6c3, 0xbd93b344d6b6c6c3, 0xbd93b344d6b6c6c3, 0x3d9d8ef15b715155, 0x3d9d8ef15b715155, 0x3d9d8ef15b715155, - 0x3d9d8ef15b715155, 0xbda1388752475756, 0x3d8da24f1b32d2da, 0x3d8da24f1b32d2da, 0x3d8da24f1b32d2da, 0x3d8da24f1b32d2da, 0x3d8da24f1b32d2da, 0x3d135dbfc1818507, - 0x3d135dbfc1818507, 0x3d135dbfc1818507, 0x3d135dbfc1818507, 0x3d135dbfc1818507, 0xbd8d54d81c2cccc6, 0xbd8d54d81c2cccc6, 0xbd8d54d81c2cccc6, 0xbd8d54d81c2cccc6, - 0xbd8d54d81c2cccc6, 0xbd9d6835dbee4e4b, 0xbd9d6835dbee4e4b, 0xbd9d6835dbee4e4b, 0x3da14be51208d8db, 0xbd9d6835dbee4e4b, 0x3d93da005639c9cd, 0x3d93da005639c9cd, -] )) ), - -################ chunk 3584 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, - 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbc3da77079111, 0x40fbc3da77079111, 0x40fbc3da77079111, - 0x40fbc3da77079111, 0x40fbc3da77079111, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbeb1f8fbb3b98, - 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbfec21c1510db, 0x40fbfec21c1510db, 0x40fbfec21c1510db, 0x40fbfec21c1510db, - 0x40fbfec21c1510db, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc260734c8bb62, 0x40fc260734c8bb62, - 0x40fc260734c8bb62, 0x40fc260734c8bb62, 0x40fc260734c8bb61, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, - 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, - 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, 0x40fc74916630106e, 0x40fc74916630106e, 0x40fc74916630106e, 0x40fc74916630106f, 0x40fc74916630106e, 0x40fc8833f289e5b2, - 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, - 0x40fc9bd67ee3baf5, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcc31b9797657b, 0x40fcc31b9797657b, - 0x40fcc31b9797657b, 0x40fcc31b9797657b, 0x40fcc31b9797657b, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, - 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, - 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd254855588fcc, - 0x40fd254855588fcc, 0x40fd254855588fcc, 0x40fd254855588fcc, 0x40fd254855588fcb, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, - 0x40fd38eae1b2650f, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd602ffa660f95, 0x40fd602ffa660f95, - 0x40fd602ffa660f95, 0x40fd602ffa660f95, 0x40fd602ffa660f95, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d9, 0x40fd73d286bfe4d8, - 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, - 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdc25cb82739e5, - 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, - 0x40fdd5ff44810f29, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, - 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, - 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86435, 0x40fe382c02423979, 0x40fe382c02423979, 0x40fe382c02423979, - 0x40fe382c02423979, 0x40fe382c02423979, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe5f711af5e3ff, - 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe7313a74fb942, 0x40fe7313a74fb942, 0x40fe7313a74fb942, 0x40fe7313a74fb943, - 0x40fe7313a74fb942, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, - 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, - 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fed5406510e393, 0x40fed5406510e393, 0x40fed5406510e393, - 0x40fed5406510e393, 0x40fed5406510e393, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fefc857dc48e19, - 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40ff10280a1e635c, 0x40ff10280a1e635c, 0x40ff10280a1e635c, 0x40ff10280a1e635c, - 0x40ff10280a1e635c, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca9678389f, 0x40ff376d22d20de3, 0x40ff376d22d20de3, - 0x40ff376d22d20de3, 0x40ff376d22d20de3, 0x40ff376d22d20de3, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, - 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff7254c7df8dac, 0x40ff7254c7df8dac, 0x40ff7254c7df8dac, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d93da005639c9cd, 0x3d93da005639c9cd, 0x3d93da005639c9cd, 0x3d7470da21878796, 0x3d7470da21878796, 0x3d7470da21878796, 0x3d7470da21878796, 0x3d7470da21878796, - 0xbd8343268aec0c05, 0xbd8343268aec0c05, 0xbd8343268aec0c05, 0xbd8343268aec0c05, 0xbd8343268aec0c05, 0xbd985f5d134dedea, 0xbd985f5d134dedea, 0xbd985f5d134dedea, - 0xbd985f5d134dedea, 0xbd985f5d134dedea, 0x3d98e2d91eda2a2e, 0x3d98e2d91eda2a2e, 0x3d98e2d91eda2a2e, 0x3d98e2d91eda2a2e, 0x3d98e2d91eda2a2e, 0x3d844a1ea204848c, - 0x3d844a1ea204848c, 0x3d844a1ea204848c, 0x3d844a1ea204848c, 0x3d844a1ea204848c, 0xbd7262e9f3569688, 0xbd7262e9f3569688, 0xbd7262e9f3569688, 0xbd7262e9f3569688, - 0xbd7262e9f3569688, 0xbd9356844aad8d8a, 0xbd9356844aad8d8a, 0xbd9356844aad8d8a, 0xbd9356844aad8d8a, 0xbd9356844aad8d8a, 0x3d9debb1e77a8a8e, 0x3d9debb1e77a8a8e, - 0x3d9debb1e77a8a8e, 0x3d9debb1e77a8a8e, 0xbda10a270c42bab9, 0x3d8e5bd03345454d, 0x3d8e5bd03345454d, 0x3d8e5bd03345454d, 0x3d8e5bd03345454d, 0x3d8e5bd03345454d, - 0x3d3c0792f2aeaf98, 0x3d3c0792f2aeaf98, 0x3d3c0792f2aeaf98, 0x3d3c0792f2aeaf98, 0x3d3c0792f2aeaf98, 0xbd8c9b57041a5a53, 0xbd8c9b57041a5a53, 0xbd8c9b57041a5a53, - 0xbd8c9b57041a5a53, 0xbd8c9b57041a5a53, 0xbd9d0b754fe51511, 0xbd9d0b754fe51511, 0xbd9d0b754fe51511, 0x3da17a45580d7577, 0xbd9d0b754fe51511, 0x3d9436c0e2430307, - 0x3d9436c0e2430307, 0x3d9436c0e2430307, 0x3d9436c0e2430307, 0x3d9436c0e2430307, 0x3d75e3dc51ac6c7b, 0x3d75e3dc51ac6c7b, 0x3d75e3dc51ac6c7b, 0x3d75e3dc51ac6c7b, - 0x3d75e3dc51ac6c7b, 0xbd8289a572d99992, 0xbd8289a572d99992, 0xbd8289a572d99992, 0xbd8289a572d99992, 0xbd8289a572d99992, 0xbd98029c8744b4b1, 0xbd98029c8744b4b1, - 0xbd98029c8744b4b1, 0xbd98029c8744b4b1, 0xbd98029c8744b4b1, 0x3d993f99aae36367, 0x3d993f99aae36367, 0x3d993f99aae36367, 0x3d993f99aae36367, 0x3d993f99aae36367, - 0x3d85039fba16f6fe, 0x3d85039fba16f6fe, 0x3d85039fba16f6fe, 0x3d85039fba16f6fe, 0x3d85039fba16f6fe, 0xbd70efe7c331b1a3, 0xbd70efe7c331b1a3, 0xbd70efe7c331b1a3, - 0xbd70efe7c331b1a3, 0xbd70efe7c331b1a3, 0xbd92f9c3bea45451, 0xbd92f9c3bea45451, 0xbd92f9c3bea45451, 0xbd92f9c3bea45451, 0xbd92f9c3bea45451, 0x3d9e48727383c3c8, - 0x3d9e48727383c3c8, 0x3d9e48727383c3c8, 0x3d9e48727383c3c8, 0xbda0dbc6c63e1e1c, 0x3d8f15514b57b7bf, 0x3d8f15514b57b7bf, 0x3d8f15514b57b7bf, 0x3d8f15514b57b7bf, - 0x3d8f15514b57b7bf, 0x3d499bdafa7e7ef7, 0x3d499bdafa7e7ef7, 0x3d499bdafa7e7ef7, 0x3d499bdafa7e7ef7, 0x3d499bdafa7e7ef7, 0xbd8be1d5ec07e7e0, 0xbd8be1d5ec07e7e0, - 0xbd8be1d5ec07e7e0, 0xbd8be1d5ec07e7e0, 0xbd8be1d5ec07e7e0, 0xbd9caeb4c3dbdbd8, 0xbd9caeb4c3dbdbd8, 0xbd9caeb4c3dbdbd8, 0x3da1a8a59e121214, 0xbd9caeb4c3dbdbd8, - 0x3d9493816e4c3c40, 0x3d9493816e4c3c40, 0x3d9493816e4c3c40, 0x3d9493816e4c3c40, 0x3d9493816e4c3c40, 0x3d7756de81d15161, 0x3d7756de81d15161, 0x3d7756de81d15161, - 0x3d7756de81d15161, 0x3d7756de81d15161, 0xbd81d0245ac7271f, 0xbd81d0245ac7271f, 0xbd81d0245ac7271f, 0xbd81d0245ac7271f, 0xbd81d0245ac7271f, 0xbd97a5dbfb3b7b78, - 0xbd97a5dbfb3b7b78, 0xbd97a5dbfb3b7b78, 0xbd97a5dbfb3b7b78, 0xbd97a5dbfb3b7b78, 0x3d999c5a36ec9ca0, 0x3d999c5a36ec9ca0, 0x3d999c5a36ec9ca0, 0x3d999c5a36ec9ca0, - 0x3d999c5a36ec9ca0, 0x3d85bd20d2296971, 0x3d85bd20d2296971, 0x3d85bd20d2296971, 0x3d85bd20d2296971, 0x3d85bd20d2296971, 0xbd6ef9cb2619997b, 0xbd6ef9cb2619997b, - 0xbd6ef9cb2619997b, 0xbd6ef9cb2619997b, 0xbd6ef9cb2619997b, 0xbd929d03329b1b17, 0xbd929d03329b1b17, 0xbd929d03329b1b17, 0xbd929d03329b1b17, 0xbd929d03329b1b17, - 0x3d9ea532ff8cfd01, 0x3d9ea532ff8cfd01, 0x3d9ea532ff8cfd01, 0x3d9ea532ff8cfd01, 0xbda0ad6680398180, 0x3d8fced2636a2a32, 0x3d8fced2636a2a32, 0x3d8fced2636a2a32, - 0x3d8fced2636a2a32, 0x3d8fced2636a2a32, 0x3d5299f63dd2d311, 0x3d5299f63dd2d311, 0x3d5299f63dd2d311, 0x3d5299f63dd2d311, 0x3d5299f63dd2d311, 0xbd8b2854d3f5756e, - 0xbd8b2854d3f5756e, 0xbd8b2854d3f5756e, 0xbd8b2854d3f5756e, 0xbd8b2854d3f5756e, 0xbd9c51f437d2a29f, 0xbd9c51f437d2a29f, 0xbd9c51f437d2a29f, 0x3da1d705e416aeb1, - 0xbd9c51f437d2a29f, 0x3d94f041fa557579, 0x3d94f041fa557579, 0x3d94f041fa557579, 0x3d94f041fa557579, 0x3d94f041fa557579, 0x3d78c9e0b1f63646, 0x3d78c9e0b1f63646, - 0x3d78c9e0b1f63646, 0x3d78c9e0b1f63646, 0x3d78c9e0b1f63646, 0xbd8116a342b4b4ad, 0xbd8116a342b4b4ad, 0xbd8116a342b4b4ad, 0xbd8116a342b4b4ad, 0xbd8116a342b4b4ad, - 0xbd97491b6f32423e, 0xbd97491b6f32423e, 0xbd97491b6f32423e, 0xbd97491b6f32423e, 0xbd97491b6f32423e, 0x3d99f91ac2f5d5da, 0x3d99f91ac2f5d5da, 0x3d99f91ac2f5d5da, - 0x3d99f91ac2f5d5da, 0x3d99f91ac2f5d5da, 0x3d8676a1ea3bdbe4, 0x3d8676a1ea3bdbe4, 0x3d8676a1ea3bdbe4, 0x3d8676a1ea3bdbe4, 0x3d8676a1ea3bdbe4, 0xbd6c13c6c5cfcfb0, - 0xbd6c13c6c5cfcfb0, 0xbd6c13c6c5cfcfb0, 0xbd6c13c6c5cfcfb0, 0xbd6c13c6c5cfcfb0, 0xbd924042a691e1de, 0xbd924042a691e1de, 0xbd924042a691e1de, 0xbd924042a691e1de, - 0xbd924042a691e1de, 0x3d9f01f38b96363a, 0x3d9f01f38b96363a, 0x3d9f01f38b96363a, 0x3d9f01f38b96363a, 0xbda07f063a34e4e3, 0x3d904429bdbe4e52, 0x3d904429bdbe4e52, - 0x3d904429bdbe4e52, 0x3d904429bdbe4e52, 0x3d904429bdbe4e52, 0x3d5865fefe6666a7, 0x3d5865fefe6666a7, 0x3d5865fefe6666a7, 0x3d5865fefe6666a7, 0x3d5865fefe6666a7, - 0xbd8a6ed3bbe302fb, 0xbd8a6ed3bbe302fb, 0xbd8a6ed3bbe302fb, 0xbd8a6ed3bbe302fb, 0xbd8a6ed3bbe302fb, 0xbd9bf533abc96965, 0xbd9bf533abc96965, 0xbd9bf533abc96965, -] )) ), - -################ chunk 4096 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40ff7254c7df8dad, 0x40ff7254c7df8dac, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff9999e0933833, - 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, - 0x40ffad3c6ced0d76, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, - 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, - 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x410007b495571be3, 0x410007b495571be3, 0x410007b495571be3, - 0x410007b495571be3, 0x410007b495571be3, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001b5721b0f126, - 0x41001b5721b0f126, 0x41001b5721b0f126, 0x41001b5721b0f126, 0x41001b5721b0f126, 0x4100252867dddbc8, 0x4100252867dddbc8, 0x4100252867dddbc8, 0x4100252867dddbc8, - 0x4100252867dddbc8, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x410038caf437b10b, 0x410038caf437b10b, - 0x410038caf437b10b, 0x410038caf437b10b, 0x410038caf437b10b, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, - 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x4100563ec6be70f0, 0x4100563ec6be70f0, 0x4100563ec6be70f0, - 0x4100563ec6be70f0, 0x4100563ec6be70f0, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410069e153184633, - 0x410069e153184633, 0x410069e153184633, 0x410069e153184633, 0x410069e153184633, 0x410073b2994530d5, 0x410073b2994530d5, 0x410073b2994530d5, 0x410073b2994530d5, - 0x410073b2994530d5, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b76, 0x41008755259f0618, 0x41008755259f0618, - 0x41008755259f0618, 0x41008755259f0618, 0x41008755259f0618, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, - 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, - 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100b86b847f9b40, - 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, - 0x4100c23ccaac85e2, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100d5df57065b25, 0x4100d5df57065b25, - 0x4100d5df57065b25, 0x4100d5df57065b25, 0x4100d5df57065b25, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, - 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100f353298d1b0a, 0x4100f353298d1b0a, 0x4100f353298d1b0a, - 0x4100f353298d1b0a, 0x4100f353298d1b0a, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ab, 0x410106f5b5e6f04d, - 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410110c6fc13daef, 0x410110c6fc13daef, 0x410110c6fc13daef, 0x410110c6fc13daef, - 0x410110c6fc13daef, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41012469886db032, 0x41012469886db032, - 0x41012469886db032, 0x41012469886db032, 0x41012469886db032, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, - 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x410141dd5af47017, 0x410141dd5af47017, 0x410141dd5af47017, - 0x410141dd5af47017, 0x410141dd5af47017, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x4101557fe74e455a, - 0x4101557fe74e455a, 0x4101557fe74e455a, 0x4101557fe74e455a, 0x4101557fe74e455a, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, - 0x41015f512d7b2ffc, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x410172f3b9d5053f, 0x410172f3b9d5053f, - 0x410172f3b9d5053f, 0x410172f3b9d5053f, 0x410172f3b9d5053f, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe0, - 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x410190678c5bc524, 0x410190678c5bc524, 0x410190678c5bc524, - 0x410190678c5bc524, 0x410190678c5bc524, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x4101a40a18b59a67, - 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101addb5ee28509, 0x4101addb5ee28509, 0x4101addb5ee28509, 0x4101addb5ee28509, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3da205662a1b4b4d, 0xbd9bf533abc96965, 0x3d954d02865eaeb3, 0x3d954d02865eaeb3, 0x3d954d02865eaeb3, 0x3d954d02865eaeb3, 0x3d954d02865eaeb3, 0x3d7a3ce2e21b1b2b, - 0x3d7a3ce2e21b1b2b, 0x3d7a3ce2e21b1b2b, 0x3d7a3ce2e21b1b2b, 0x3d7a3ce2e21b1b2b, 0xbd805d222aa2423a, 0xbd805d222aa2423a, 0xbd805d222aa2423a, 0xbd805d222aa2423a, - 0xbd805d222aa2423a, 0xbd96ec5ae3290905, 0xbd96ec5ae3290905, 0xbd96ec5ae3290905, 0xbd96ec5ae3290905, 0xbd96ec5ae3290905, 0x3d9a55db4eff0f13, 0x3d9a55db4eff0f13, - 0x3d9a55db4eff0f13, 0x3d9a55db4eff0f13, 0x3d9a55db4eff0f13, 0x3d873023024e4e57, 0x3d873023024e4e57, 0x3d873023024e4e57, 0x3d873023024e4e57, 0x3d873023024e4e57, - 0xbd692dc2658605e5, 0xbd692dc2658605e5, 0xbd692dc2658605e5, 0xbd692dc2658605e5, 0xbd692dc2658605e5, 0xbd91e3821a88a8a5, 0xbd91e3821a88a8a5, 0xbd91e3821a88a8a5, - 0xbd91e3821a88a8a5, 0xbd91e3821a88a8a5, 0x3d9f5eb4179f6f74, 0x3d9f5eb4179f6f74, 0x3d9f5eb4179f6f74, 0x3d9f5eb4179f6f74, 0x3d9f5eb4179f6f74, 0xbda7af8adb1c3c3a, - 0xbda7af8adb1c3c3a, 0xbda7af8adb1c3c3a, 0xbda7af8adb1c3c3a, 0xbda7af8adb1c3c3a, 0x3d5e3207bef9fa3d, 0x3d5e3207bef9fa3d, 0x3d5e3207bef9fa3d, 0x3d5e3207bef9fa3d, - 0x3d5e3207bef9fa3d, 0x3da992ab570bdbde, 0x3da992ab570bdbde, 0x3da992ab570bdbde, 0x3da992ab570bdbde, 0x3da992ab570bdbde, 0xbd9b98731fc0302c, 0xbd9b98731fc0302c, - 0xbd9b98731fc0302c, 0xbd9b98731fc0302c, 0xbd9b98731fc0302c, 0x3d95a9c31267e7ec, 0x3d95a9c31267e7ec, 0x3d95a9c31267e7ec, 0x3d95a9c31267e7ec, 0x3d95a9c31267e7ec, - 0xbdac8a035db7fffe, 0xbdac8a035db7fffe, 0xbdac8a035db7fffe, 0xbdac8a035db7fffe, 0xbdac8a035db7fffe, 0xbd7f4742251f9f8f, 0xbd7f4742251f9f8f, 0xbd7f4742251f9f8f, - 0xbd7f4742251f9f8f, 0xbd7f4742251f9f8f, 0x3da4b832d470181a, 0x3da4b832d470181a, 0x3da4b832d470181a, 0x3da4b832d470181a, 0x3da4b832d470181a, 0xbda2a6b2127bdbda, - 0xbda2a6b2127bdbda, 0xbda2a6b2127bdbda, 0xbda2a6b2127bdbda, 0xbda2a6b2127bdbda, 0x3d87e9a41a60c0c9, 0x3d87e9a41a60c0c9, 0x3d87e9a41a60c0c9, 0x3d87e9a41a60c0c9, - 0x3d87e9a41a60c0c9, 0x3dae9b841fac3c3e, 0x3dae9b841fac3c3e, 0x3dae9b841fac3c3e, 0x3dae9b841fac3c3e, 0xbdb0b23df029e1e1, 0xbd9186c18e7f6f6b, 0xbd9186c18e7f6f6b, - 0xbd9186c18e7f6f6b, 0xbd9186c18e7f6f6b, 0xbd9186c18e7f6f6b, 0x3d9fbb74a3a8a8ad, 0x3d9fbb74a3a8a8ad, 0x3d9fbb74a3a8a8ad, 0x3d9fbb74a3a8a8ad, 0x3d9fbb74a3a8a8ad, - 0xbda7812a95179f9d, 0xbda7812a95179f9d, 0xbda7812a95179f9d, 0xbda7812a95179f9d, 0xbda7812a95179f9d, 0x3d61ff083fc6c6e9, 0x3d61ff083fc6c6e9, 0x3d61ff083fc6c6e9, - 0x3d61ff083fc6c6e9, 0x3d61ff083fc6c6e9, 0x3da9c10b9d10787b, 0x3da9c10b9d10787b, 0x3da9c10b9d10787b, 0x3da9c10b9d10787b, 0x3da9c10b9d10787b, 0xbd9b3bb293b6f6f3, - 0xbd9b3bb293b6f6f3, 0xbd9b3bb293b6f6f3, 0xbd9b3bb293b6f6f3, 0xbd9b3bb293b6f6f3, 0x3d9606839e712125, 0x3d9606839e712125, 0x3d9606839e712125, 0x3d9606839e712125, - 0x3d9606839e712125, 0xbdac5ba317b36361, 0xbdac5ba317b36361, 0xbdac5ba317b36361, 0xbdac5ba317b36361, 0xbdac5ba317b36361, 0xbd7dd43ff4fabaa9, 0xbd7dd43ff4fabaa9, - 0xbd7dd43ff4fabaa9, 0xbd7dd43ff4fabaa9, 0xbd7dd43ff4fabaa9, 0x3da4e6931a74b4b7, 0x3da4e6931a74b4b7, 0x3da4e6931a74b4b7, 0x3da4e6931a74b4b7, 0x3da4e6931a74b4b7, - 0xbda27851cc773f3d, 0xbda27851cc773f3d, 0xbda27851cc773f3d, 0xbda27851cc773f3d, 0xbda27851cc773f3d, 0x3d88a3253273333c, 0x3d88a3253273333c, 0x3d88a3253273333c, - 0x3d88a3253273333c, 0x3d88a3253273333c, 0x3daec9e465b0d8db, 0x3daec9e465b0d8db, 0x3daec9e465b0d8db, 0x3daec9e465b0d8db, 0xbdb09b0dcd279392, 0xbd912a0102763632, - 0xbd912a0102763632, 0xbd912a0102763632, 0xbd912a0102763632, 0xbd912a0102763632, 0x3da00c1a97d8f0f3, 0x3da00c1a97d8f0f3, 0x3da00c1a97d8f0f3, 0x3da00c1a97d8f0f3, - 0x3da00c1a97d8f0f3, 0xbda752ca4f130301, 0xbda752ca4f130301, 0xbda752ca4f130301, 0xbda752ca4f130301, 0xbda752ca4f130301, 0x3d64e50ca01090b4, 0x3d64e50ca01090b4, - 0x3d64e50ca01090b4, 0x3d64e50ca01090b4, 0x3d64e50ca01090b4, 0x3da9ef6be3151517, 0x3da9ef6be3151517, 0x3da9ef6be3151517, 0x3da9ef6be3151517, 0x3da9ef6be3151517, - 0xbd9adef207adbdb9, 0xbd9adef207adbdb9, 0xbd9adef207adbdb9, 0xbd9adef207adbdb9, 0xbd9adef207adbdb9, 0x3d9663442a7a5a5f, 0x3d9663442a7a5a5f, 0x3d9663442a7a5a5f, - 0x3d9663442a7a5a5f, 0x3d9663442a7a5a5f, 0xbdac2d42d1aec6c5, 0xbdac2d42d1aec6c5, 0xbdac2d42d1aec6c5, 0xbdac2d42d1aec6c5, 0xbdac2d42d1aec6c5, 0xbd7c613dc4d5d5c4, - 0xbd7c613dc4d5d5c4, 0xbd7c613dc4d5d5c4, 0xbd7c613dc4d5d5c4, 0xbd7c613dc4d5d5c4, 0x3da514f360795154, 0x3da514f360795154, 0x3da514f360795154, 0x3da514f360795154, - 0x3da514f360795154, 0xbda249f18672a2a0, 0xbda249f18672a2a0, 0xbda249f18672a2a0, 0xbda249f18672a2a0, 0xbda249f18672a2a0, 0x3d895ca64a85a5af, 0x3d895ca64a85a5af, - 0x3d895ca64a85a5af, 0x3d895ca64a85a5af, 0x3d895ca64a85a5af, 0x3daef844abb57578, 0x3daef844abb57578, 0x3daef844abb57578, 0x3daef844abb57578, 0xbdb083ddaa254544, - 0xbd90cd40766cfcf8, 0xbd90cd40766cfcf8, 0xbd90cd40766cfcf8, 0xbd90cd40766cfcf8, 0xbd90cd40766cfcf8, 0x3da03a7adddd8d90, 0x3da03a7adddd8d90, 0x3da03a7adddd8d90, - 0x3da03a7adddd8d90, 0x3da03a7adddd8d90, 0xbda7246a090e6664, 0xbda7246a090e6664, 0xbda7246a090e6664, 0xbda7246a090e6664, 0xbda7246a090e6664, 0x3d67cb11005a5a7f, - 0x3d67cb11005a5a7f, 0x3d67cb11005a5a7f, 0x3d67cb11005a5a7f, 0x3d67cb11005a5a7f, 0x3daa1dcc2919b1b4, 0x3daa1dcc2919b1b4, 0x3daa1dcc2919b1b4, 0x3daa1dcc2919b1b4, -] )) ), - -################ chunk 4608 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4101addb5ee28509, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, - 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, - 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101def1bdc31a31, 0x4101def1bdc31a31, 0x4101def1bdc31a31, - 0x4101def1bdc31a31, 0x4101def1bdc31a31, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101f2944a1cef74, - 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101fc659049da16, 0x4101fc659049da16, 0x4101fc659049da16, 0x4101fc659049da16, - 0x4101fc659049da15, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x410210081ca3af59, 0x410210081ca3af59, - 0x410210081ca3af59, 0x410210081ca3af59, 0x410210081ca3af59, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, - 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, - 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102411e7b844481, - 0x4102411e7b844481, 0x4102411e7b844481, 0x4102411e7b844481, 0x4102411e7b844481, 0x41024aefc1b12f22, 0x41024aefc1b12f22, 0x41024aefc1b12f22, 0x41024aefc1b12f22, - 0x41024aefc1b12f22, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x41025e924e0b0466, 0x41025e924e0b0466, - 0x41025e924e0b0466, 0x41025e924e0b0466, 0x41025e924e0b0466, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, - 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027c062091c44b, 0x41027c062091c44b, 0x41027c062091c44b, - 0x41027c062091c44b, 0x41027c062091c44a, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x41028fa8aceb998e, - 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41029979f318842f, 0x41029979f318842f, 0x41029979f318842f, 0x41029979f318842f, - 0x41029979f318842f, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102ad1c7f725973, 0x4102ad1c7f725973, - 0x4102ad1c7f725973, 0x4102ad1c7f725973, 0x4102ad1c7f725973, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, - 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102ca9051f91957, 0x4102ca9051f91957, 0x4102ca9051f91957, - 0x4102ca9051f91957, 0x4102ca9051f91957, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102de32de52ee9b, - 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102e804247fd93c, 0x4102e804247fd93c, 0x4102e804247fd93c, 0x4102e804247fd93c, - 0x4102e804247fd93c, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae80, - 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae7f, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, - 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x4103191a83606e64, 0x4103191a83606e64, 0x4103191a83606e64, - 0x4103191a83606e64, 0x4103191a83606e64, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x41032cbd0fba43a8, - 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x4103368e55e72e49, 0x4103368e55e72e49, 0x4103368e55e72e49, 0x4103368e55e72e49, - 0x4103368e55e72e49, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x41034a30e241038c, 0x41034a30e241038c, - 0x41034a30e241038c, 0x41034a30e241038c, 0x41034a30e241038c, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, - 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x410367a4b4c7c371, 0x410367a4b4c7c371, 0x410367a4b4c7c371, - 0x410367a4b4c7c371, 0x410367a4b4c7c371, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037b47412198b5, - 0x41037b47412198b5, 0x41037b47412198b5, 0x41037b47412198b5, 0x41037b47412198b4, 0x41038518874e8356, 0x41038518874e8356, 0x41038518874e8356, 0x41038518874e8356, - 0x41038518874e8356, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x410398bb13a85899, 0x410398bb13a85899, - 0x410398bb13a85899, 0x410398bb13a85899, 0x410398bb13a85899, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3daa1dcc2919b1b4, 0xbd9a82317ba48480, 0xbd9a82317ba48480, 0xbd9a82317ba48480, 0xbd9a82317ba48480, 0xbd9a82317ba48480, 0x3d96c004b6839398, 0x3d96c004b6839398, - 0x3d96c004b6839398, 0x3d96c004b6839398, 0x3d96c004b6839398, 0xbdabfee28baa2a28, 0xbdabfee28baa2a28, 0xbdabfee28baa2a28, 0xbdabfee28baa2a28, 0xbdabfee28baa2a28, - 0xbd7aee3b94b0f0df, 0xbd7aee3b94b0f0df, 0xbd7aee3b94b0f0df, 0xbd7aee3b94b0f0df, 0xbd7aee3b94b0f0df, 0x3da54353a67dedf0, 0x3da54353a67dedf0, 0x3da54353a67dedf0, - 0x3da54353a67dedf0, 0x3da54353a67dedf0, 0xbda21b91406e0604, 0xbda21b91406e0604, 0xbda21b91406e0604, 0xbda21b91406e0604, 0xbda21b91406e0604, 0x3d8a162762981821, - 0x3d8a162762981821, 0x3d8a162762981821, 0x3d8a162762981821, 0x3d8a162762981821, 0x3daf26a4f1ba1214, 0x3daf26a4f1ba1214, 0x3daf26a4f1ba1214, 0x3daf26a4f1ba1214, - 0xbdb06cad8722f6f6, 0xbd90707fea63c3bf, 0xbd90707fea63c3bf, 0xbd90707fea63c3bf, 0xbd90707fea63c3bf, 0xbd90707fea63c3bf, 0x3da068db23e22a2c, 0x3da068db23e22a2c, - 0x3da068db23e22a2c, 0x3da068db23e22a2c, 0x3da068db23e22a2c, 0xbda6f609c309c9c7, 0xbda6f609c309c9c7, 0xbda6f609c309c9c7, 0xbda6f609c309c9c7, 0xbda6f609c309c9c7, - 0x3d6ab11560a4244a, 0x3d6ab11560a4244a, 0x3d6ab11560a4244a, 0x3d6ab11560a4244a, 0x3d6ab11560a4244a, 0x3daa4c2c6f1e4e51, 0x3daa4c2c6f1e4e51, 0x3daa4c2c6f1e4e51, - 0x3daa4c2c6f1e4e51, 0x3daa4c2c6f1e4e51, 0xbd9a2570ef9b4b47, 0xbd9a2570ef9b4b47, 0xbd9a2570ef9b4b47, 0xbd9a2570ef9b4b47, 0xbd9a2570ef9b4b47, 0x3d971cc5428cccd2, - 0x3d971cc5428cccd2, 0x3d971cc5428cccd2, 0x3d971cc5428cccd2, 0x3d971cc5428cccd2, 0xbdabd08245a58d8b, 0xbdabd08245a58d8b, 0xbdabd08245a58d8b, 0xbdabd08245a58d8b, - 0xbdabd08245a58d8b, 0xbd797b39648c0bf9, 0xbd797b39648c0bf9, 0xbd797b39648c0bf9, 0xbd797b39648c0bf9, 0xbd797b39648c0bf9, 0x3da571b3ec828a8d, 0x3da571b3ec828a8d, - 0x3da571b3ec828a8d, 0x3da571b3ec828a8d, 0x3da571b3ec828a8d, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, - 0x3d8acfa87aaa8a94, 0x3d8acfa87aaa8a94, 0x3d8acfa87aaa8a94, 0x3d8acfa87aaa8a94, 0x3d8acfa87aaa8a94, 0x3daf550537beaeb1, 0x3daf550537beaeb1, 0x3daf550537beaeb1, - 0x3daf550537beaeb1, 0xbdb0557d6420a8a7, 0xbd9013bf5e5a8a86, 0xbd9013bf5e5a8a86, 0xbd9013bf5e5a8a86, 0xbd9013bf5e5a8a86, 0xbd9013bf5e5a8a86, 0x3da0973b69e6c6c9, - 0x3da0973b69e6c6c9, 0x3da0973b69e6c6c9, 0x3da0973b69e6c6c9, 0x3da0973b69e6c6c9, 0xbda6c7a97d052d2b, 0xbda6c7a97d052d2b, 0xbda6c7a97d052d2b, 0xbda6c7a97d052d2b, - 0xbda6c7a97d052d2b, 0x3d6d9719c0edee14, 0x3d6d9719c0edee14, 0x3d6d9719c0edee14, 0x3d6d9719c0edee14, 0x3d6d9719c0edee14, 0x3daa7a8cb522eaed, 0x3daa7a8cb522eaed, - 0x3daa7a8cb522eaed, 0x3daa7a8cb522eaed, 0x3daa7a8cb522eaed, 0xbd99c8b06392120d, 0xbd99c8b06392120d, 0xbd99c8b06392120d, 0xbd99c8b06392120d, 0xbd99c8b06392120d, - 0x3d977985ce96060b, 0x3d977985ce96060b, 0x3d977985ce96060b, 0x3d977985ce96060b, 0x3d977985ce96060b, 0xbdaba221ffa0f0ef, 0xbdaba221ffa0f0ef, 0xbdaba221ffa0f0ef, - 0xbdaba221ffa0f0ef, 0xbdaba221ffa0f0ef, 0xbd78083734672714, 0xbd78083734672714, 0xbd78083734672714, 0xbd78083734672714, 0xbd78083734672714, 0x3da5a0143287272a, - 0x3da5a0143287272a, 0x3da5a0143287272a, 0x3da5a0143287272a, 0x3da5a0143287272a, 0xbda1bed0b464ccca, 0xbda1bed0b464ccca, 0xbda1bed0b464ccca, 0xbda1bed0b464ccca, - 0xbda1bed0b464ccca, 0x3d8b892992bcfd07, 0x3d8b892992bcfd07, 0x3d8b892992bcfd07, 0x3d8b892992bcfd07, 0x3d8b892992bcfd07, 0x3daf83657dc34b4e, 0x3daf83657dc34b4e, - 0x3daf83657dc34b4e, 0x3daf83657dc34b4e, 0xbdb03e4d411e5a59, 0xbd8f6dfda4a2a299, 0xbd8f6dfda4a2a299, 0xbd8f6dfda4a2a299, 0xbd8f6dfda4a2a299, 0xbd8f6dfda4a2a299, - 0x3da0c59bafeb6366, 0x3da0c59bafeb6366, 0x3da0c59bafeb6366, 0x3da0c59bafeb6366, 0x3da0c59bafeb6366, 0xbda699493700908e, 0xbda699493700908e, 0xbda699493700908e, - 0xbda699493700908e, 0xbda699493700908e, 0x3d703e8f109bdbf0, 0x3d703e8f109bdbf0, 0x3d703e8f109bdbf0, 0x3d703e8f109bdbf0, 0x3d703e8f109bdbf0, 0x3daaa8ecfb27878a, - 0x3daaa8ecfb27878a, 0x3daaa8ecfb27878a, 0x3daaa8ecfb27878a, 0x3daaa8ecfb27878a, 0xbd996befd788d8d4, 0xbd996befd788d8d4, 0xbd996befd788d8d4, 0xbd996befd788d8d4, - 0xbd996befd788d8d4, 0x3d97d6465a9f3f44, 0x3d97d6465a9f3f44, 0x3d97d6465a9f3f44, 0x3d97d6465a9f3f44, 0x3d97d6465a9f3f44, 0xbdab73c1b99c5452, 0xbdab73c1b99c5452, - 0xbdab73c1b99c5452, 0xbdab73c1b99c5452, 0xbdab73c1b99c5452, 0xbd7695350442422e, 0xbd7695350442422e, 0xbd7695350442422e, 0xbd7695350442422e, 0xbd7695350442422e, - 0x3da5ce74788bc3c6, 0x3da5ce74788bc3c6, 0x3da5ce74788bc3c6, 0x3da5ce74788bc3c6, 0x3da5ce74788bc3c6, 0xbda190706e60302e, 0xbda190706e60302e, 0xbda190706e60302e, - 0xbda190706e60302e, 0xbda190706e60302e, 0x3d8c42aaaacf6f79, 0x3d8c42aaaacf6f79, 0x3d8c42aaaacf6f79, 0x3d8c42aaaacf6f79, 0x3d8c42aaaacf6f79, 0x3dafb1c5c3c7e7ea, - 0x3dafb1c5c3c7e7ea, 0x3dafb1c5c3c7e7ea, 0x3dafb1c5c3c7e7ea, 0xbdb0271d1e1c0c0b, 0xbd8eb47c8c903026, 0xbd8eb47c8c903026, 0xbd8eb47c8c903026, 0xbd8eb47c8c903026, - 0xbd8eb47c8c903026, 0x3da0f3fbf5f00003, 0x3da0f3fbf5f00003, 0x3da0f3fbf5f00003, 0x3da0f3fbf5f00003, 0x3da0f3fbf5f00003, 0xbda66ae8f0fbf3f1, 0xbda66ae8f0fbf3f1, - 0xbda66ae8f0fbf3f1, 0xbda66ae8f0fbf3f1, 0xbda66ae8f0fbf3f1, 0x3d71b19140c0c0d5, 0x3d71b19140c0c0d5, 0x3d71b19140c0c0d5, 0x3d71b19140c0c0d5, 0x3d71b19140c0c0d5, -] )) ), - -################ chunk 5120 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103b62ee62f187e, 0x4103b62ee62f187e, 0x4103b62ee62f187e, - 0x4103b62ee62f187e, 0x4103b62ee62f187e, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c9d17288edc1, - 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, - 0x4103d3a2b8b5d863, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103e745450fada6, 0x4103e745450fada6, - 0x4103e745450fada6, 0x4103e745450fada6, 0x4103e745450fada6, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, - 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982e9, 0x410404b917966d8b, 0x410404b917966d8b, 0x410404b917966d8b, - 0x410404b917966d8b, 0x410404b917966d8b, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x4104185ba3f042ce, - 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104222cea1d2d70, 0x4104222cea1d2d70, 0x4104222cea1d2d70, 0x4104222cea1d2d70, - 0x4104222cea1d2d70, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x410435cf767702b3, 0x410435cf767702b3, - 0x410435cf767702b3, 0x410435cf767702b3, 0x410435cf767702b3, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, - 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104534348fdc298, 0x4104534348fdc298, 0x4104534348fdc298, - 0x4104534348fdc298, 0x4104534348fdc298, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x410466e5d55797db, - 0x410466e5d55797db, 0x410466e5d55797db, 0x410466e5d55797db, 0x410466e5d55797db, 0x410470b71b84827d, 0x410470b71b84827d, 0x410470b71b84827d, 0x410470b71b84827d, - 0x410470b71b84827d, 0x41047a8861b16d1e, 0x41047a8861b16d1e, 0x41047a8861b16d1e, 0x41047a8861b16d1f, 0x41047a8861b16d1e, 0x41048459a7de57c0, 0x41048459a7de57c0, - 0x41048459a7de57c0, 0x41048459a7de57c0, 0x41048459a7de57c0, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, - 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, - 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104b57006beece8, - 0x4104b57006beece8, 0x4104b57006beece8, 0x4104b57006beece8, 0x4104b57006beece8, 0x4104bf414cebd78a, 0x4104bf414cebd78a, 0x4104bf414cebd78a, 0x4104bf414cebd78a, - 0x4104bf414cebd78a, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104d2e3d945accd, 0x4104d2e3d945accd, - 0x4104d2e3d945accd, 0x4104d2e3d945accd, 0x4104d2e3d945accd, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, - 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, - 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, 0x4104fa28f1f95753, 0x4104fa28f1f95753, 0x4104fa28f1f95753, 0x4104fa28f1f95754, 0x4104fa28f1f95753, 0x410503fa382641f5, - 0x410503fa382641f5, 0x410503fa382641f5, 0x410503fa382641f5, 0x410503fa382641f5, 0x41050dcb7e532c97, 0x41050dcb7e532c97, 0x41050dcb7e532c97, 0x41050dcb7e532c97, - 0x41050dcb7e532c97, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105216e0aad01da, 0x4105216e0aad01da, - 0x4105216e0aad01da, 0x4105216e0aad01da, 0x4105216e0aad01da, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, - 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, - 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x41055284698d9702, - 0x41055284698d9702, 0x41055284698d9702, 0x41055284698d9702, 0x41055284698d9702, 0x41055c55afba81a4, 0x41055c55afba81a4, 0x41055c55afba81a4, 0x41055c55afba81a4, - 0x41055c55afba81a4, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056ff83c1456e7, 0x41056ff83c1456e7, - 0x41056ff83c1456e7, 0x41056ff83c1456e7, 0x41056ff83c1456e7, 0x410579c982414188, 0x410579c982414188, 0x410579c982414188, 0x410579c982414189, 0x410579c982414188, - 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, - 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105a10e9af4ec0f, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3daad74d412c2427, 0x3daad74d412c2427, 0x3daad74d412c2427, 0x3daad74d412c2427, 0x3daad74d412c2427, 0xbd990f2f4b7f9f9b, 0xbd990f2f4b7f9f9b, 0xbd990f2f4b7f9f9b, - 0xbd990f2f4b7f9f9b, 0xbd990f2f4b7f9f9b, 0x3d983306e6a8787e, 0x3d983306e6a8787e, 0x3d983306e6a8787e, 0x3d983306e6a8787e, 0x3d983306e6a8787e, 0xbdab45617397b7b5, - 0xbdab45617397b7b5, 0xbdab45617397b7b5, 0xbdab45617397b7b5, 0xbdab45617397b7b5, 0xbd752232d41d5d49, 0xbd752232d41d5d49, 0xbd752232d41d5d49, 0xbd752232d41d5d49, - 0xbd752232d41d5d49, 0x3da5fcd4be906063, 0x3da5fcd4be906063, 0x3da5fcd4be906063, 0x3da5fcd4be906063, 0x3da5fcd4be906063, 0xbda16210285b9391, 0xbda16210285b9391, - 0xbda16210285b9391, 0xbda16210285b9391, 0xbda16210285b9391, 0x3d8cfc2bc2e1e1ec, 0x3d8cfc2bc2e1e1ec, 0x3d8cfc2bc2e1e1ec, 0x3d8cfc2bc2e1e1ec, 0x3d8cfc2bc2e1e1ec, - 0x3dafe02609cc8487, 0x3dafe02609cc8487, 0x3dafe02609cc8487, 0x3dafe02609cc8487, 0xbdb00fecfb19bdbc, 0xbd8dfafb747dbdb3, 0xbd8dfafb747dbdb3, 0xbd8dfafb747dbdb3, - 0xbd8dfafb747dbdb3, 0xbd8dfafb747dbdb3, 0x3da1225c3bf49c9f, 0x3da1225c3bf49c9f, 0x3da1225c3bf49c9f, 0x3da1225c3bf49c9f, 0x3da1225c3bf49c9f, 0xbda63c88aaf75755, - 0xbda63c88aaf75755, 0xbda63c88aaf75755, 0xbda63c88aaf75755, 0xbda63c88aaf75755, 0x3d73249370e5a5ba, 0x3d73249370e5a5ba, 0x3d73249370e5a5ba, 0x3d73249370e5a5ba, - 0x3d73249370e5a5ba, 0x3dab05ad8730c0c3, 0x3dab05ad8730c0c3, 0x3dab05ad8730c0c3, 0x3dab05ad8730c0c3, 0x3dab05ad8730c0c3, 0xbd98b26ebf766661, 0xbd98b26ebf766661, - 0xbd98b26ebf766661, 0xbd98b26ebf766661, 0xbd98b26ebf766661, 0x3d988fc772b1b1b7, 0x3d988fc772b1b1b7, 0x3d988fc772b1b1b7, 0x3d988fc772b1b1b7, 0x3d988fc772b1b1b7, - 0xbdab17012d931b18, 0xbdab17012d931b18, 0xbdab17012d931b18, 0xbdab17012d931b18, 0xbdab17012d931b18, 0xbd73af30a3f87864, 0xbd73af30a3f87864, 0xbd73af30a3f87864, - 0xbd73af30a3f87864, 0xbd73af30a3f87864, 0x3da62b350494fd00, 0x3da62b350494fd00, 0x3da62b350494fd00, 0x3da62b350494fd00, 0x3da62b350494fd00, 0xbda133afe256f6f4, - 0xbda133afe256f6f4, 0xbda133afe256f6f4, 0xbda133afe256f6f4, 0xbda133afe256f6f4, 0x3d8db5acdaf4545f, 0x3d8db5acdaf4545f, 0x3d8db5acdaf4545f, 0x3d8db5acdaf4545f, - 0x3d8db5acdaf4545f, 0xbdaff179b02ededc, 0xbdaff179b02ededc, 0xbdaff179b02ededc, 0x3db0074327e89092, 0xbdaff179b02ededc, 0xbd8d417a5c6b4b41, 0xbd8d417a5c6b4b41, - 0xbd8d417a5c6b4b41, 0xbd8d417a5c6b4b41, 0xbd8d417a5c6b4b41, 0x3da150bc81f9393c, 0x3da150bc81f9393c, 0x3da150bc81f9393c, 0x3da150bc81f9393c, 0x3da150bc81f9393c, - 0xbda60e2864f2bab8, 0xbda60e2864f2bab8, 0xbda60e2864f2bab8, 0xbda60e2864f2bab8, 0xbda60e2864f2bab8, 0x3d749795a10a8aa0, 0x3d749795a10a8aa0, 0x3d749795a10a8aa0, - 0x3d749795a10a8aa0, 0x3d749795a10a8aa0, 0x3dab340dcd355d60, 0x3dab340dcd355d60, 0x3dab340dcd355d60, 0x3dab340dcd355d60, 0x3dab340dcd355d60, 0xbd9855ae336d2d28, - 0xbd9855ae336d2d28, 0xbd9855ae336d2d28, 0xbd9855ae336d2d28, 0xbd9855ae336d2d28, 0x3d98ec87febaeaf0, 0x3d98ec87febaeaf0, 0x3d98ec87febaeaf0, 0x3d98ec87febaeaf0, - 0x3d98ec87febaeaf0, 0xbdaae8a0e78e7e7c, 0xbdaae8a0e78e7e7c, 0xbdaae8a0e78e7e7c, 0xbdaae8a0e78e7e7c, 0xbdaae8a0e78e7e7c, 0xbd723c2e73d3937e, 0xbd723c2e73d3937e, - 0xbd723c2e73d3937e, 0xbd723c2e73d3937e, 0xbd723c2e73d3937e, 0x3da659954a99999c, 0x3da659954a99999c, 0x3da659954a99999c, 0x3da659954a99999c, 0x3da659954a99999c, - 0xbda1054f9c525a58, 0xbda1054f9c525a58, 0xbda1054f9c525a58, 0xbda1054f9c525a58, 0xbda1054f9c525a58, 0x3d8e6f2df306c6d2, 0x3d8e6f2df306c6d2, 0x3d8e6f2df306c6d2, - 0x3d8e6f2df306c6d2, 0x3d8e6f2df306c6d2, 0xbdafc3196a2a4240, 0xbdafc3196a2a4240, 0xbdafc3196a2a4240, 0x3db01e734aeadee0, 0xbdafc3196a2a4240, 0xbd8c87f94458d8ce, - 0xbd8c87f94458d8ce, 0xbd8c87f94458d8ce, 0xbd8c87f94458d8ce, 0xbd8c87f94458d8ce, 0x3da17f1cc7fdd5d9, 0x3da17f1cc7fdd5d9, 0x3da17f1cc7fdd5d9, 0x3da17f1cc7fdd5d9, - 0x3da17f1cc7fdd5d9, 0xbda5dfc81eee1e1b, 0xbda5dfc81eee1e1b, 0xbda5dfc81eee1e1b, 0xbda5dfc81eee1e1b, 0xbda5dfc81eee1e1b, 0x3d760a97d12f6f85, 0x3d760a97d12f6f85, - 0x3d760a97d12f6f85, 0x3d760a97d12f6f85, 0x3d760a97d12f6f85, 0x3dab626e1339f9fd, 0x3dab626e1339f9fd, 0x3dab626e1339f9fd, 0x3dab626e1339f9fd, 0x3dab626e1339f9fd, - 0xbd97f8eda763f3ee, 0xbd97f8eda763f3ee, 0xbd97f8eda763f3ee, 0xbd97f8eda763f3ee, 0xbd97f8eda763f3ee, 0x3d9949488ac4242a, 0x3d9949488ac4242a, 0x3d9949488ac4242a, - 0x3d9949488ac4242a, 0x3d9949488ac4242a, 0xbdaaba40a189e1df, 0xbdaaba40a189e1df, 0xbdaaba40a189e1df, 0xbdaaba40a189e1df, 0xbdaaba40a189e1df, 0xbd70c92c43aeae99, - 0xbd70c92c43aeae99, 0xbd70c92c43aeae99, 0xbd70c92c43aeae99, 0xbd70c92c43aeae99, 0x3da687f5909e3639, 0x3da687f5909e3639, 0x3da687f5909e3639, 0x3da687f5909e3639, - 0x3da687f5909e3639, 0xbda0d6ef564dbdbb, 0xbda0d6ef564dbdbb, 0xbda0d6ef564dbdbb, 0xbda0d6ef564dbdbb, 0xbda0d6ef564dbdbb, 0x3d8f28af0b193944, 0x3d8f28af0b193944, - 0x3d8f28af0b193944, 0x3d8f28af0b193944, 0x3d8f28af0b193944, 0xbdaf94b92425a5a3, 0xbdaf94b92425a5a3, 0xbdaf94b92425a5a3, 0x3db035a36ded2d2f, 0xbdaf94b92425a5a3, - 0xbd8bce782c46665b, 0xbd8bce782c46665b, 0xbd8bce782c46665b, 0xbd8bce782c46665b, 0xbd8bce782c46665b, 0x3da1ad7d0e027275, 0x3da1ad7d0e027275, 0x3da1ad7d0e027275, - 0x3da1ad7d0e027275, 0x3da1ad7d0e027275, 0xbda5b167d8e9817f, 0xbda5b167d8e9817f, 0xbda5b167d8e9817f, 0xbda5b167d8e9817f, 0xbda5b167d8e9817f, 0x3d777d9a0154546b, -] )) ), - -################ chunk 5632 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, - 0x4105aadfe121d6b1, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105be826d7babf4, 0x4105be826d7babf4, - 0x4105be826d7babf4, 0x4105be826d7babf4, 0x4105be826d7babf4, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, - 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105dbf640026bd9, 0x4105dbf640026bd9, 0x4105dbf640026bd9, - 0x4105dbf640026bd9, 0x4105dbf640026bd9, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105ef98cc5c411c, - 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105f96a12892bbd, 0x4105f96a12892bbd, 0x4105f96a12892bbd, 0x4105f96a12892bbe, - 0x4105f96a12892bbd, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x41060d0c9ee30101, 0x41060d0c9ee30101, - 0x41060d0c9ee30101, 0x41060d0c9ee30101, 0x41060d0c9ee30101, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, - 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x41062a807169c0e6, 0x41062a807169c0e6, 0x41062a807169c0e6, - 0x41062a807169c0e6, 0x41062a807169c0e6, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063e22fdc39629, - 0x41063e22fdc39629, 0x41063e22fdc39629, 0x41063e22fdc39629, 0x41063e22fdc39629, 0x410647f443f080ca, 0x410647f443f080ca, 0x410647f443f080ca, 0x410647f443f080ca, - 0x410647f443f080ca, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x41065b96d04a560e, 0x41065b96d04a560e, - 0x41065b96d04a560e, 0x41065b96d04a560e, 0x41065b96d04a560e, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, - 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x4106790aa2d115f2, 0x4106790aa2d115f2, 0x4106790aa2d115f2, - 0x4106790aa2d115f3, 0x4106790aa2d115f2, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x41068cad2f2aeb36, - 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x4106967e7557d5d7, 0x4106967e7557d5d7, 0x4106967e7557d5d7, 0x4106967e7557d5d7, - 0x4106967e7557d5d7, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, - 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, - 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106c794d4386aff, 0x4106c794d4386aff, 0x4106c794d4386aff, - 0x4106c794d4386aff, 0x4106c794d4386aff, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106db3760924043, - 0x4106db3760924043, 0x4106db3760924043, 0x4106db3760924043, 0x4106db3760924043, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, - 0x4106e508a6bf2ae4, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106f8ab33190027, 0x4106f8ab33190027, - 0x4106f8ab33190027, 0x4106f8ab33190028, 0x4106f8ab33190027, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, - 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x4107161f059fc00c, 0x4107161f059fc00c, 0x4107161f059fc00c, - 0x4107161f059fc00c, 0x4107161f059fc00c, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x410729c191f99550, - 0x410729c191f99550, 0x410729c191f99550, 0x410729c191f99550, 0x410729c191f99550, 0x41073392d8267ff1, 0x41073392d8267ff1, 0x41073392d8267ff1, 0x41073392d8267ff1, - 0x41073392d8267ff1, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x4107473564805534, 0x4107473564805534, - 0x4107473564805534, 0x4107473564805534, 0x4107473564805534, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, - 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x410764a937071519, 0x410764a937071519, 0x410764a937071519, - 0x410764a937071519, 0x410764a937071519, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x4107784bc360ea5c, - 0x4107784bc360ea5c, 0x4107784bc360ea5c, 0x4107784bc360ea5d, 0x4107784bc360ea5c, 0x4107821d098dd4fe, 0x4107821d098dd4fe, 0x4107821d098dd4fe, 0x4107821d098dd4fe, - 0x4107821d098dd4fe, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x410795bf95e7aa41, 0x410795bf95e7aa41, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d777d9a0154546b, 0x3d777d9a0154546b, 0x3d777d9a0154546b, 0x3d777d9a0154546b, 0x3dab90ce593e9699, 0x3dab90ce593e9699, 0x3dab90ce593e9699, 0x3dab90ce593e9699, - 0x3dab90ce593e9699, 0xbd979c2d1b5abab5, 0xbd979c2d1b5abab5, 0xbd979c2d1b5abab5, 0xbd979c2d1b5abab5, 0xbd979c2d1b5abab5, 0x3d99a60916cd5d63, 0x3d99a60916cd5d63, - 0x3d99a60916cd5d63, 0x3d99a60916cd5d63, 0x3d99a60916cd5d63, 0xbdaa8be05b854542, 0xbdaa8be05b854542, 0xbdaa8be05b854542, 0xbdaa8be05b854542, 0xbdaa8be05b854542, - 0xbd6eac5427139367, 0xbd6eac5427139367, 0xbd6eac5427139367, 0xbd6eac5427139367, 0xbd6eac5427139367, 0x3da6b655d6a2d2d6, 0x3da6b655d6a2d2d6, 0x3da6b655d6a2d2d6, - 0x3da6b655d6a2d2d6, 0x3da6b655d6a2d2d6, 0xbda0a88f1049211e, 0xbda0a88f1049211e, 0xbda0a88f1049211e, 0xbda0a88f1049211e, 0xbda0a88f1049211e, 0x3d8fe230232babb7, - 0x3d8fe230232babb7, 0x3d8fe230232babb7, 0x3d8fe230232babb7, 0x3d8fe230232babb7, 0xbdaf6658de210906, 0xbdaf6658de210906, 0xbdaf6658de210906, 0x3db04cd390ef7b7d, - 0xbdaf6658de210906, 0xbd8b14f71433f3e9, 0xbd8b14f71433f3e9, 0xbd8b14f71433f3e9, 0xbd8b14f71433f3e9, 0xbd8b14f71433f3e9, 0x3da1dbdd54070f12, 0x3da1dbdd54070f12, - 0x3da1dbdd54070f12, 0x3da1dbdd54070f12, 0x3da1dbdd54070f12, 0xbda5830792e4e4e2, 0xbda5830792e4e4e2, 0xbda5830792e4e4e2, 0xbda5830792e4e4e2, 0xbda5830792e4e4e2, - 0x3d78f09c31793950, 0x3d78f09c31793950, 0x3d78f09c31793950, 0x3d78f09c31793950, 0x3d78f09c31793950, 0x3dabbf2e9f433336, 0x3dabbf2e9f433336, 0x3dabbf2e9f433336, - 0x3dabbf2e9f433336, 0x3dabbf2e9f433336, 0xbd973f6c8f51817c, 0xbd973f6c8f51817c, 0xbd973f6c8f51817c, 0xbd973f6c8f51817c, 0xbd973f6c8f51817c, 0x3d9a02c9a2d6969c, - 0x3d9a02c9a2d6969c, 0x3d9a02c9a2d6969c, 0x3d9a02c9a2d6969c, 0x3d9a02c9a2d6969c, 0xbdaa5d801580a8a6, 0xbdaa5d801580a8a6, 0xbdaa5d801580a8a6, 0xbdaa5d801580a8a6, - 0xbdaa5d801580a8a6, 0xbd6bc64fc6c9c99c, 0xbd6bc64fc6c9c99c, 0xbd6bc64fc6c9c99c, 0xbd6bc64fc6c9c99c, 0xbd6bc64fc6c9c99c, 0x3da6e4b61ca76f72, 0x3da6e4b61ca76f72, - 0x3da6e4b61ca76f72, 0x3da6e4b61ca76f72, 0x3da6e4b61ca76f72, 0xbda07a2eca448482, 0xbda07a2eca448482, 0xbda07a2eca448482, 0xbda07a2eca448482, 0xbda07a2eca448482, - 0x3d904dd89d9f0f15, 0x3d904dd89d9f0f15, 0x3d904dd89d9f0f15, 0x3d904dd89d9f0f15, 0x3d904dd89d9f0f15, 0xbdaf37f8981c6c6a, 0xbdaf37f8981c6c6a, 0xbdaf37f8981c6c6a, - 0x3db06403b3f1c9cb, 0xbdaf37f8981c6c6a, 0xbd8a5b75fc218176, 0xbd8a5b75fc218176, 0xbd8a5b75fc218176, 0xbd8a5b75fc218176, 0xbd8a5b75fc218176, 0x3da20a3d9a0babaf, - 0x3da20a3d9a0babaf, 0x3da20a3d9a0babaf, 0x3da20a3d9a0babaf, 0x3da20a3d9a0babaf, 0xbda554a74ce04845, 0xbda554a74ce04845, 0xbda554a74ce04845, 0xbda554a74ce04845, - 0xbda554a74ce04845, 0x3d7a639e619e1e35, 0x3d7a639e619e1e35, 0x3d7a639e619e1e35, 0x3d7a639e619e1e35, 0x3d7a639e619e1e35, 0x3dabed8ee547cfd3, 0x3dabed8ee547cfd3, - 0x3dabed8ee547cfd3, 0x3dabed8ee547cfd3, 0x3dabed8ee547cfd3, 0xbd96e2ac03484842, 0xbd96e2ac03484842, 0xbd96e2ac03484842, 0xbd96e2ac03484842, 0xbd96e2ac03484842, - 0x3d9a5f8a2edfcfd6, 0x3d9a5f8a2edfcfd6, 0x3d9a5f8a2edfcfd6, 0x3d9a5f8a2edfcfd6, 0x3d9a5f8a2edfcfd6, 0xbdaa2f1fcf7c0c09, 0xbdaa2f1fcf7c0c09, 0xbdaa2f1fcf7c0c09, - 0xbdaa2f1fcf7c0c09, 0xbdaa2f1fcf7c0c09, 0xbd68e04b667fffd1, 0xbd68e04b667fffd1, 0xbd68e04b667fffd1, 0xbd68e04b667fffd1, 0xbd68e04b667fffd1, 0x3da7131662ac0c0f, - 0x3da7131662ac0c0f, 0x3da7131662ac0c0f, 0x3da7131662ac0c0f, 0x3da7131662ac0c0f, 0xbda04bce843fe7e5, 0xbda04bce843fe7e5, 0xbda04bce843fe7e5, 0xbda04bce843fe7e5, - 0xbda04bce843fe7e5, 0x3d90aa9929a8484e, 0x3d90aa9929a8484e, 0x3d90aa9929a8484e, 0x3d90aa9929a8484e, 0x3d90aa9929a8484e, 0xbdaf09985217cfcd, 0xbdaf09985217cfcd, - 0xbdaf09985217cfcd, 0x3db07b33d6f4181a, 0xbdaf09985217cfcd, 0xbd89a1f4e40f0f03, 0xbd89a1f4e40f0f03, 0xbd89a1f4e40f0f03, 0xbd89a1f4e40f0f03, 0xbd89a1f4e40f0f03, - 0x3da2389de010484b, 0x3da2389de010484b, 0x3da2389de010484b, 0x3da2389de010484b, 0x3da2389de010484b, 0xbda5264706dbaba9, 0xbda5264706dbaba9, 0xbda5264706dbaba9, - 0xbda5264706dbaba9, 0xbda5264706dbaba9, 0x3d7bd6a091c3031b, 0x3d7bd6a091c3031b, 0x3d7bd6a091c3031b, 0x3d7bd6a091c3031b, 0x3d7bd6a091c3031b, 0x3dac1bef2b4c6c6f, - 0x3dac1bef2b4c6c6f, 0x3dac1bef2b4c6c6f, 0x3dac1bef2b4c6c6f, 0x3dac1bef2b4c6c6f, 0xbd9685eb773f0f09, 0xbd9685eb773f0f09, 0xbd9685eb773f0f09, 0xbd9685eb773f0f09, - 0xbd9685eb773f0f09, 0x3d9abc4abae9090f, 0x3d9abc4abae9090f, 0x3d9abc4abae9090f, 0x3d9abc4abae9090f, 0x3d9abc4abae9090f, 0xbdaa00bf89776f6c, 0xbdaa00bf89776f6c, - 0xbdaa00bf89776f6c, 0xbdaa00bf89776f6c, 0xbdaa00bf89776f6c, 0xbd65fa4706363606, 0xbd65fa4706363606, 0xbd65fa4706363606, 0xbd65fa4706363606, 0xbd65fa4706363606, - 0x3da74176a8b0a8ac, 0x3da74176a8b0a8ac, 0x3da74176a8b0a8ac, 0x3da74176a8b0a8ac, 0x3da74176a8b0a8ac, 0xbda01d6e3e3b4b48, 0xbda01d6e3e3b4b48, 0xbda01d6e3e3b4b48, - 0xbda01d6e3e3b4b48, 0xbda01d6e3e3b4b48, 0x3d910759b5b18188, 0x3d910759b5b18188, 0x3d910759b5b18188, 0x3d910759b5b18188, 0x3d910759b5b18188, 0xbdaedb380c133330, - 0xbdaedb380c133330, 0xbdaedb380c133330, 0x3db09263f9f66668, 0xbdaedb380c133330, 0xbd88e873cbfc9c90, 0xbd88e873cbfc9c90, 0xbd88e873cbfc9c90, 0xbd88e873cbfc9c90, - 0xbd88e873cbfc9c90, 0x3da266fe2614e4e8, 0x3da266fe2614e4e8, 0x3da266fe2614e4e8, 0x3da266fe2614e4e8, 0x3da266fe2614e4e8, 0xbda4f7e6c0d70f0c, 0xbda4f7e6c0d70f0c, -] )) ), - -################ chunk 6144 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x410795bf95e7aa41, 0x410795bf95e7aa41, 0x410795bf95e7aa41, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, - 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107b333686e6a26, 0x4107b333686e6a26, 0x4107b333686e6a26, - 0x4107b333686e6a26, 0x4107b333686e6a26, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107c6d5f4c83f69, - 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, - 0x4107d0a73af52a0b, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107e449c74eff4e, 0x4107e449c74eff4e, - 0x4107e449c74eff4e, 0x4107e449c74eff4e, 0x4107e449c74eff4e, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, - 0x4107f7ec53a8d491, 0x4107f7ec53a8d491, 0x4107f7ec53a8d491, 0x4107f7ec53a8d492, 0x4107f7ec53a8d491, 0x410801bd99d5bf33, 0x410801bd99d5bf33, 0x410801bd99d5bf33, - 0x410801bd99d5bf33, 0x410801bd99d5bf33, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41081560262f9476, - 0x41081560262f9476, 0x41081560262f9476, 0x41081560262f9476, 0x41081560262f9476, 0x41081f316c5c7f18, 0x41081f316c5c7f18, 0x41081f316c5c7f18, 0x41081f316c5c7f18, - 0x41081f316c5c7f18, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x410832d3f8b6545b, 0x410832d3f8b6545b, - 0x410832d3f8b6545b, 0x410832d3f8b6545b, 0x410832d3f8b6545b, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, - 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x41085047cb3d1440, 0x41085047cb3d1440, 0x41085047cb3d1440, - 0x41085047cb3d1440, 0x41085047cb3d1440, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x410863ea5796e983, - 0x410863ea5796e983, 0x410863ea5796e983, 0x410863ea5796e983, 0x410863ea5796e983, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, - 0x41086dbb9dc3d425, 0x4108778ce3f0bec6, 0x4108778ce3f0bec6, 0x4108778ce3f0bec6, 0x4108778ce3f0bec7, 0x4108778ce3f0bec6, 0x4108815e2a1da968, 0x4108815e2a1da968, - 0x4108815e2a1da968, 0x4108815e2a1da968, 0x4108815e2a1da968, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, - 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089ed1fca4694d, 0x41089ed1fca4694d, 0x41089ed1fca4694d, - 0x41089ed1fca4694d, 0x41089ed1fca4694d, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108b27488fe3e90, - 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, - 0x4108bc45cf2b2932, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, - 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, - 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, - 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, 0x4108f72d7438a8fb, 0x4108f72d7438a8fb, 0x4108f72d7438a8fb, 0x4108f72d7438a8fc, 0x4108f72d7438a8fb, 0x410900feba65939d, - 0x410900feba65939d, 0x410900feba65939d, 0x410900feba65939d, 0x410900feba65939d, 0x41090ad000927e3f, 0x41090ad000927e3f, 0x41090ad000927e3f, 0x41090ad000927e3f, - 0x41090ad000927e3f, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x41091e728cec5382, 0x41091e728cec5382, - 0x41091e728cec5382, 0x41091e728cec5382, 0x41091e728cec5382, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, - 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093be65f731367, 0x41093be65f731367, 0x41093be65f731367, - 0x41093be65f731367, 0x41093be65f731367, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x41094f88ebcce8aa, - 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x4109595a31f9d34c, 0x4109595a31f9d34c, 0x4109595a31f9d34c, 0x4109595a31f9d34c, - 0x4109595a31f9d34c, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, - 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, 0x410976ce04809330, 0x410976ce04809330, 0x410976ce04809330, 0x410976ce04809331, 0x410976ce04809330, - 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x41098a7090da6874, 0x41098a7090da6874, 0x41098a7090da6874, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbda4f7e6c0d70f0c, 0xbda4f7e6c0d70f0c, 0xbda4f7e6c0d70f0c, 0x3d7d49a2c1e7e800, 0x3d7d49a2c1e7e800, 0x3d7d49a2c1e7e800, 0x3d7d49a2c1e7e800, 0x3d7d49a2c1e7e800, - 0x3dac4a4f7151090c, 0x3dac4a4f7151090c, 0x3dac4a4f7151090c, 0x3dac4a4f7151090c, 0x3dac4a4f7151090c, 0xbd96292aeb35d5d0, 0xbd96292aeb35d5d0, 0xbd96292aeb35d5d0, - 0xbd96292aeb35d5d0, 0xbd96292aeb35d5d0, 0x3d9b190b46f24248, 0x3d9b190b46f24248, 0x3d9b190b46f24248, 0x3d9b190b46f24248, 0x3d9b190b46f24248, 0xbda9d25f4372d2d0, - 0xbda9d25f4372d2d0, 0xbda9d25f4372d2d0, 0xbda9d25f4372d2d0, 0xbda9d25f4372d2d0, 0xbd631442a5ec6c3b, 0xbd631442a5ec6c3b, 0xbd631442a5ec6c3b, 0xbd631442a5ec6c3b, - 0xbd631442a5ec6c3b, 0x3da76fd6eeb54548, 0x3da76fd6eeb54548, 0x3da76fd6eeb54548, 0x3da76fd6eeb54548, 0x3da76fd6eeb54548, 0xbd9fde1bf06d5d57, 0xbd9fde1bf06d5d57, - 0xbd9fde1bf06d5d57, 0xbd9fde1bf06d5d57, 0xbd9fde1bf06d5d57, 0x3d91641a41babac1, 0x3d91641a41babac1, 0x3d91641a41babac1, 0x3d91641a41babac1, 0x3d91641a41babac1, - 0xbdaeacd7c60e9693, 0xbdaeacd7c60e9693, 0xbdaeacd7c60e9693, 0x3db0a9941cf8b4b6, 0xbdaeacd7c60e9693, 0xbd882ef2b3ea2a1e, 0xbd882ef2b3ea2a1e, 0xbd882ef2b3ea2a1e, - 0xbd882ef2b3ea2a1e, 0xbd882ef2b3ea2a1e, 0x3da2955e6c198185, 0x3da2955e6c198185, 0x3da2955e6c198185, 0x3da2955e6c198185, 0x3da2955e6c198185, 0xbda4c9867ad2726f, - 0xbda4c9867ad2726f, 0xbda4c9867ad2726f, 0xbda4c9867ad2726f, 0xbda4c9867ad2726f, 0x3d7ebca4f20ccce6, 0x3d7ebca4f20ccce6, 0x3d7ebca4f20ccce6, 0x3d7ebca4f20ccce6, - 0x3d7ebca4f20ccce6, 0x3dac78afb755a5a9, 0x3dac78afb755a5a9, 0x3dac78afb755a5a9, 0x3dac78afb755a5a9, 0x3dac78afb755a5a9, 0xbd95cc6a5f2c9c96, 0xbd95cc6a5f2c9c96, - 0xbd95cc6a5f2c9c96, 0xbd95cc6a5f2c9c96, 0xbd95cc6a5f2c9c96, 0x3d9b75cbd2fb7b82, 0x3d9b75cbd2fb7b82, 0x3d9b75cbd2fb7b82, 0x3d9b75cbd2fb7b82, 0x3d9b75cbd2fb7b82, - 0xbda9a3fefd6e3633, 0xbda9a3fefd6e3633, 0xbda9a3fefd6e3633, 0xbda9a3fefd6e3633, 0xbda9a3fefd6e3633, 0xbd602e3e45a2a270, 0xbd602e3e45a2a270, 0xbd602e3e45a2a270, - 0xbd602e3e45a2a270, 0xbd602e3e45a2a270, 0x3da79e3734b9e1e5, 0x3da79e3734b9e1e5, 0x3da79e3734b9e1e5, 0x3da79e3734b9e1e5, 0x3da79e3734b9e1e5, 0xbd9f815b6464241e, - 0xbd9f815b6464241e, 0xbd9f815b6464241e, 0xbd9f815b6464241e, 0xbd9f815b6464241e, 0x3d91c0dacdc3f3fa, 0x3d91c0dacdc3f3fa, 0x3d91c0dacdc3f3fa, 0x3d91c0dacdc3f3fa, - 0x3d91c0dacdc3f3fa, 0xbdae7e778009f9f7, 0xbdae7e778009f9f7, 0xbdae7e778009f9f7, 0x3db0c0c43ffb0305, 0xbdae7e778009f9f7, 0xbd8775719bd7b7ab, 0xbd8775719bd7b7ab, - 0xbd8775719bd7b7ab, 0xbd8775719bd7b7ab, 0xbd8775719bd7b7ab, 0x3da2c3beb21e1e21, 0x3da2c3beb21e1e21, 0x3da2c3beb21e1e21, 0x3da2c3beb21e1e21, 0x3da2c3beb21e1e21, - 0xbda49b2634cdd5d3, 0xbda49b2634cdd5d3, 0xbda49b2634cdd5d3, 0xbda49b2634cdd5d3, 0xbda49b2634cdd5d3, 0x3d8017d39118d8e6, 0x3d8017d39118d8e6, 0x3d8017d39118d8e6, - 0x3d8017d39118d8e6, 0x3d8017d39118d8e6, 0x3daca70ffd5a4245, 0x3daca70ffd5a4245, 0x3daca70ffd5a4245, 0x3daca70ffd5a4245, 0x3daca70ffd5a4245, 0xbd956fa9d323635d, - 0xbd956fa9d323635d, 0xbd956fa9d323635d, 0xbd956fa9d323635d, 0xbd956fa9d323635d, 0x3d9bd28c5f04b4bb, 0x3d9bd28c5f04b4bb, 0x3d9bd28c5f04b4bb, 0x3d9bd28c5f04b4bb, - 0x3d9bd28c5f04b4bb, 0xbda9759eb7699996, 0xbda9759eb7699996, 0xbda9759eb7699996, 0xbda9759eb7699996, 0xbda9759eb7699996, 0xbd5a9073cab1b14b, 0xbd5a9073cab1b14b, - 0xbd5a9073cab1b14b, 0xbd5a9073cab1b14b, 0xbd5a9073cab1b14b, 0x3da7cc977abe7e82, 0x3da7cc977abe7e82, 0x3da7cc977abe7e82, 0x3da7cc977abe7e82, 0x3da7cc977abe7e82, - 0xbd9f249ad85aeae4, 0xbd9f249ad85aeae4, 0xbd9f249ad85aeae4, 0xbd9f249ad85aeae4, 0xbd9f249ad85aeae4, 0x3d921d9b59cd2d34, 0x3d921d9b59cd2d34, 0x3d921d9b59cd2d34, - 0x3d921d9b59cd2d34, 0x3d921d9b59cd2d34, 0xbdae50173a055d5a, 0xbdae50173a055d5a, 0xbdae50173a055d5a, 0x3db0d7f462fd5153, 0xbdae50173a055d5a, 0xbd86bbf083c54538, - 0xbd86bbf083c54538, 0xbd86bbf083c54538, 0xbd86bbf083c54538, 0xbd86bbf083c54538, 0x3da2f21ef822babe, 0x3da2f21ef822babe, 0x3da2f21ef822babe, 0x3da2f21ef822babe, - 0x3da2f21ef822babe, 0xbda46cc5eec93936, 0xbda46cc5eec93936, 0xbda46cc5eec93936, 0xbda46cc5eec93936, 0xbda46cc5eec93936, 0x3d80d154a92b4b58, 0x3d80d154a92b4b58, - 0x3d80d154a92b4b58, 0x3d80d154a92b4b58, 0x3d80d154a92b4b58, 0x3dacd570435edee2, 0x3dacd570435edee2, 0x3dacd570435edee2, 0x3dacd570435edee2, 0x3dacd570435edee2, - 0xbd9512e9471a2a24, 0xbd9512e9471a2a24, 0xbd9512e9471a2a24, 0xbd9512e9471a2a24, 0xbd9512e9471a2a24, 0x3d9c2f4ceb0dedf4, 0x3d9c2f4ceb0dedf4, 0x3d9c2f4ceb0dedf4, - 0x3d9c2f4ceb0dedf4, 0x3d9c2f4ceb0dedf4, 0xbda9473e7164fcfa, 0xbda9473e7164fcfa, 0xbda9473e7164fcfa, 0xbda9473e7164fcfa, 0xbda9473e7164fcfa, 0xbd54c46b0a1e1db6, - 0xbd54c46b0a1e1db6, 0xbd54c46b0a1e1db6, 0xbd54c46b0a1e1db6, 0xbd54c46b0a1e1db6, 0x3da7faf7c0c31b1e, 0x3da7faf7c0c31b1e, 0x3da7faf7c0c31b1e, 0x3da7faf7c0c31b1e, - 0x3da7faf7c0c31b1e, 0xbd9ec7da4c51b1ab, 0xbd9ec7da4c51b1ab, 0xbd9ec7da4c51b1ab, 0xbd9ec7da4c51b1ab, 0xbd9ec7da4c51b1ab, 0x3d927a5be5d6666d, 0x3d927a5be5d6666d, - 0x3d927a5be5d6666d, 0x3d927a5be5d6666d, 0x3d927a5be5d6666d, 0xbdae21b6f400c0bd, 0xbdae21b6f400c0bd, 0xbdae21b6f400c0bd, 0x3db0ef2485ff9fa1, 0xbdae21b6f400c0bd, - 0xbd86026f6bb2d2c6, 0xbd86026f6bb2d2c6, 0xbd86026f6bb2d2c6, 0xbd86026f6bb2d2c6, 0xbd86026f6bb2d2c6, 0x3da3207f3e27575b, 0x3da3207f3e27575b, 0x3da3207f3e27575b, -] )) ), - -################ chunk 6656 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x41098a7090da6874, 0x41098a7090da6874, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099e131d343db7, - 0x41099e131d343db7, 0x41099e131d343db7, 0x41099e131d343db7, 0x41099e131d343db7, 0x4109a7e463612859, 0x4109a7e463612859, 0x4109a7e463612859, 0x4109a7e463612859, - 0x4109a7e463612859, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, - 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, - 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109d8fac241bd81, 0x4109d8fac241bd81, 0x4109d8fac241bd81, - 0x4109d8fac241bd81, 0x4109d8fac241bd81, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109ec9d4e9b92c4, - 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109f66e94c87d65, 0x4109f66e94c87d65, 0x4109f66e94c87d65, 0x4109f66e94c87d66, - 0x4109f66e94c87d65, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a0a11212252a9, 0x410a0a11212252a9, - 0x410a0a11212252a9, 0x410a0a11212252a9, 0x410a0a11212252a9, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, - 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a2784f3a9128e, 0x410a2784f3a9128e, 0x410a2784f3a9128e, - 0x410a2784f3a9128e, 0x410a2784f3a9128e, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a3b278002e7d1, - 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a44f8c62fd272, 0x410a44f8c62fd272, 0x410a44f8c62fd272, 0x410a44f8c62fd272, - 0x410a44f8c62fd272, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a589b5289a7b6, 0x410a589b5289a7b6, - 0x410a589b5289a7b6, 0x410a589b5289a7b6, 0x410a589b5289a7b6, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, - 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a760f2510679a, 0x410a760f2510679a, 0x410a760f2510679a, - 0x410a760f2510679a, 0x410a760f2510679a, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a89b1b16a3cde, - 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a9382f797277f, 0x410a9382f797277f, 0x410a9382f797277f, 0x410a9382f797277f, - 0x410a9382f797277f, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, - 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, - 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410ac4995677bca7, 0x410ac4995677bca7, 0x410ac4995677bca7, - 0x410ac4995677bca7, 0x410ac4995677bca7, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ad83be2d191eb, - 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, - 0x410ae20d28fe7c8c, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410af5afb55851cf, 0x410af5afb55851cf, - 0x410af5afb55851cf, 0x410af5afb55851cf, 0x410af5afb55851cf, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, - 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b132387df11b4, 0x410b132387df11b4, 0x410b132387df11b4, - 0x410b132387df11b4, 0x410b132387df11b4, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b26c61438e6f8, - 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b30975a65d199, 0x410b30975a65d199, 0x410b30975a65d199, 0x410b30975a65d199, - 0x410b30975a65d199, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, - 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, - 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b61adb94666c1, 0x410b61adb94666c1, 0x410b61adb94666c1, - 0x410b61adb94666c1, 0x410b61adb94666c1, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b755045a03c04, - 0x410b755045a03c04, 0x410b755045a03c04, 0x410b755045a03c04, 0x410b755045a03c04, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3da3207f3e27575b, 0x3da3207f3e27575b, 0xbda43e65a8c49c99, 0xbda43e65a8c49c99, 0xbda43e65a8c49c99, 0xbda43e65a8c49c99, 0xbda43e65a8c49c99, 0x3d818ad5c13dbdcb, - 0x3d818ad5c13dbdcb, 0x3d818ad5c13dbdcb, 0x3d818ad5c13dbdcb, 0x3d818ad5c13dbdcb, 0x3dad03d089637b7f, 0x3dad03d089637b7f, 0x3dad03d089637b7f, 0x3dad03d089637b7f, - 0x3dad03d089637b7f, 0xbd94b628bb10f0ea, 0xbd94b628bb10f0ea, 0xbd94b628bb10f0ea, 0xbd94b628bb10f0ea, 0xbd94b628bb10f0ea, 0x3d9c8c0d7717272e, 0x3d9c8c0d7717272e, - 0x3d9c8c0d7717272e, 0x3d9c8c0d7717272e, 0x3d9c8c0d7717272e, 0xbda918de2b60605d, 0xbda918de2b60605d, 0xbda918de2b60605d, 0xbda918de2b60605d, 0xbda918de2b60605d, - 0xbd4df0c493151440, 0xbd4df0c493151440, 0xbd4df0c493151440, 0xbd4df0c493151440, 0xbd4df0c493151440, 0x3da8295806c7b7bb, 0x3da8295806c7b7bb, 0x3da8295806c7b7bb, - 0x3da8295806c7b7bb, 0x3da8295806c7b7bb, 0xbd9e6b19c0487872, 0xbd9e6b19c0487872, 0xbd9e6b19c0487872, 0xbd9e6b19c0487872, 0xbd9e6b19c0487872, 0x3d92d71c71df9fa6, - 0x3d92d71c71df9fa6, 0x3d92d71c71df9fa6, 0x3d92d71c71df9fa6, 0x3d92d71c71df9fa6, 0xbdadf356adfc2421, 0xbdadf356adfc2421, 0xbdadf356adfc2421, 0x3db10654a901edf0, - 0xbdadf356adfc2421, 0xbd8548ee53a06053, 0xbd8548ee53a06053, 0xbd8548ee53a06053, 0xbd8548ee53a06053, 0xbd8548ee53a06053, 0x3da34edf842bf3f7, 0x3da34edf842bf3f7, - 0x3da34edf842bf3f7, 0x3da34edf842bf3f7, 0x3da34edf842bf3f7, 0xbda4100562bffffd, 0xbda4100562bffffd, 0xbda4100562bffffd, 0xbda4100562bffffd, 0xbda4100562bffffd, - 0x3d824456d950303e, 0x3d824456d950303e, 0x3d824456d950303e, 0x3d824456d950303e, 0x3d824456d950303e, 0x3dad3230cf68181b, 0x3dad3230cf68181b, 0x3dad3230cf68181b, - 0x3dad3230cf68181b, 0x3dad3230cf68181b, 0xbd9459682f07b7b1, 0xbd9459682f07b7b1, 0xbd9459682f07b7b1, 0xbd9459682f07b7b1, 0xbd9459682f07b7b1, 0x3d9ce8ce03206067, - 0x3d9ce8ce03206067, 0x3d9ce8ce03206067, 0x3d9ce8ce03206067, 0x3d9ce8ce03206067, 0xbda8ea7de55bc3c0, 0xbda8ea7de55bc3c0, 0xbda8ea7de55bc3c0, 0xbda8ea7de55bc3c0, - 0xbda8ea7de55bc3c0, 0xbd4258b311eded15, 0xbd4258b311eded15, 0xbd4258b311eded15, 0xbd4258b311eded15, 0xbd4258b311eded15, 0x3da857b84ccc5458, 0x3da857b84ccc5458, - 0x3da857b84ccc5458, 0x3da857b84ccc5458, 0x3da857b84ccc5458, 0xbd9e0e59343f3f38, 0xbd9e0e59343f3f38, 0xbd9e0e59343f3f38, 0xbd9e0e59343f3f38, 0xbd9e0e59343f3f38, - 0x3d9333dcfde8d8e0, 0x3d9333dcfde8d8e0, 0x3d9333dcfde8d8e0, 0x3d9333dcfde8d8e0, 0x3d9333dcfde8d8e0, 0xbdadc4f667f78784, 0xbdadc4f667f78784, 0xbdadc4f667f78784, - 0xbdadc4f667f78784, 0xbdadc4f667f78784, 0xbd848f6d3b8dede0, 0xbd848f6d3b8dede0, 0xbd848f6d3b8dede0, 0xbd848f6d3b8dede0, 0xbd848f6d3b8dede0, 0x3da37d3fca309094, - 0x3da37d3fca309094, 0x3da37d3fca309094, 0x3da37d3fca309094, 0x3da37d3fca309094, 0xbda3e1a51cbb6360, 0xbda3e1a51cbb6360, 0xbda3e1a51cbb6360, 0xbda3e1a51cbb6360, - 0xbda3e1a51cbb6360, 0x3d82fdd7f162a2b0, 0x3d82fdd7f162a2b0, 0x3d82fdd7f162a2b0, 0x3d82fdd7f162a2b0, 0x3d82fdd7f162a2b0, 0x3dad6091156cb4b8, 0x3dad6091156cb4b8, - 0x3dad6091156cb4b8, 0x3dad6091156cb4b8, 0x3dad6091156cb4b8, 0xbd93fca7a2fe7e78, 0xbd93fca7a2fe7e78, 0xbd93fca7a2fe7e78, 0xbd93fca7a2fe7e78, 0xbd93fca7a2fe7e78, - 0x3d9d458e8f2999a0, 0x3d9d458e8f2999a0, 0x3d9d458e8f2999a0, 0x3d9d458e8f2999a0, 0x3d9d458e8f2999a0, 0xbda8bc1d9f572724, 0xbda8bc1d9f572724, 0xbda8bc1d9f572724, - 0xbda8bc1d9f572724, 0xbda8bc1d9f572724, 0xbd2b0286431b17a6, 0xbd2b0286431b17a6, 0xbd2b0286431b17a6, 0xbd2b0286431b17a6, 0xbd2b0286431b17a6, 0x3da8861892d0f0f4, - 0x3da8861892d0f0f4, 0x3da8861892d0f0f4, 0x3da8861892d0f0f4, 0x3da8861892d0f0f4, 0xbd9db198a83605ff, 0xbd9db198a83605ff, 0xbd9db198a83605ff, 0xbd9db198a83605ff, - 0xbd9db198a83605ff, 0x3d93909d89f21219, 0x3d93909d89f21219, 0x3d93909d89f21219, 0x3d93909d89f21219, 0x3d93909d89f21219, 0xbdad969621f2eae7, 0xbdad969621f2eae7, - 0xbdad969621f2eae7, 0xbdad969621f2eae7, 0xbdad969621f2eae7, 0xbd83d5ec237b7b6e, 0xbd83d5ec237b7b6e, 0xbd83d5ec237b7b6e, 0xbd83d5ec237b7b6e, 0xbd83d5ec237b7b6e, - 0x3da3aba010352d31, 0x3da3aba010352d31, 0x3da3aba010352d31, 0x3da3aba010352d31, 0x3da3aba010352d31, 0xbda3b344d6b6c6c3, 0xbda3b344d6b6c6c3, 0xbda3b344d6b6c6c3, - 0xbda3b344d6b6c6c3, 0xbda3b344d6b6c6c3, 0x3d83b75909751523, 0x3d83b75909751523, 0x3d83b75909751523, 0x3d83b75909751523, 0x3d83b75909751523, 0x3dad8ef15b715155, - 0x3dad8ef15b715155, 0x3dad8ef15b715155, 0x3dad8ef15b715155, 0x3dad8ef15b715155, 0xbd939fe716f5453e, 0xbd939fe716f5453e, 0xbd939fe716f5453e, 0xbd939fe716f5453e, - 0xbd939fe716f5453e, 0x3d9da24f1b32d2da, 0x3d9da24f1b32d2da, 0x3d9da24f1b32d2da, 0x3d9da24f1b32d2da, 0x3d9da24f1b32d2da, 0xbda88dbd59528a87, 0xbda88dbd59528a87, - 0xbda88dbd59528a87, 0xbda88dbd59528a87, 0xbda88dbd59528a87, 0x3d235dbfc1818507, 0x3d235dbfc1818507, 0x3d235dbfc1818507, 0x3d235dbfc1818507, 0x3d235dbfc1818507, - 0x3da8b478d8d58d91, 0x3da8b478d8d58d91, 0x3da8b478d8d58d91, 0x3da8b478d8d58d91, 0x3da8b478d8d58d91, 0xbd9d54d81c2cccc6, 0xbd9d54d81c2cccc6, 0xbd9d54d81c2cccc6, - 0xbd9d54d81c2cccc6, 0xbd9d54d81c2cccc6, 0x3d93ed5e15fb4b52, 0x3d93ed5e15fb4b52, 0x3d93ed5e15fb4b52, 0x3d93ed5e15fb4b52, 0x3d93ed5e15fb4b52, 0xbdad6835dbee4e4b, - 0xbdad6835dbee4e4b, 0xbdad6835dbee4e4b, 0xbdad6835dbee4e4b, 0xbdad6835dbee4e4b, 0xbd831c6b0b6908fb, 0xbd831c6b0b6908fb, 0xbd831c6b0b6908fb, 0xbd831c6b0b6908fb, -] )) ), - -################ chunk 7168 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x410b7f218bcd26a6, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b92c41826fbe9, 0x410b92c41826fbe9, - 0x410b92c41826fbe9, 0x410b92c41826fbe9, 0x410b92c41826fbe9, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, - 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410bb037eaadbbce, 0x410bb037eaadbbce, 0x410bb037eaadbbce, - 0x410bb037eaadbbce, 0x410bb037eaadbbce, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bc3da77079111, - 0x410bc3da77079111, 0x410bc3da77079111, 0x410bc3da77079111, 0x410bc3da77079111, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, - 0x410bcdabbd347bb3, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410be14e498e50f6, 0x410be14e498e50f6, - 0x410be14e498e50f6, 0x410be14e498e50f6, 0x410be14e498e50f6, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, - 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bfec21c1510db, 0x410bfec21c1510db, 0x410bfec21c1510db, - 0x410bfec21c1510db, 0x410bfec21c1510db, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c1264a86ee61e, - 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, - 0x410c1c35ee9bd0c0, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb61, 0x410c2fd87af5a603, 0x410c2fd87af5a603, - 0x410c2fd87af5a603, 0x410c2fd87af5a603, 0x410c2fd87af5a603, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, - 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, - 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c60eed9d63b2b, - 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c6ac0200325cd, 0x410c6ac0200325cd, 0x410c6ac0200325cd, 0x410c6ac0200325cd, - 0x410c6ac0200325cd, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, - 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, - 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, - 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a596, 0x410caf790b3d9038, - 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410cb94a516a7ada, 0x410cb94a516a7ada, 0x410cb94a516a7ada, 0x410cb94a516a7ada, - 0x410cb94a516a7ada, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cccecddc4501d, 0x410cccecddc4501d, - 0x410cccecddc4501d, 0x410cccecddc4501d, 0x410cccecddc4501d, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, - 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410cea60b04b1002, 0x410cea60b04b1002, 0x410cea60b04b1002, - 0x410cea60b04b1002, 0x410cea60b04b1002, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cfe033ca4e545, - 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, - 0x410d07d482d1cfe7, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, - 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcb, - 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d38eae1b2650f, 0x410d38eae1b2650f, 0x410d38eae1b2650f, - 0x410d38eae1b2650f, 0x410d38eae1b2650f, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d4c8d6e0c3a52, - 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d565eb43924f4, 0x410d565eb43924f4, 0x410d565eb43924f4, 0x410d565eb43924f4, - 0x410d565eb43924f4, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d6a014092fa37, 0x410d6a014092fa37, - 0x410d6a014092fa37, 0x410d6a014092fa37, 0x410d6a014092fa37, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbd831c6b0b6908fb, 0x3da3da005639c9cd, 0x3da3da005639c9cd, 0x3da3da005639c9cd, 0x3da3da005639c9cd, 0x3da3da005639c9cd, 0xbda384e490b22a27, 0xbda384e490b22a27, - 0xbda384e490b22a27, 0xbda384e490b22a27, 0xbda384e490b22a27, 0x3d8470da21878796, 0x3d8470da21878796, 0x3d8470da21878796, 0x3d8470da21878796, 0x3d8470da21878796, - 0x3dadbd51a175edf1, 0x3dadbd51a175edf1, 0x3dadbd51a175edf1, 0x3dadbd51a175edf1, 0x3dadbd51a175edf1, 0xbd9343268aec0c05, 0xbd9343268aec0c05, 0xbd9343268aec0c05, - 0xbd9343268aec0c05, 0xbd9343268aec0c05, 0x3d9dff0fa73c0c13, 0x3d9dff0fa73c0c13, 0x3d9dff0fa73c0c13, 0x3d9dff0fa73c0c13, 0x3d9dff0fa73c0c13, 0xbda85f5d134dedea, - 0xbda85f5d134dedea, 0xbda85f5d134dedea, 0xbda85f5d134dedea, 0xbda85f5d134dedea, 0x3d406f817187886d, 0x3d406f817187886d, 0x3d406f817187886d, 0x3d406f817187886d, - 0x3d406f817187886d, 0x3da8e2d91eda2a2e, 0x3da8e2d91eda2a2e, 0x3da8e2d91eda2a2e, 0x3da8e2d91eda2a2e, 0x3da8e2d91eda2a2e, 0xbd9cf8179023938c, 0xbd9cf8179023938c, - 0xbd9cf8179023938c, 0xbd9cf8179023938c, 0xbd9cf8179023938c, 0x3d944a1ea204848c, 0x3d944a1ea204848c, 0x3d944a1ea204848c, 0x3d944a1ea204848c, 0x3d944a1ea204848c, - 0xbdad39d595e9b1ae, 0xbdad39d595e9b1ae, 0xbdad39d595e9b1ae, 0xbdad39d595e9b1ae, 0xbdad39d595e9b1ae, 0xbd8262e9f3569688, 0xbd8262e9f3569688, 0xbd8262e9f3569688, - 0xbd8262e9f3569688, 0xbd8262e9f3569688, 0x3da408609c3e666a, 0x3da408609c3e666a, 0x3da408609c3e666a, 0x3da408609c3e666a, 0x3da408609c3e666a, 0xbda356844aad8d8a, - 0xbda356844aad8d8a, 0xbda356844aad8d8a, 0xbda356844aad8d8a, 0xbda356844aad8d8a, 0x3d852a5b3999fa08, 0x3d852a5b3999fa08, 0x3d852a5b3999fa08, 0x3d852a5b3999fa08, - 0x3d852a5b3999fa08, 0x3dadebb1e77a8a8e, 0x3dadebb1e77a8a8e, 0x3dadebb1e77a8a8e, 0x3dadebb1e77a8a8e, 0xbdb10a270c42bab9, 0xbd92e665fee2d2cc, 0xbd92e665fee2d2cc, - 0xbd92e665fee2d2cc, 0xbd92e665fee2d2cc, 0xbd92e665fee2d2cc, 0x3d9e5bd03345454d, 0x3d9e5bd03345454d, 0x3d9e5bd03345454d, 0x3d9e5bd03345454d, 0x3d9e5bd03345454d, - 0xbda830fccd49514e, 0xbda830fccd49514e, 0xbda830fccd49514e, 0xbda830fccd49514e, 0xbda830fccd49514e, 0x3d4c0792f2aeaf98, 0x3d4c0792f2aeaf98, 0x3d4c0792f2aeaf98, - 0x3d4c0792f2aeaf98, 0x3d4c0792f2aeaf98, 0x3da9113964dec6ca, 0x3da9113964dec6ca, 0x3da9113964dec6ca, 0x3da9113964dec6ca, 0x3da9113964dec6ca, 0xbd9c9b57041a5a53, - 0xbd9c9b57041a5a53, 0xbd9c9b57041a5a53, 0xbd9c9b57041a5a53, 0xbd9c9b57041a5a53, 0x3d94a6df2e0dbdc5, 0x3d94a6df2e0dbdc5, 0x3d94a6df2e0dbdc5, 0x3d94a6df2e0dbdc5, - 0x3d94a6df2e0dbdc5, 0xbdad0b754fe51511, 0xbdad0b754fe51511, 0xbdad0b754fe51511, 0xbdad0b754fe51511, 0xbdad0b754fe51511, 0xbd81a968db442415, 0xbd81a968db442415, - 0xbd81a968db442415, 0xbd81a968db442415, 0xbd81a968db442415, 0x3da436c0e2430307, 0x3da436c0e2430307, 0x3da436c0e2430307, 0x3da436c0e2430307, 0x3da436c0e2430307, - 0xbda3282404a8f0ed, 0xbda3282404a8f0ed, 0xbda3282404a8f0ed, 0xbda3282404a8f0ed, 0xbda3282404a8f0ed, 0x3d85e3dc51ac6c7b, 0x3d85e3dc51ac6c7b, 0x3d85e3dc51ac6c7b, - 0x3d85e3dc51ac6c7b, 0x3d85e3dc51ac6c7b, 0x3dae1a122d7f272b, 0x3dae1a122d7f272b, 0x3dae1a122d7f272b, 0x3dae1a122d7f272b, 0xbdb0f2f6e9406c6b, 0xbd9289a572d99992, - 0xbd9289a572d99992, 0xbd9289a572d99992, 0xbd9289a572d99992, 0xbd9289a572d99992, 0x3d9eb890bf4e7e86, 0x3d9eb890bf4e7e86, 0x3d9eb890bf4e7e86, 0x3d9eb890bf4e7e86, - 0x3d9eb890bf4e7e86, 0xbda8029c8744b4b1, 0xbda8029c8744b4b1, 0xbda8029c8744b4b1, 0xbda8029c8744b4b1, 0xbda8029c8744b4b1, 0x3d53cfd239eaeb62, 0x3d53cfd239eaeb62, - 0x3d53cfd239eaeb62, 0x3d53cfd239eaeb62, 0x3d53cfd239eaeb62, 0x3da93f99aae36367, 0x3da93f99aae36367, 0x3da93f99aae36367, 0x3da93f99aae36367, 0x3da93f99aae36367, - 0xbd9c3e967811211a, 0xbd9c3e967811211a, 0xbd9c3e967811211a, 0xbd9c3e967811211a, 0xbd9c3e967811211a, 0x3d95039fba16f6fe, 0x3d95039fba16f6fe, 0x3d95039fba16f6fe, - 0x3d95039fba16f6fe, 0x3d95039fba16f6fe, 0xbdacdd1509e07875, 0xbdacdd1509e07875, 0xbdacdd1509e07875, 0xbdacdd1509e07875, 0xbdacdd1509e07875, 0xbd80efe7c331b1a3, - 0xbd80efe7c331b1a3, 0xbd80efe7c331b1a3, 0xbd80efe7c331b1a3, 0xbd80efe7c331b1a3, 0x3da4652128479fa3, 0x3da4652128479fa3, 0x3da4652128479fa3, 0x3da4652128479fa3, - 0x3da4652128479fa3, 0xbda2f9c3bea45451, 0xbda2f9c3bea45451, 0xbda2f9c3bea45451, 0xbda2f9c3bea45451, 0xbda2f9c3bea45451, 0x3d869d5d69bedeee, 0x3d869d5d69bedeee, - 0x3d869d5d69bedeee, 0x3d869d5d69bedeee, 0x3d869d5d69bedeee, 0x3dae48727383c3c8, 0x3dae48727383c3c8, 0x3dae48727383c3c8, 0x3dae48727383c3c8, 0xbdb0dbc6c63e1e1c, - 0xbd922ce4e6d06059, 0xbd922ce4e6d06059, 0xbd922ce4e6d06059, 0xbd922ce4e6d06059, 0xbd922ce4e6d06059, 0x3d9f15514b57b7bf, 0x3d9f15514b57b7bf, 0x3d9f15514b57b7bf, - 0x3d9f15514b57b7bf, 0x3d9f15514b57b7bf, 0xbda7d43c41401814, 0xbda7d43c41401814, 0xbda7d43c41401814, 0xbda7d43c41401814, 0xbda7d43c41401814, 0x3d599bdafa7e7ef7, - 0x3d599bdafa7e7ef7, 0x3d599bdafa7e7ef7, 0x3d599bdafa7e7ef7, 0x3d599bdafa7e7ef7, 0x3da96df9f0e80004, 0x3da96df9f0e80004, 0x3da96df9f0e80004, 0x3da96df9f0e80004, - 0x3da96df9f0e80004, 0xbd9be1d5ec07e7e0, 0xbd9be1d5ec07e7e0, 0xbd9be1d5ec07e7e0, 0xbd9be1d5ec07e7e0, 0xbd9be1d5ec07e7e0, 0x3d95606046203038, 0x3d95606046203038, - 0x3d95606046203038, 0x3d95606046203038, 0x3d95606046203038, 0xbdacaeb4c3dbdbd8, 0xbdacaeb4c3dbdbd8, 0xbdacaeb4c3dbdbd8, 0xbdacaeb4c3dbdbd8, 0xbdacaeb4c3dbdbd8, -] )) ), - -################ chunk 7680 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d87751319ba1c, 0x410d87751319ba1c, 0x410d87751319ba1c, - 0x410d87751319ba1c, 0x410d87751319ba1c, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d9b179f738f5f, - 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, - 0x410da4e8e5a07a00, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410db88b71fa4f44, 0x410db88b71fa4f44, - 0x410db88b71fa4f44, 0x410db88b71fa4f44, 0x410db88b71fa4f44, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, - 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dd5ff44810f29, 0x410dd5ff44810f29, 0x410dd5ff44810f29, - 0x410dd5ff44810f29, 0x410dd5ff44810f29, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410de9a1d0dae46c, - 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410df3731707cf0d, 0x410df3731707cf0d, 0x410df3731707cf0d, 0x410df3731707cf0d, - 0x410df3731707cf0d, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410e0715a361a451, 0x410e0715a361a451, - 0x410e0715a361a451, 0x410e0715a361a451, 0x410e0715a361a451, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, - 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e248975e86436, 0x410e248975e86436, 0x410e248975e86436, - 0x410e248975e86436, 0x410e248975e86435, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e382c02423979, - 0x410e382c02423979, 0x410e382c02423979, 0x410e382c02423979, 0x410e382c02423979, 0x410e41fd486f241a, 0x410e41fd486f241a, 0x410e41fd486f241a, 0x410e41fd486f241a, - 0x410e41fd486f241a, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, - 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, - 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e7313a74fb942, 0x410e7313a74fb942, 0x410e7313a74fb942, - 0x410e7313a74fb942, 0x410e7313a74fb942, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e86b633a98e86, - 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e908779d67927, 0x410e908779d67927, 0x410e908779d67927, 0x410e908779d67927, - 0x410e908779d67927, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410ea42a06304e6b, 0x410ea42a06304e6b, - 0x410ea42a06304e6b, 0x410ea42a06304e6b, 0x410ea42a06304e6a, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, - 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, - 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ed5406510e393, - 0x410ed5406510e393, 0x410ed5406510e393, 0x410ed5406510e393, 0x410ed5406510e393, 0x410edf11ab3dce34, 0x410edf11ab3dce34, 0x410edf11ab3dce34, 0x410edf11ab3dce34, - 0x410edf11ab3dce34, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ef2b43797a377, 0x410ef2b43797a377, - 0x410ef2b43797a377, 0x410ef2b43797a377, 0x410ef2b43797a377, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, - 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f10280a1e635c, 0x410f10280a1e635c, 0x410f10280a1e635c, - 0x410f10280a1e635c, 0x410f10280a1e635c, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f23ca967838a0, - 0x410f23ca967838a0, 0x410f23ca967838a0, 0x410f23ca967838a0, 0x410f23ca9678389f, 0x410f2d9bdca52341, 0x410f2d9bdca52341, 0x410f2d9bdca52341, 0x410f2d9bdca52341, - 0x410f2d9bdca52341, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f413e68fef884, 0x410f413e68fef884, - 0x410f413e68fef884, 0x410f413e68fef884, 0x410f413e68fef884, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, - 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f5eb23b85b869, 0x410f5eb23b85b869, 0x410f5eb23b85b869, - 0x410f5eb23b85b869, 0x410f5eb23b85b869, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f7254c7df8dac, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbd803666ab1f3f30, 0xbd803666ab1f3f30, 0xbd803666ab1f3f30, 0xbd803666ab1f3f30, 0xbd803666ab1f3f30, 0x3da493816e4c3c40, 0x3da493816e4c3c40, 0x3da493816e4c3c40, - 0x3da493816e4c3c40, 0x3da493816e4c3c40, 0xbda2cb63789fb7b4, 0xbda2cb63789fb7b4, 0xbda2cb63789fb7b4, 0xbda2cb63789fb7b4, 0xbda2cb63789fb7b4, 0x3d8756de81d15161, - 0x3d8756de81d15161, 0x3d8756de81d15161, 0x3d8756de81d15161, 0x3d8756de81d15161, 0x3dae76d2b9886064, 0x3dae76d2b9886064, 0x3dae76d2b9886064, 0x3dae76d2b9886064, - 0xbdb0c496a33bcfce, 0xbd91d0245ac7271f, 0xbd91d0245ac7271f, 0xbd91d0245ac7271f, 0xbd91d0245ac7271f, 0xbd91d0245ac7271f, 0x3d9f7211d760f0f9, 0x3d9f7211d760f0f9, - 0x3d9f7211d760f0f9, 0x3d9f7211d760f0f9, 0x3d9f7211d760f0f9, 0xbda7a5dbfb3b7b78, 0xbda7a5dbfb3b7b78, 0xbda7a5dbfb3b7b78, 0xbda7a5dbfb3b7b78, 0xbda7a5dbfb3b7b78, - 0x3d5f67e3bb12128d, 0x3d5f67e3bb12128d, 0x3d5f67e3bb12128d, 0x3d5f67e3bb12128d, 0x3d5f67e3bb12128d, 0x3da99c5a36ec9ca0, 0x3da99c5a36ec9ca0, 0x3da99c5a36ec9ca0, - 0x3da99c5a36ec9ca0, 0x3da99c5a36ec9ca0, 0xbd9b85155ffeaea7, 0xbd9b85155ffeaea7, 0xbd9b85155ffeaea7, 0xbd9b85155ffeaea7, 0xbd9b85155ffeaea7, 0x3d95bd20d2296971, - 0x3d95bd20d2296971, 0x3d95bd20d2296971, 0x3d95bd20d2296971, 0x3d95bd20d2296971, 0xbdac80547dd73f3b, 0xbdac80547dd73f3b, 0xbdac80547dd73f3b, 0xbdac80547dd73f3b, - 0xbdac80547dd73f3b, 0xbd7ef9cb2619997b, 0xbd7ef9cb2619997b, 0xbd7ef9cb2619997b, 0xbd7ef9cb2619997b, 0xbd7ef9cb2619997b, 0x3da4c1e1b450d8dd, 0x3da4c1e1b450d8dd, - 0x3da4c1e1b450d8dd, 0x3da4c1e1b450d8dd, 0x3da4c1e1b450d8dd, 0xbda29d03329b1b17, 0xbda29d03329b1b17, 0xbda29d03329b1b17, 0xbda29d03329b1b17, 0xbda29d03329b1b17, - 0x3d88105f99e3c3d3, 0x3d88105f99e3c3d3, 0x3d88105f99e3c3d3, 0x3d88105f99e3c3d3, 0x3d88105f99e3c3d3, 0x3daea532ff8cfd01, 0x3daea532ff8cfd01, 0x3daea532ff8cfd01, - 0x3daea532ff8cfd01, 0xbdb0ad6680398180, 0xbd917363cebdede6, 0xbd917363cebdede6, 0xbd917363cebdede6, 0xbd917363cebdede6, 0xbd917363cebdede6, 0x3d9fced2636a2a32, - 0x3d9fced2636a2a32, 0x3d9fced2636a2a32, 0x3d9fced2636a2a32, 0x3d9fced2636a2a32, 0xbda7777bb536dedb, 0xbda7777bb536dedb, 0xbda7777bb536dedb, 0xbda7777bb536dedb, - 0xbda7777bb536dedb, 0x3d6299f63dd2d311, 0x3d6299f63dd2d311, 0x3d6299f63dd2d311, 0x3d6299f63dd2d311, 0x3d6299f63dd2d311, 0x3da9caba7cf1393d, 0x3da9caba7cf1393d, - 0x3da9caba7cf1393d, 0x3da9caba7cf1393d, 0x3da9caba7cf1393d, 0xbd9b2854d3f5756e, 0xbd9b2854d3f5756e, 0xbd9b2854d3f5756e, 0xbd9b2854d3f5756e, 0xbd9b2854d3f5756e, - 0x3d9619e15e32a2aa, 0x3d9619e15e32a2aa, 0x3d9619e15e32a2aa, 0x3d9619e15e32a2aa, 0x3d9619e15e32a2aa, 0xbdac51f437d2a29f, 0xbdac51f437d2a29f, 0xbdac51f437d2a29f, - 0xbdac51f437d2a29f, 0xbdac51f437d2a29f, 0xbd7d86c8f5f4b495, 0xbd7d86c8f5f4b495, 0xbd7d86c8f5f4b495, 0xbd7d86c8f5f4b495, 0xbd7d86c8f5f4b495, 0x3da4f041fa557579, - 0x3da4f041fa557579, 0x3da4f041fa557579, 0x3da4f041fa557579, 0x3da4f041fa557579, 0xbda26ea2ec967e7b, 0xbda26ea2ec967e7b, 0xbda26ea2ec967e7b, 0xbda26ea2ec967e7b, - 0xbda26ea2ec967e7b, 0x3d88c9e0b1f63646, 0x3d88c9e0b1f63646, 0x3d88c9e0b1f63646, 0x3d88c9e0b1f63646, 0x3d88c9e0b1f63646, 0x3daed3934591999e, 0x3daed3934591999e, - 0x3daed3934591999e, 0x3daed3934591999e, 0xbdb096365d373331, 0xbd9116a342b4b4ad, 0xbd9116a342b4b4ad, 0xbd9116a342b4b4ad, 0xbd9116a342b4b4ad, 0xbd9116a342b4b4ad, - 0x3da015c977b9b1b6, 0x3da015c977b9b1b6, 0x3da015c977b9b1b6, 0x3da015c977b9b1b6, 0x3da015c977b9b1b6, 0xbda7491b6f32423e, 0xbda7491b6f32423e, 0xbda7491b6f32423e, - 0xbda7491b6f32423e, 0xbda7491b6f32423e, 0x3d657ffa9e1c9cdc, 0x3d657ffa9e1c9cdc, 0x3d657ffa9e1c9cdc, 0x3d657ffa9e1c9cdc, 0x3d657ffa9e1c9cdc, 0x3da9f91ac2f5d5da, - 0x3da9f91ac2f5d5da, 0x3da9f91ac2f5d5da, 0x3da9f91ac2f5d5da, 0x3da9f91ac2f5d5da, 0xbd9acb9447ec3c34, 0xbd9acb9447ec3c34, 0xbd9acb9447ec3c34, 0xbd9acb9447ec3c34, - 0xbd9acb9447ec3c34, 0x3d9676a1ea3bdbe4, 0x3d9676a1ea3bdbe4, 0x3d9676a1ea3bdbe4, 0x3d9676a1ea3bdbe4, 0x3d9676a1ea3bdbe4, 0xbdac2393f1ce0602, 0xbdac2393f1ce0602, - 0xbdac2393f1ce0602, 0xbdac2393f1ce0602, 0xbdac2393f1ce0602, 0xbd7c13c6c5cfcfb0, 0xbd7c13c6c5cfcfb0, 0xbd7c13c6c5cfcfb0, 0xbd7c13c6c5cfcfb0, 0xbd7c13c6c5cfcfb0, - 0x3da51ea2405a1216, 0x3da51ea2405a1216, 0x3da51ea2405a1216, 0x3da51ea2405a1216, 0x3da51ea2405a1216, 0xbda24042a691e1de, 0xbda24042a691e1de, 0xbda24042a691e1de, - 0xbda24042a691e1de, 0xbda24042a691e1de, 0x3d898361ca08a8b9, 0x3d898361ca08a8b9, 0x3d898361ca08a8b9, 0x3d898361ca08a8b9, 0x3d898361ca08a8b9, 0x3daf01f38b96363a, - 0x3daf01f38b96363a, 0x3daf01f38b96363a, 0x3daf01f38b96363a, 0xbdb07f063a34e4e3, 0xbd90b9e2b6ab7b73, 0xbd90b9e2b6ab7b73, 0xbd90b9e2b6ab7b73, 0xbd90b9e2b6ab7b73, - 0xbd90b9e2b6ab7b73, 0x3da04429bdbe4e52, 0x3da04429bdbe4e52, 0x3da04429bdbe4e52, 0x3da04429bdbe4e52, 0x3da04429bdbe4e52, 0xbda71abb292da5a2, 0xbda71abb292da5a2, - 0xbda71abb292da5a2, 0xbda71abb292da5a2, 0xbda71abb292da5a2, 0x3d6865fefe6666a7, 0x3d6865fefe6666a7, 0x3d6865fefe6666a7, 0x3d6865fefe6666a7, 0x3d6865fefe6666a7, - 0x3daa277b08fa7276, 0x3daa277b08fa7276, 0x3daa277b08fa7276, 0x3daa277b08fa7276, 0x3daa277b08fa7276, 0xbd9a6ed3bbe302fb, 0xbd9a6ed3bbe302fb, 0xbd9a6ed3bbe302fb, - 0xbd9a6ed3bbe302fb, 0xbd9a6ed3bbe302fb, 0x3d96d3627645151d, 0x3d96d3627645151d, 0x3d96d3627645151d, 0x3d96d3627645151d, 0x3d96d3627645151d, 0xbdabf533abc96965, -] )) ), - -################ chunk 8192 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7c260e0c784e, 0x410f7c260e0c784e, 0x410f7c260e0c784e, 0x410f7c260e0c784e, - 0x410f7c260e0c784e, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f8fc89a664d91, 0x410f8fc89a664d91, - 0x410f8fc89a664d91, 0x410f8fc89a664d91, 0x410f8fc89a664d91, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, - 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d4, 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, - 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fc0def946e2b9, - 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, - 0x410fcab03f73cd5b, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fde52cbcda29e, 0x410fde52cbcda29e, - 0x410fde52cbcda29e, 0x410fde52cbcda29e, 0x410fde52cbcda29e, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, - 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ffbc69e546283, 0x410ffbc69e546283, 0x410ffbc69e546283, - 0x410ffbc69e546283, 0x410ffbc69e546283, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411007b495571be3, - 0x411007b495571be3, 0x411007b495571be3, 0x411007b495571be3, 0x411007b495571be3, 0x41100c9d386d9134, 0x41100c9d386d9134, 0x41100c9d386d9134, 0x41100c9d386d9134, - 0x41100c9d386d9134, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, - 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, - 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110252867dddbc8, 0x4110252867dddbc8, 0x4110252867dddbc8, - 0x4110252867dddbc8, 0x4110252867dddbc8, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102ef9ae0ac66a, - 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x411033e251213bba, 0x411033e251213bba, 0x411033e251213bba, 0x411033e251213bba, - 0x411033e251213bba, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x41103db3974e265c, 0x41103db3974e265c, - 0x41103db3974e265c, 0x41103db3974e265c, 0x41103db3974e265c, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, - 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104c6d8091864e, 0x41104c6d8091864e, 0x41104c6d8091864e, - 0x41104c6d8091864e, 0x41104c6d8091864e, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110563ec6be70f0, - 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x41105b2769d4e641, 0x41105b2769d4e641, 0x41105b2769d4e641, 0x41105b2769d4e641, - 0x41105b2769d4e641, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411064f8b001d0e2, 0x411064f8b001d0e2, - 0x411064f8b001d0e2, 0x411064f8b001d0e3, 0x411064f8b001d0e2, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, - 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x411073b2994530d5, 0x411073b2994530d5, 0x411073b2994530d5, - 0x411073b2994530d5, 0x411073b2994530d5, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x41107d83df721b77, - 0x41107d83df721b77, 0x41107d83df721b77, 0x41107d83df721b77, 0x41107d83df721b77, 0x4110826c828890c7, 0x4110826c828890c7, 0x4110826c828890c7, 0x4110826c828890c7, - 0x4110826c828890c7, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, - 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, - 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, - 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x4110a4c8f825c5fd, - 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, - 0x4110a9b19b3c3b4e, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110b382e16925ef, 0x4110b382e16925ef, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbdabf533abc96965, 0xbdabf533abc96965, 0xbdabf533abc96965, 0xbdabf533abc96965, 0xbd7aa0c495aaeaca, 0xbd7aa0c495aaeaca, 0xbd7aa0c495aaeaca, 0xbd7aa0c495aaeaca, - 0xbd7aa0c495aaeaca, 0x3da54d02865eaeb3, 0x3da54d02865eaeb3, 0x3da54d02865eaeb3, 0x3da54d02865eaeb3, 0x3da54d02865eaeb3, 0xbda211e2608d4541, 0xbda211e2608d4541, - 0xbda211e2608d4541, 0xbda211e2608d4541, 0xbda211e2608d4541, 0x3d8a3ce2e21b1b2b, 0x3d8a3ce2e21b1b2b, 0x3d8a3ce2e21b1b2b, 0x3d8a3ce2e21b1b2b, 0x3d8a3ce2e21b1b2b, - 0x3daf3053d19ad2d7, 0x3daf3053d19ad2d7, 0x3daf3053d19ad2d7, 0x3daf3053d19ad2d7, 0xbdb067d617329695, 0xbd905d222aa2423a, 0xbd905d222aa2423a, 0xbd905d222aa2423a, - 0xbd905d222aa2423a, 0xbd905d222aa2423a, 0x3da0728a03c2eaef, 0x3da0728a03c2eaef, 0x3da0728a03c2eaef, 0x3da0728a03c2eaef, 0x3da0728a03c2eaef, 0xbda6ec5ae3290905, - 0xbda6ec5ae3290905, 0xbda6ec5ae3290905, 0xbda6ec5ae3290905, 0xbda6ec5ae3290905, 0x3d6b4c035eb03072, 0x3d6b4c035eb03072, 0x3d6b4c035eb03072, 0x3d6b4c035eb03072, - 0x3d6b4c035eb03072, 0x3daa55db4eff0f13, 0x3daa55db4eff0f13, 0x3daa55db4eff0f13, 0x3daa55db4eff0f13, 0x3daa55db4eff0f13, 0xbd9a12132fd9c9c2, 0xbd9a12132fd9c9c2, - 0xbd9a12132fd9c9c2, 0xbd9a12132fd9c9c2, 0xbd9a12132fd9c9c2, 0x3d973023024e4e57, 0x3d973023024e4e57, 0x3d973023024e4e57, 0x3d973023024e4e57, 0x3d973023024e4e57, - 0xbdabc6d365c4ccc9, 0xbdabc6d365c4ccc9, 0xbdabc6d365c4ccc9, 0xbdabc6d365c4ccc9, 0xbdabc6d365c4ccc9, 0xbd792dc2658605e5, 0xbd792dc2658605e5, 0xbd792dc2658605e5, - 0xbd792dc2658605e5, 0xbd792dc2658605e5, 0xbdb5424e99ce5a58, 0xbdb5424e99ce5a58, 0xbdb5424e99ce5a58, 0xbdb5424e99ce5a58, 0xbdb5424e99ce5a58, 0xbda1e3821a88a8a5, - 0xbda1e3821a88a8a5, 0xbda1e3821a88a8a5, 0xbda1e3821a88a8a5, 0xbda1e3821a88a8a5, 0x3d8af663fa2d8d9e, 0x3d8af663fa2d8d9e, 0x3d8af663fa2d8d9e, 0x3d8af663fa2d8d9e, - 0x3d8af663fa2d8d9e, 0x3daf5eb4179f6f74, 0x3daf5eb4179f6f74, 0x3daf5eb4179f6f74, 0x3daf5eb4179f6f74, 0x3daf5eb4179f6f74, 0x3dbbffe79859bdc0, 0x3dbbffe79859bdc0, - 0x3dbbffe79859bdc0, 0x3dbbffe79859bdc0, 0x3dbbffe79859bdc0, 0xbdb7af8adb1c3c3a, 0xbdb7af8adb1c3c3a, 0xbdb7af8adb1c3c3a, 0xbdb7af8adb1c3c3a, 0xbdb7af8adb1c3c3a, - 0xbda6bdfa9d246c68, 0xbda6bdfa9d246c68, 0xbda6bdfa9d246c68, 0xbda6bdfa9d246c68, 0xbda6bdfa9d246c68, 0x3d6e3207bef9fa3d, 0x3d6e3207bef9fa3d, 0x3d6e3207bef9fa3d, - 0x3d6e3207bef9fa3d, 0x3d6e3207bef9fa3d, 0x3daa843b9503abb0, 0x3daa843b9503abb0, 0x3daa843b9503abb0, 0x3daa843b9503abb0, 0x3daa843b9503abb0, 0x3db992ab570bdbde, - 0x3db992ab570bdbde, 0x3db992ab570bdbde, 0x3db992ab570bdbde, 0x3db992ab570bdbde, 0xbdba1cc71c6a1e1c, 0xbdba1cc71c6a1e1c, 0xbdba1cc71c6a1e1c, 0xbdba1cc71c6a1e1c, - 0xbdba1cc71c6a1e1c, 0xbdab98731fc0302c, 0xbdab98731fc0302c, 0xbdab98731fc0302c, 0xbdab98731fc0302c, 0xbdab98731fc0302c, 0xbd77bac035612100, 0xbd77bac035612100, - 0xbd77bac035612100, 0xbd77bac035612100, 0xbd77bac035612100, 0x3da5a9c31267e7ec, 0x3da5a9c31267e7ec, 0x3da5a9c31267e7ec, 0x3da5a9c31267e7ec, 0x3da5a9c31267e7ec, - 0x3db7256f15bdf9fc, 0x3db7256f15bdf9fc, 0x3db7256f15bdf9fc, 0x3db7256f15bdf9fc, 0x3db7256f15bdf9fc, 0xbdbc8a035db7fffe, 0xbdbc8a035db7fffe, 0xbdbc8a035db7fffe, - 0xbdbc8a035db7fffe, 0xbdbc8a035db7fffe, 0xbdb03975d12df9f8, 0xbdb03975d12df9f8, 0xbdb03975d12df9f8, 0xbdb03975d12df9f8, 0xbdb03975d12df9f8, 0xbd8f4742251f9f8f, - 0xbd8f4742251f9f8f, 0xbd8f4742251f9f8f, 0xbd8f4742251f9f8f, 0xbd8f4742251f9f8f, 0x3da0cf4a8fcc2428, 0x3da0cf4a8fcc2428, 0x3da0cf4a8fcc2428, 0x3da0cf4a8fcc2428, - 0x3da0cf4a8fcc2428, 0x3db4b832d470181a, 0x3db4b832d470181a, 0x3db4b832d470181a, 0x3db4b832d470181a, 0x3db4b832d470181a, 0xbdbef73f9f05e1e0, 0xbdbef73f9f05e1e0, - 0xbdbef73f9f05e1e0, 0x3dc08460307d0f10, 0xbdbef73f9f05e1e0, 0xbdb2a6b2127bdbda, 0xbdb2a6b2127bdbda, 0xbdb2a6b2127bdbda, 0xbdb2a6b2127bdbda, 0xbdb2a6b2127bdbda, - 0xbd99589217c7574f, 0xbd99589217c7574f, 0xbd99589217c7574f, 0xbd99589217c7574f, 0xbd99589217c7574f, 0x3d97e9a41a60c0c9, 0x3d97e9a41a60c0c9, 0x3d97e9a41a60c0c9, - 0x3d97e9a41a60c0c9, 0x3d97e9a41a60c0c9, 0x3db24af693223638, 0x3db24af693223638, 0x3db24af693223638, 0x3db24af693223638, 0x3db24af693223638, 0x3dbe9b841fac3c3e, - 0x3dbe9b841fac3c3e, 0x3dbe9b841fac3c3e, 0x3dbe9b841fac3c3e, 0x3dbe9b841fac3c3e, 0xbdb513ee53c9bdbc, 0xbdb513ee53c9bdbc, 0xbdb513ee53c9bdbc, 0xbdb513ee53c9bdbc, - 0xbdb513ee53c9bdbc, 0xbda186c18e7f6f6b, 0xbda186c18e7f6f6b, 0xbda186c18e7f6f6b, 0xbda186c18e7f6f6b, 0xbda186c18e7f6f6b, 0x3d8c69662a527284, 0x3d8c69662a527284, - 0x3d8c69662a527284, 0x3d8c69662a527284, 0x3d8c69662a527284, 0x3dafbb74a3a8a8ad, 0x3dafbb74a3a8a8ad, 0x3dafbb74a3a8a8ad, 0x3dafbb74a3a8a8ad, 0x3dafbb74a3a8a8ad, - 0x3dbc2e47de5e5a5c, 0x3dbc2e47de5e5a5c, 0x3dbc2e47de5e5a5c, 0x3dbc2e47de5e5a5c, 0x3dbc2e47de5e5a5c, 0xbdb7812a95179f9d, 0xbdb7812a95179f9d, 0xbdb7812a95179f9d, - 0xbdb7812a95179f9d, 0xbdb7812a95179f9d, 0xbda6613a111b332f, 0xbda6613a111b332f, 0xbda6613a111b332f, 0xbda6613a111b332f, 0xbda6613a111b332f, 0x3d71ff083fc6c6e9, - 0x3d71ff083fc6c6e9, 0x3d71ff083fc6c6e9, 0x3d71ff083fc6c6e9, 0x3d71ff083fc6c6e9, 0x3daae0fc210ce4e9, 0x3daae0fc210ce4e9, 0x3daae0fc210ce4e9, 0x3daae0fc210ce4e9, - 0x3daae0fc210ce4e9, 0x3db9c10b9d10787b, 0x3db9c10b9d10787b, 0x3db9c10b9d10787b, 0x3db9c10b9d10787b, 0x3db9c10b9d10787b, 0xbdb9ee66d665817f, 0xbdb9ee66d665817f, -] )) ), - -################ chunk 8704 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4110b382e16925ef, 0x4110b382e16925ef, 0x4110b382e16925ef, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, - 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, - 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110cc0e10d97083, - 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, - 0x4110d0f6b3efe5d4, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, - 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, - 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e981e3603068, 0x4110e981e3603068, 0x4110e981e3603068, - 0x4110e981e3603068, 0x4110e981e3603068, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110f353298d1b0a, - 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f83bcca3905b, 0x4110f83bcca3905b, 0x4110f83bcca3905b, 0x4110f83bcca3905b, - 0x4110f83bcca3905b, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4111020d12d07afc, 0x4111020d12d07afc, - 0x4111020d12d07afc, 0x4111020d12d07afc, 0x4111020d12d07afc, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, - 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x411110c6fc13daef, 0x411110c6fc13daef, 0x411110c6fc13daef, - 0x411110c6fc13daef, 0x411110c6fc13daef, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x41111a984240c590, - 0x41111a984240c590, 0x41111a984240c590, 0x41111a984240c590, 0x41111a984240c590, 0x41111f80e5573ae1, 0x41111f80e5573ae1, 0x41111f80e5573ae1, 0x41111f80e5573ae1, - 0x41111f80e5573ae1, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x411129522b842583, 0x411129522b842583, - 0x411129522b842583, 0x411129522b842583, 0x411129522b842583, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, - 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111380c14c78575, 0x4111380c14c78575, 0x4111380c14c78575, - 0x4111380c14c78575, 0x4111380c14c78575, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x411141dd5af47017, - 0x411141dd5af47017, 0x411141dd5af47017, 0x411141dd5af47017, 0x411141dd5af47017, 0x411146c5fe0ae568, 0x411146c5fe0ae568, 0x411146c5fe0ae568, 0x411146c5fe0ae568, - 0x411146c5fe0ae568, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x411150974437d009, 0x411150974437d009, - 0x411150974437d009, 0x411150974437d009, 0x411150974437d009, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, - 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, - 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x4111692273a81a9d, - 0x4111692273a81a9d, 0x4111692273a81a9d, 0x4111692273a81a9d, 0x4111692273a81a9d, 0x41116e0b16be8fee, 0x41116e0b16be8fee, 0x41116e0b16be8fee, 0x41116e0b16be8fee, - 0x41116e0b16be8fee, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, - 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe0, - 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x41118696462eda82, 0x41118696462eda82, 0x41118696462eda82, - 0x41118696462eda82, 0x41118696462eda82, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x411190678c5bc524, - 0x411190678c5bc524, 0x411190678c5bc524, 0x411190678c5bc524, 0x411190678c5bc524, 0x411195502f723a75, 0x411195502f723a75, 0x411195502f723a75, 0x411195502f723a75, - 0x411195502f723a75, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119f21759f2516, 0x41119f21759f2516, - 0x41119f21759f2516, 0x41119f21759f2516, 0x41119f21759f2516, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, - 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111addb5ee28509, 0x4111addb5ee28509, 0x4111addb5ee28509, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbdb9ee66d665817f, 0xbdb9ee66d665817f, 0xbdb9ee66d665817f, 0xbdab3bb293b6f6f3, 0xbdab3bb293b6f6f3, 0xbdab3bb293b6f6f3, 0xbdab3bb293b6f6f3, 0xbdab3bb293b6f6f3, - 0xbd74d4bbd5175735, 0xbd74d4bbd5175735, 0xbd74d4bbd5175735, 0xbd74d4bbd5175735, 0xbd74d4bbd5175735, 0x3da606839e712125, 0x3da606839e712125, 0x3da606839e712125, - 0x3da606839e712125, 0x3da606839e712125, 0x3db753cf5bc29699, 0x3db753cf5bc29699, 0x3db753cf5bc29699, 0x3db753cf5bc29699, 0x3db753cf5bc29699, 0xbdbc5ba317b36361, - 0xbdbc5ba317b36361, 0xbdbc5ba317b36361, 0xbdbc5ba317b36361, 0xbdbc5ba317b36361, 0xbdb00b158b295d5b, 0xbdb00b158b295d5b, 0xbdb00b158b295d5b, 0xbdb00b158b295d5b, - 0xbdb00b158b295d5b, 0xbd8dd43ff4fabaa9, 0xbd8dd43ff4fabaa9, 0xbd8dd43ff4fabaa9, 0xbd8dd43ff4fabaa9, 0xbd8dd43ff4fabaa9, 0x3da12c0b1bd55d62, 0x3da12c0b1bd55d62, - 0x3da12c0b1bd55d62, 0x3da12c0b1bd55d62, 0x3da12c0b1bd55d62, 0x3db4e6931a74b4b7, 0x3db4e6931a74b4b7, 0x3db4e6931a74b4b7, 0x3db4e6931a74b4b7, 0x3db4e6931a74b4b7, - 0xbdbec8df59014543, 0xbdbec8df59014543, 0xbdbec8df59014543, 0xbdbec8df59014543, 0xbdbec8df59014543, 0xbdb27851cc773f3d, 0xbdb27851cc773f3d, 0xbdb27851cc773f3d, - 0xbdb27851cc773f3d, 0xbdb27851cc773f3d, 0xbd989f10ffb4e4dc, 0xbd989f10ffb4e4dc, 0xbd989f10ffb4e4dc, 0xbd989f10ffb4e4dc, 0xbd989f10ffb4e4dc, 0x3d98a3253273333c, - 0x3d98a3253273333c, 0x3d98a3253273333c, 0x3d98a3253273333c, 0x3d98a3253273333c, 0x3db27956d926d2d5, 0x3db27956d926d2d5, 0x3db27956d926d2d5, 0x3db27956d926d2d5, - 0x3db27956d926d2d5, 0x3dbec9e465b0d8db, 0x3dbec9e465b0d8db, 0x3dbec9e465b0d8db, 0x3dbec9e465b0d8db, 0x3dbec9e465b0d8db, 0xbdb4e58e0dc5211f, 0xbdb4e58e0dc5211f, - 0xbdb4e58e0dc5211f, 0xbdb4e58e0dc5211f, 0xbdb4e58e0dc5211f, 0xbda12a0102763632, 0xbda12a0102763632, 0xbda12a0102763632, 0xbda12a0102763632, 0xbda12a0102763632, - 0x3d8ddc685a775769, 0x3d8ddc685a775769, 0x3d8ddc685a775769, 0x3d8ddc685a775769, 0x3d8ddc685a775769, 0x3db00c1a97d8f0f3, 0x3db00c1a97d8f0f3, 0x3db00c1a97d8f0f3, - 0x3db00c1a97d8f0f3, 0x3db00c1a97d8f0f3, 0x3dbc5ca82462f6f9, 0x3dbc5ca82462f6f9, 0x3dbc5ca82462f6f9, 0x3dbc5ca82462f6f9, 0x3dbc5ca82462f6f9, 0xbdb752ca4f130301, - 0xbdb752ca4f130301, 0xbdb752ca4f130301, 0xbdb752ca4f130301, 0xbdb752ca4f130301, 0xbda604798511f9f6, 0xbda604798511f9f6, 0xbda604798511f9f6, 0xbda604798511f9f6, - 0xbda604798511f9f6, 0x3d74e50ca01090b4, 0x3d74e50ca01090b4, 0x3d74e50ca01090b4, 0x3d74e50ca01090b4, 0x3d74e50ca01090b4, 0x3dab3dbcad161e23, 0x3dab3dbcad161e23, - 0x3dab3dbcad161e23, 0x3dab3dbcad161e23, 0x3dab3dbcad161e23, 0x3db9ef6be3151517, 0x3db9ef6be3151517, 0x3db9ef6be3151517, 0x3db9ef6be3151517, 0x3db9ef6be3151517, - 0xbdb9c0069060e4e3, 0xbdb9c0069060e4e3, 0xbdb9c0069060e4e3, 0xbdb9c0069060e4e3, 0xbdb9c0069060e4e3, 0xbdaadef207adbdb9, 0xbdaadef207adbdb9, 0xbdaadef207adbdb9, - 0xbdaadef207adbdb9, 0xbdaadef207adbdb9, 0xbd71eeb774cd8d6a, 0xbd71eeb774cd8d6a, 0xbd71eeb774cd8d6a, 0xbd71eeb774cd8d6a, 0xbd71eeb774cd8d6a, 0x3da663442a7a5a5f, - 0x3da663442a7a5a5f, 0x3da663442a7a5a5f, 0x3da663442a7a5a5f, 0x3da663442a7a5a5f, 0x3db7822fa1c73335, 0x3db7822fa1c73335, 0x3db7822fa1c73335, 0x3db7822fa1c73335, - 0x3db7822fa1c73335, 0xbdbc2d42d1aec6c5, 0xbdbc2d42d1aec6c5, 0xbdbc2d42d1aec6c5, 0xbdbc2d42d1aec6c5, 0xbdbc2d42d1aec6c5, 0xbdafb96a8a49817d, 0xbdafb96a8a49817d, - 0xbdafb96a8a49817d, 0xbdafb96a8a49817d, 0xbdafb96a8a49817d, 0xbd8c613dc4d5d5c4, 0xbd8c613dc4d5d5c4, 0xbd8c613dc4d5d5c4, 0xbd8c613dc4d5d5c4, 0xbd8c613dc4d5d5c4, - 0x3da188cba7de969b, 0x3da188cba7de969b, 0x3da188cba7de969b, 0x3da188cba7de969b, 0x3da188cba7de969b, 0x3db514f360795154, 0x3db514f360795154, 0x3db514f360795154, - 0x3db514f360795154, 0x3db514f360795154, 0xbdbe9a7f12fca8a6, 0xbdbe9a7f12fca8a6, 0xbdbe9a7f12fca8a6, 0xbdbe9a7f12fca8a6, 0xbdbe9a7f12fca8a6, 0xbdb249f18672a2a0, - 0xbdb249f18672a2a0, 0xbdb249f18672a2a0, 0xbdb249f18672a2a0, 0xbdb249f18672a2a0, 0xbd97e58fe7a27269, 0xbd97e58fe7a27269, 0xbd97e58fe7a27269, 0xbd97e58fe7a27269, - 0xbd97e58fe7a27269, 0x3d995ca64a85a5af, 0x3d995ca64a85a5af, 0x3d995ca64a85a5af, 0x3d995ca64a85a5af, 0x3d995ca64a85a5af, 0x3db2a7b71f2b6f72, 0x3db2a7b71f2b6f72, - 0x3db2a7b71f2b6f72, 0x3db2a7b71f2b6f72, 0x3db2a7b71f2b6f72, 0x3dbef844abb57578, 0x3dbef844abb57578, 0x3dbef844abb57578, 0x3dbef844abb57578, 0xbdc083ddaa254544, - 0xbdb4b72dc7c08482, 0xbdb4b72dc7c08482, 0xbdb4b72dc7c08482, 0xbdb4b72dc7c08482, 0xbdb4b72dc7c08482, 0xbda0cd40766cfcf8, 0xbda0cd40766cfcf8, 0xbda0cd40766cfcf8, - 0xbda0cd40766cfcf8, 0xbda0cd40766cfcf8, 0x3d8f4f6a8a9c3c4e, 0x3d8f4f6a8a9c3c4e, 0x3d8f4f6a8a9c3c4e, 0x3d8f4f6a8a9c3c4e, 0x3d8f4f6a8a9c3c4e, 0x3db03a7adddd8d90, - 0x3db03a7adddd8d90, 0x3db03a7adddd8d90, 0x3db03a7adddd8d90, 0x3db03a7adddd8d90, 0x3dbc8b086a679396, 0x3dbc8b086a679396, 0x3dbc8b086a679396, 0x3dbc8b086a679396, - 0x3dbc8b086a679396, 0xbdb7246a090e6664, 0xbdb7246a090e6664, 0xbdb7246a090e6664, 0xbdb7246a090e6664, 0xbdb7246a090e6664, 0xbda5a7b8f908c0bc, 0xbda5a7b8f908c0bc, - 0xbda5a7b8f908c0bc, 0xbda5a7b8f908c0bc, 0xbda5a7b8f908c0bc, 0x3d77cb11005a5a7f, 0x3d77cb11005a5a7f, 0x3d77cb11005a5a7f, 0x3d77cb11005a5a7f, 0x3d77cb11005a5a7f, - 0x3dab9a7d391f575c, 0x3dab9a7d391f575c, 0x3dab9a7d391f575c, 0x3dab9a7d391f575c, 0x3dab9a7d391f575c, 0x3dba1dcc2919b1b4, 0x3dba1dcc2919b1b4, 0x3dba1dcc2919b1b4, -] )) ), - -################ chunk 9216 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4111addb5ee28509, 0x4111addb5ee28509, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b7aca50f6faa, - 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111bc954825e4fb, 0x4111bc954825e4fb, 0x4111bc954825e4fb, 0x4111bc954825e4fb, - 0x4111bc954825e4fb, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, - 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, - 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d52077962f8f, 0x4111d52077962f8f, 0x4111d52077962f8f, - 0x4111d52077962f8f, 0x4111d52077962f8f, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111def1bdc31a31, - 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111e3da60d98f81, 0x4111e3da60d98f81, 0x4111e3da60d98f81, 0x4111e3da60d98f81, - 0x4111e3da60d98f81, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111edaba7067a23, 0x4111edaba7067a23, - 0x4111edaba7067a23, 0x4111edaba7067a23, 0x4111edaba7067a23, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, - 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111fc659049da16, 0x4111fc659049da16, 0x4111fc659049da16, - 0x4111fc659049da16, 0x4111fc659049da15, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x41120636d676c4b7, - 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120b1f798d3a08, 0x41120b1f798d3a08, 0x41120b1f798d3a08, 0x41120b1f798d3a08, - 0x41120b1f798d3a08, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411214f0bfba24aa, 0x411214f0bfba24aa, - 0x411214f0bfba24aa, 0x411214f0bfba24aa, 0x411214f0bfba24aa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, - 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x411223aaa8fd849c, 0x411223aaa8fd849c, 0x411223aaa8fd849c, - 0x411223aaa8fd849c, 0x411223aaa8fd849c, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x41122d7bef2a6f3e, - 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x411232649240e48e, 0x411232649240e48e, 0x411232649240e48e, 0x411232649240e48e, - 0x411232649240e48e, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x41123c35d86dcf30, 0x41123c35d86dcf30, - 0x41123c35d86dcf30, 0x41123c35d86dcf30, 0x41123c35d86dcf30, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, - 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x41124aefc1b12f22, 0x41124aefc1b12f22, 0x41124aefc1b12f22, - 0x41124aefc1b12f22, 0x41124aefc1b12f22, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x411254c107de19c4, - 0x411254c107de19c4, 0x411254c107de19c4, 0x411254c107de19c4, 0x411254c107de19c4, 0x411259a9aaf48f15, 0x411259a9aaf48f15, 0x411259a9aaf48f15, 0x411259a9aaf48f15, - 0x411259a9aaf48f15, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x4112637af12179b6, 0x4112637af12179b6, - 0x4112637af12179b6, 0x4112637af12179b6, 0x4112637af12179b6, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, - 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41127234da64d9a9, 0x41127234da64d9a9, 0x41127234da64d9a9, - 0x41127234da64d9a9, 0x41127234da64d9a9, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x41127c062091c44b, - 0x41127c062091c44b, 0x41127c062091c44b, 0x41127c062091c44b, 0x41127c062091c44a, 0x411280eec3a8399b, 0x411280eec3a8399b, 0x411280eec3a8399b, 0x411280eec3a8399b, - 0x411280eec3a8399b, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x41128ac009d5243d, 0x41128ac009d5243d, - 0x41128ac009d5243d, 0x41128ac009d5243d, 0x41128ac009d5243d, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, - 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x41129979f318842f, 0x41129979f318842f, 0x41129979f318842f, - 0x41129979f318842f, 0x41129979f318842f, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x4112a34b39456ed1, - 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a833dc5be422, 0x4112a833dc5be422, 0x4112a833dc5be422, 0x4112a833dc5be422, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3dba1dcc2919b1b4, 0x3dba1dcc2919b1b4, 0xbdb991a64a5c4846, 0xbdb991a64a5c4846, 0xbdb991a64a5c4846, 0xbdb991a64a5c4846, 0xbdb991a64a5c4846, 0xbdaa82317ba48480, - 0xbdaa82317ba48480, 0xbdaa82317ba48480, 0xbdaa82317ba48480, 0xbdaa82317ba48480, 0xbd6e11662907873e, 0xbd6e11662907873e, 0xbd6e11662907873e, 0xbd6e11662907873e, - 0xbd6e11662907873e, 0x3da6c004b6839398, 0x3da6c004b6839398, 0x3da6c004b6839398, 0x3da6c004b6839398, 0x3da6c004b6839398, 0x3db7b08fe7cbcfd2, 0x3db7b08fe7cbcfd2, - 0x3db7b08fe7cbcfd2, 0x3db7b08fe7cbcfd2, 0x3db7b08fe7cbcfd2, 0xbdbbfee28baa2a28, 0xbdbbfee28baa2a28, 0xbdbbfee28baa2a28, 0xbdbbfee28baa2a28, 0xbdbbfee28baa2a28, - 0xbdaf5ca9fe404844, 0xbdaf5ca9fe404844, 0xbdaf5ca9fe404844, 0xbdaf5ca9fe404844, 0xbdaf5ca9fe404844, 0xbd8aee3b94b0f0df, 0xbd8aee3b94b0f0df, 0xbd8aee3b94b0f0df, - 0xbd8aee3b94b0f0df, 0xbd8aee3b94b0f0df, 0x3da1e58c33e7cfd4, 0x3da1e58c33e7cfd4, 0x3da1e58c33e7cfd4, 0x3da1e58c33e7cfd4, 0x3da1e58c33e7cfd4, 0x3db54353a67dedf0, - 0x3db54353a67dedf0, 0x3db54353a67dedf0, 0x3db54353a67dedf0, 0x3db54353a67dedf0, 0xbdbe6c1eccf80c0a, 0xbdbe6c1eccf80c0a, 0xbdbe6c1eccf80c0a, 0xbdbe6c1eccf80c0a, - 0xbdbe6c1eccf80c0a, 0xbdb21b91406e0604, 0xbdb21b91406e0604, 0xbdb21b91406e0604, 0xbdb21b91406e0604, 0xbdb21b91406e0604, 0xbd972c0ecf8ffff7, 0xbd972c0ecf8ffff7, - 0xbd972c0ecf8ffff7, 0xbd972c0ecf8ffff7, 0xbd972c0ecf8ffff7, 0x3d9a162762981821, 0x3d9a162762981821, 0x3d9a162762981821, 0x3d9a162762981821, 0x3d9a162762981821, - 0x3db2d61765300c0e, 0x3db2d61765300c0e, 0x3db2d61765300c0e, 0x3db2d61765300c0e, 0x3db2d61765300c0e, 0x3dbf26a4f1ba1214, 0x3dbf26a4f1ba1214, 0x3dbf26a4f1ba1214, - 0x3dbf26a4f1ba1214, 0xbdc06cad8722f6f6, 0xbdb488cd81bbe7e6, 0xbdb488cd81bbe7e6, 0xbdb488cd81bbe7e6, 0xbdb488cd81bbe7e6, 0xbdb488cd81bbe7e6, 0xbda0707fea63c3bf, - 0xbda0707fea63c3bf, 0xbda0707fea63c3bf, 0xbda0707fea63c3bf, 0xbda0707fea63c3bf, 0x3d9061365d60909a, 0x3d9061365d60909a, 0x3d9061365d60909a, 0x3d9061365d60909a, - 0x3d9061365d60909a, 0x3db068db23e22a2c, 0x3db068db23e22a2c, 0x3db068db23e22a2c, 0x3db068db23e22a2c, 0x3db068db23e22a2c, 0x3dbcb968b06c3033, 0x3dbcb968b06c3033, - 0x3dbcb968b06c3033, 0x3dbcb968b06c3033, 0x3dbcb968b06c3033, 0xbdb6f609c309c9c7, 0xbdb6f609c309c9c7, 0xbdb6f609c309c9c7, 0xbdb6f609c309c9c7, 0xbdb6f609c309c9c7, - 0xbda54af86cff8783, 0xbda54af86cff8783, 0xbda54af86cff8783, 0xbda54af86cff8783, 0xbda54af86cff8783, 0x3d7ab11560a4244a, 0x3d7ab11560a4244a, 0x3d7ab11560a4244a, - 0x3d7ab11560a4244a, 0x3d7ab11560a4244a, 0x3dabf73dc5289095, 0x3dabf73dc5289095, 0x3dabf73dc5289095, 0x3dabf73dc5289095, 0x3dabf73dc5289095, 0x3dba4c2c6f1e4e51, - 0x3dba4c2c6f1e4e51, 0x3dba4c2c6f1e4e51, 0x3dba4c2c6f1e4e51, 0x3dba4c2c6f1e4e51, 0xbdb963460457aba9, 0xbdb963460457aba9, 0xbdb963460457aba9, 0xbdb963460457aba9, - 0xbdb963460457aba9, 0xbdaa2570ef9b4b47, 0xbdaa2570ef9b4b47, 0xbdaa2570ef9b4b47, 0xbdaa2570ef9b4b47, 0xbdaa2570ef9b4b47, 0xbd68455d6873f3a9, 0xbd68455d6873f3a9, - 0xbd68455d6873f3a9, 0xbd68455d6873f3a9, 0xbd68455d6873f3a9, 0x3da71cc5428cccd2, 0x3da71cc5428cccd2, 0x3da71cc5428cccd2, 0x3da71cc5428cccd2, 0x3da71cc5428cccd2, - 0x3db7def02dd06c6f, 0x3db7def02dd06c6f, 0x3db7def02dd06c6f, 0x3db7def02dd06c6f, 0x3db7def02dd06c6f, 0xbdbbd08245a58d8b, 0xbdbbd08245a58d8b, 0xbdbbd08245a58d8b, - 0xbdbbd08245a58d8b, 0xbdbbd08245a58d8b, 0xbdaeffe972370f0a, 0xbdaeffe972370f0a, 0xbdaeffe972370f0a, 0xbdaeffe972370f0a, 0xbdaeffe972370f0a, 0xbd897b39648c0bf9, - 0xbd897b39648c0bf9, 0xbd897b39648c0bf9, 0xbd897b39648c0bf9, 0xbd897b39648c0bf9, 0x3da2424cbff1090e, 0x3da2424cbff1090e, 0x3da2424cbff1090e, 0x3da2424cbff1090e, - 0x3da2424cbff1090e, 0x3db571b3ec828a8d, 0x3db571b3ec828a8d, 0x3db571b3ec828a8d, 0x3db571b3ec828a8d, 0x3db571b3ec828a8d, 0xbdbe3dbe86f36f6d, 0xbdbe3dbe86f36f6d, - 0xbdbe3dbe86f36f6d, 0xbdbe3dbe86f36f6d, 0xbdbe3dbe86f36f6d, 0xbdb1ed30fa696967, 0xbdb1ed30fa696967, 0xbdb1ed30fa696967, 0xbdb1ed30fa696967, 0xbdb1ed30fa696967, - 0xbd96728db77d8d84, 0xbd96728db77d8d84, 0xbd96728db77d8d84, 0xbd96728db77d8d84, 0xbd96728db77d8d84, 0x3d9acfa87aaa8a94, 0x3d9acfa87aaa8a94, 0x3d9acfa87aaa8a94, - 0x3d9acfa87aaa8a94, 0x3d9acfa87aaa8a94, 0x3db30477ab34a8ab, 0x3db30477ab34a8ab, 0x3db30477ab34a8ab, 0x3db30477ab34a8ab, 0x3db30477ab34a8ab, 0x3dbf550537beaeb1, - 0x3dbf550537beaeb1, 0x3dbf550537beaeb1, 0x3dbf550537beaeb1, 0xbdc0557d6420a8a7, 0xbdb45a6d3bb74b49, 0xbdb45a6d3bb74b49, 0xbdb45a6d3bb74b49, 0xbdb45a6d3bb74b49, - 0xbdb45a6d3bb74b49, 0xbda013bf5e5a8a86, 0xbda013bf5e5a8a86, 0xbda013bf5e5a8a86, 0xbda013bf5e5a8a86, 0xbda013bf5e5a8a86, 0x3d911ab77573030d, 0x3d911ab77573030d, - 0x3d911ab77573030d, 0x3d911ab77573030d, 0x3d911ab77573030d, 0x3db0973b69e6c6c9, 0x3db0973b69e6c6c9, 0x3db0973b69e6c6c9, 0x3db0973b69e6c6c9, 0x3db0973b69e6c6c9, - 0x3dbce7c8f670cccf, 0x3dbce7c8f670cccf, 0x3dbce7c8f670cccf, 0x3dbce7c8f670cccf, 0x3dbce7c8f670cccf, 0xbdb6c7a97d052d2b, 0xbdb6c7a97d052d2b, 0xbdb6c7a97d052d2b, - 0xbdb6c7a97d052d2b, 0xbdb6c7a97d052d2b, 0xbda4ee37e0f64e4a, 0xbda4ee37e0f64e4a, 0xbda4ee37e0f64e4a, 0xbda4ee37e0f64e4a, 0xbda4ee37e0f64e4a, 0x3d7d9719c0edee14, - 0x3d7d9719c0edee14, 0x3d7d9719c0edee14, 0x3d7d9719c0edee14, 0x3d7d9719c0edee14, 0x3dac53fe5131c9cf, 0x3dac53fe5131c9cf, 0x3dac53fe5131c9cf, 0x3dac53fe5131c9cf, -] )) ), - -################ chunk 9728 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4112a833dc5be422, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112b2052288cec3, 0x4112b2052288cec3, - 0x4112b2052288cec3, 0x4112b2052288cec3, 0x4112b2052288cec3, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, - 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, - 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112ca9051f91957, - 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, - 0x4112cf78f50f8ea8, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, - 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, - 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e804247fd93c, 0x4112e804247fd93c, 0x4112e804247fd93c, - 0x4112e804247fd93c, 0x4112e804247fd93c, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112f1d56aacc3de, - 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, - 0x4112f6be0dc3392f, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae7f, 0x4113008f53f023d0, 0x4113008f53f023d0, - 0x4113008f53f023d0, 0x4113008f53f023d0, 0x4113008f53f023d0, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, - 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130f493d3383c3, 0x41130f493d3383c3, 0x41130f493d3383c3, - 0x41130f493d3383c3, 0x41130f493d3383c3, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x4113191a83606e64, - 0x4113191a83606e64, 0x4113191a83606e64, 0x4113191a83606e64, 0x4113191a83606e64, 0x41131e032676e3b5, 0x41131e032676e3b5, 0x41131e032676e3b5, 0x41131e032676e3b5, - 0x41131e032676e3b5, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411327d46ca3ce57, 0x411327d46ca3ce57, - 0x411327d46ca3ce57, 0x411327d46ca3ce57, 0x411327d46ca3ce57, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, - 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x40774475ad031dbf, 0x40774475ad031dbf, 0x40774475ad031dbf, - 0x40774475ad031dc0, 0x40774475ad031dbf, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x4089156a569a0b02, - 0x4089156a569a0b02, 0x4089156a569a0b02, 0x4089156a569a0b02, 0x4089156a569a0b02, 0x408fcf0216a64913, 0x408fcf0216a64913, 0x408fcf0216a64913, 0x408fcf0216a64913, - 0x408fcf0216a64913, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4096a118cb5f629a, 0x4096a118cb5f629a, - 0x4096a118cb5f629a, 0x4096a118cb5f629a, 0x4096a118cb5f629a, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, - 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, - 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a3b88a15befee2, - 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a566f005c20e67, 0x40a566f005c20e67, 0x40a566f005c20e67, 0x40a566f005c20e67, - 0x40a566f005c20e67, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, - 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, - 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, - 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40b095dccaebbd82, - 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, - 0x40b16d0fc2ed4544, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, - 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3dac53fe5131c9cf, 0x3dba7a8cb522eaed, 0x3dba7a8cb522eaed, 0x3dba7a8cb522eaed, 0x3dba7a8cb522eaed, 0x3dba7a8cb522eaed, 0xbdb934e5be530f0d, 0xbdb934e5be530f0d, - 0xbdb934e5be530f0d, 0xbdb934e5be530f0d, 0xbdb934e5be530f0d, 0xbda9c8b06392120d, 0xbda9c8b06392120d, 0xbda9c8b06392120d, 0xbda9c8b06392120d, 0xbda9c8b06392120d, - 0xbd627954a7e06013, 0xbd627954a7e06013, 0xbd627954a7e06013, 0xbd627954a7e06013, 0xbd627954a7e06013, 0x3da77985ce96060b, 0x3da77985ce96060b, 0x3da77985ce96060b, - 0x3da77985ce96060b, 0x3da77985ce96060b, 0x3db80d5073d5090b, 0x3db80d5073d5090b, 0x3db80d5073d5090b, 0x3db80d5073d5090b, 0x3db80d5073d5090b, 0xbdbba221ffa0f0ef, - 0xbdbba221ffa0f0ef, 0xbdbba221ffa0f0ef, 0xbdbba221ffa0f0ef, 0xbdbba221ffa0f0ef, 0xbdaea328e62dd5d1, 0xbdaea328e62dd5d1, 0xbdaea328e62dd5d1, 0xbdaea328e62dd5d1, - 0xbdaea328e62dd5d1, 0xbd88083734672714, 0xbd88083734672714, 0xbd88083734672714, 0xbd88083734672714, 0xbd88083734672714, 0x3da29f0d4bfa4247, 0x3da29f0d4bfa4247, - 0x3da29f0d4bfa4247, 0x3da29f0d4bfa4247, 0x3da29f0d4bfa4247, 0x3db5a0143287272a, 0x3db5a0143287272a, 0x3db5a0143287272a, 0x3db5a0143287272a, 0x3db5a0143287272a, - 0xbdbe0f5e40eed2d0, 0xbdbe0f5e40eed2d0, 0xbdbe0f5e40eed2d0, 0xbdbe0f5e40eed2d0, 0xbdbe0f5e40eed2d0, 0xbdb1bed0b464ccca, 0xbdb1bed0b464ccca, 0xbdb1bed0b464ccca, - 0xbdb1bed0b464ccca, 0xbdb1bed0b464ccca, 0xbd95b90c9f6b1b11, 0xbd95b90c9f6b1b11, 0xbd95b90c9f6b1b11, 0xbd95b90c9f6b1b11, 0xbd95b90c9f6b1b11, 0x3d9b892992bcfd07, - 0x3d9b892992bcfd07, 0x3d9b892992bcfd07, 0x3d9b892992bcfd07, 0x3d9b892992bcfd07, 0x3db332d7f1394548, 0x3db332d7f1394548, 0x3db332d7f1394548, 0x3db332d7f1394548, - 0x3db332d7f1394548, 0x3dbf83657dc34b4e, 0x3dbf83657dc34b4e, 0x3dbf83657dc34b4e, 0x3dbf83657dc34b4e, 0xbdc03e4d411e5a59, 0xbdb42c0cf5b2aeac, 0xbdb42c0cf5b2aeac, - 0xbdb42c0cf5b2aeac, 0xbdb42c0cf5b2aeac, 0xbdb42c0cf5b2aeac, 0xbd9f6dfda4a2a299, 0xbd9f6dfda4a2a299, 0xbd9f6dfda4a2a299, 0xbd9f6dfda4a2a299, 0xbd9f6dfda4a2a299, - 0x3d91d4388d85757f, 0x3d91d4388d85757f, 0x3d91d4388d85757f, 0x3d91d4388d85757f, 0x3d91d4388d85757f, 0x3db0c59bafeb6366, 0x3db0c59bafeb6366, 0x3db0c59bafeb6366, - 0x3db0c59bafeb6366, 0x3db0c59bafeb6366, 0x3dbd16293c75696c, 0x3dbd16293c75696c, 0x3dbd16293c75696c, 0x3dbd16293c75696c, 0x3dbd16293c75696c, 0xbdb699493700908e, - 0xbdb699493700908e, 0xbdb699493700908e, 0xbdb699493700908e, 0xbdb699493700908e, 0xbda4917754ed1510, 0xbda4917754ed1510, 0xbda4917754ed1510, 0xbda4917754ed1510, - 0xbda4917754ed1510, 0x3d803e8f109bdbf0, 0x3d803e8f109bdbf0, 0x3d803e8f109bdbf0, 0x3d803e8f109bdbf0, 0x3d803e8f109bdbf0, 0x3dacb0bedd3b0308, 0x3dacb0bedd3b0308, - 0x3dacb0bedd3b0308, 0x3dacb0bedd3b0308, 0x3dacb0bedd3b0308, 0x3dbaa8ecfb27878a, 0x3dbaa8ecfb27878a, 0x3dbaa8ecfb27878a, 0x3dbaa8ecfb27878a, 0x3dbaa8ecfb27878a, - 0x3cd1b19140c0c0d5, 0x3cd1b19140c0c0d5, 0x3cd1b19140c0c0d5, 0x3cd1b19140c0c0d5, 0x3cd1b19140c0c0d5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd211ba218b020c7, 0xbd211ba218b020c7, 0xbd211ba218b020c7, 0xbd211ba218b020c7, 0xbd211ba218b020c7, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d21a9b7a75a3b87, 0x3d21a9b7a75a3b87, 0x3d21a9b7a75a3b87, 0x3d21a9b7a75a3b87, - 0x3d21a9b7a75a3b87, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d36e41964fdd4dc, 0x3d36e41964fdd4dc, - 0x3d36e41964fdd4dc, 0x3d36e41964fdd4dc, 0x3d36e41964fdd4dc, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd369d0e9da8c77c, 0xbd369d0e9da8c77c, 0xbd369d0e9da8c77c, 0xbd369d0e9da8c77c, 0xbd369d0e9da8c77c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d365603d653ba1c, 0x3d365603d653ba1c, 0x3d365603d653ba1c, 0x3d365603d653ba1c, 0x3d365603d653ba1c, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d44f8837880a9a2, 0x3d44f8837880a9a2, 0x3d44f8837880a9a2, 0x3d44f8837880a9a2, - 0x3d44f8837880a9a2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d35c7ee47a99f5c, 0x3d35c7ee47a99f5c, - 0x3d35c7ee47a99f5c, 0x3d35c7ee47a99f5c, 0x3d35c7ee47a99f5c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d453f8e3fd5b702, 0x3d453f8e3fd5b702, 0x3d453f8e3fd5b702, 0x3d453f8e3fd5b702, 0x3d453f8e3fd5b702, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d3539d8b8ff849b, 0x3d3539d8b8ff849b, 0x3d3539d8b8ff849b, 0x3d3539d8b8ff849b, 0x3d3539d8b8ff849b, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd553cb37c6a9dcf, 0xbd553cb37c6a9dcf, 0xbd553cb37c6a9dcf, 0xbd553cb37c6a9dcf, - 0xbd553cb37c6a9dcf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5ad50f356aa589, 0xbd5ad50f356aa589, - 0xbd5ad50f356aa589, 0xbd5ad50f356aa589, 0xbd5ad50f356aa589, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, -] )) ), - -################ chunk 10240 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, - 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b74f748af7fb93, - 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b826a782f98355, 0x40b826a782f98355, 0x40b826a782f98355, 0x40b826a782f98355, - 0x40b826a782f98355, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, - 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, - 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, - 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40be090c4b0439a4, - 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40bee03f4305c166, 0x40bee03f4305c166, 0x40bee03f4305c166, 0x40bee03f4305c166, - 0x40bee03f4305c166, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40c0475299846875, 0x40c0475299846875, - 0x40c0475299846875, 0x40c0475299846875, 0x40c0475299846875, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, - 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, - 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c2615205883bdb, - 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, - 0x40c2cceb8188ffbc, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c3a41e798a877e, 0x40c3a41e798a877e, - 0x40c3a41e798a877e, 0x40c3a41e798a877e, 0x40c3a41e798a877e, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, - 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, - 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c5be1de58e5ae3, - 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, - 0x40c629b7618f1ec4, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c700ea5990a686, 0x40c700ea5990a686, - 0x40c700ea5990a686, 0x40c700ea5990a686, 0x40c700ea5990a686, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, - 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c843b6cd92f229, 0x40c843b6cd92f229, 0x40c843b6cd92f229, - 0x40c843b6cd92f229, 0x40c843b6cd92f229, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c91ae9c59479ec, - 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c9868341953dcd, 0x40c9868341953dcd, 0x40c9868341953dcd, 0x40c9868341953dcd, - 0x40c9868341953dcd, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40ca5db63996c58f, 0x40ca5db63996c58f, - 0x40ca5db63996c58f, 0x40ca5db63996c58f, 0x40ca5db63996c58f, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, - 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cba082ad991132, 0x40cba082ad991132, 0x40cba082ad991132, - 0x40cba082ad991132, 0x40cba082ad991132, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc77b5a59a98f4, - 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, - 0x40cce34f219b5cd5, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cdba82199ce497, 0x40cdba82199ce497, - 0x40cdba82199ce497, 0x40cdba82199ce497, 0x40cdba82199ce497, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, - 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, - 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cfd48185a0b7fd, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d45cda3ce7fd1c3, 0x3d45cda3ce7fd1c3, 0x3d45cda3ce7fd1c3, 0x3d45cda3ce7fd1c3, 0x3d45cda3ce7fd1c3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d341dad9bab4f1b, 0x3d341dad9bab4f1b, 0x3d341dad9bab4f1b, 0x3d341dad9bab4f1b, 0x3d341dad9bab4f1b, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd54f5a8b515906f, 0xbd54f5a8b515906f, 0xbd54f5a8b515906f, 0xbd54f5a8b515906f, - 0xbd54f5a8b515906f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5b1c19fcbfb2e9, 0xbd5b1c19fcbfb2e9, - 0xbd5b1c19fcbfb2e9, 0xbd5b1c19fcbfb2e9, 0xbd5b1c19fcbfb2e9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d465bb95d29ec83, 0x3d465bb95d29ec83, 0x3d465bb95d29ec83, 0x3d465bb95d29ec83, 0x3d465bb95d29ec83, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d3301827e57199a, 0x3d3301827e57199a, 0x3d3301827e57199a, 0x3d3301827e57199a, 0x3d3301827e57199a, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd54ae9dedc0830e, 0xbd54ae9dedc0830e, 0xbd54ae9dedc0830e, 0xbd54ae9dedc0830e, - 0xbd54ae9dedc0830e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d624e6d9df59fdb, 0x3d624e6d9df59fdb, - 0x3d624e6d9df59fdb, 0x3d624e6d9df59fdb, 0x3d624e6d9df59fdb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd6a458c450afe2f, 0xbd6a458c450afe2f, 0xbd6a458c450afe2f, 0xbd6a458c450afe2f, 0xbd6a458c450afe2f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6dc35513dfa37d, 0xbd6dc35513dfa37d, 0xbd6dc35513dfa37d, 0xbd6dc35513dfa37d, 0xbd6dc35513dfa37d, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d65cc366cca4529, 0x3d65cc366cca4529, 0x3d65cc366cca4529, 0x3d65cc366cca4529, - 0x3d65cc366cca4529, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5baa2f8b69cdaa, 0xbd5baa2f8b69cdaa, - 0xbd5baa2f8b69cdaa, 0xbd5baa2f8b69cdaa, 0xbd5baa2f8b69cdaa, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d4777e47a7e2204, 0x3d4777e47a7e2204, 0x3d4777e47a7e2204, 0x3d4777e47a7e2204, 0x3d4777e47a7e2204, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d30c92c43aeae99, 0x3d30c92c43aeae99, 0x3d30c92c43aeae99, 0x3d30c92c43aeae99, 0x3d30c92c43aeae99, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd5420885f16684e, 0xbd5420885f16684e, 0xbd5420885f16684e, 0xbd5420885f16684e, - 0xbd5420885f16684e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d620762d6a0927b, 0x3d620762d6a0927b, - 0x3d620762d6a0927b, 0x3d620762d6a0927b, 0x3d620762d6a0927b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd69fe817db5f0cf, 0xbd69fe817db5f0cf, 0xbd69fe817db5f0cf, 0xbd69fe817db5f0cf, 0xbd69fe817db5f0cf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6e0a5fdb34b0dd, 0xbd6e0a5fdb34b0dd, 0xbd6e0a5fdb34b0dd, 0xbd6e0a5fdb34b0dd, 0xbd6e0a5fdb34b0dd, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d661341341f5289, 0x3d661341341f5289, 0x3d661341341f5289, 0x3d661341341f5289, - 0x3d661341341f5289, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5c38451a13e86a, 0xbd5c38451a13e86a, - 0xbd5c38451a13e86a, 0xbd5c38451a13e86a, 0xbd5c38451a13e86a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d48940f97d25784, 0x3d48940f97d25784, 0x3d48940f97d25784, 0x3d48940f97d25784, 0x3d48940f97d25784, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d2d21ac120c872f, 0x3d2d21ac120c872f, 0x3d2d21ac120c872f, 0x3d2d21ac120c872f, 0x3d2d21ac120c872f, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd539272d06c4d8e, 0xbd539272d06c4d8e, 0xbd539272d06c4d8e, 0xbd539272d06c4d8e, - 0xbd539272d06c4d8e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d61c0580f4b851b, 0x3d61c0580f4b851b, - 0x3d61c0580f4b851b, 0x3d61c0580f4b851b, 0x3d61c0580f4b851b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd69b776b660e36f, 0xbd69b776b660e36f, 0xbd69b776b660e36f, 0xbd69b776b660e36f, 0xbd69b776b660e36f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6e516aa289be3d, 0xbd6e516aa289be3d, 0xbd6e516aa289be3d, 0xbd6e516aa289be3d, 0xbd6e516aa289be3d, 0xbff0000000000000, -] )) ), - -################ chunk 10752 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, - 0x40d0200d80d0bdef, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, - 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, - 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, - 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d198a6b2d36b83, - 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, - 0x40d1ce7370d3cd73, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d23a0cecd49154, 0x40d23a0cecd49154, - 0x40d23a0cecd49154, 0x40d23a0cecd49154, 0x40d23a0cecd49154, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, - 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2db7326d5b726, 0x40d2db7326d5b726, 0x40d2db7326d5b726, - 0x40d2db7326d5b726, 0x40d2db7326d5b726, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3470ca2d67b07, - 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, - 0x40d37cd960d6dcf7, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, - 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, - 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, - 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4f57292d98a8b, - 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, - 0x40d52b3f50d9ec7c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, - 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, - 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, - 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d6a3d882dc9a0f, - 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, - 0x40d6d9a540dcfc00, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, - 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, - 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, - 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d8523e72dfa994, - 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8880b30e00b84, 0x40d8880b30e00b84, 0x40d8880b30e00b84, 0x40d8880b30e00b84, - 0x40d8880b30e00b84, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, - 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, - 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, - 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40da00a462e2b918, - 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da367120e31b08, 0x40da367120e31b08, 0x40da367120e31b08, 0x40da367120e31b08, - 0x40da367120e31b08, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d665a4bfb745fe9, 0x3d665a4bfb745fe9, 0x3d665a4bfb745fe9, 0x3d665a4bfb745fe9, - 0x3d665a4bfb745fe9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5cc65aa8be032a, 0xbd5cc65aa8be032a, - 0xbd5cc65aa8be032a, 0xbd5cc65aa8be032a, 0xbd5cc65aa8be032a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d49b03ab5268d05, 0x3d49b03ab5268d05, 0x3d49b03ab5268d05, 0x3d49b03ab5268d05, 0x3d49b03ab5268d05, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d28b0ff9cbbb12c, 0x3d28b0ff9cbbb12c, 0x3d28b0ff9cbbb12c, 0x3d28b0ff9cbbb12c, 0x3d28b0ff9cbbb12c, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd53045d41c232cd, 0xbd53045d41c232cd, 0xbd53045d41c232cd, 0xbd53045d41c232cd, - 0xbd53045d41c232cd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d61794d47f677bb, 0x3d61794d47f677bb, - 0x3d61794d47f677bb, 0x3d61794d47f677bb, 0x3d61794d47f677bb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd69706bef0bd60f, 0xbd69706bef0bd60f, 0xbd69706bef0bd60f, 0xbd69706bef0bd60f, 0xbd69706bef0bd60f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d70b3c54b109a31, 0x3d70b3c54b109a31, 0x3d70b3c54b109a31, 0x3d70b3c54b109a31, 0x3d70b3c54b109a31, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd74af549e9b495b, 0xbd74af549e9b495b, 0xbd74af549e9b495b, 0xbd74af549e9b495b, - 0xbd74af549e9b495b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d78aae3f225f885, 0x3d78aae3f225f885, - 0x3d78aae3f225f885, 0x3d78aae3f225f885, 0x3d78aae3f225f885, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd7ca67345b0a7af, 0xbd7ca67345b0a7af, 0xbd7ca67345b0a7af, 0xbd7ca67345b0a7af, 0xbd7ca67345b0a7af, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7f5dfd66c4a927, 0xbd7f5dfd66c4a927, 0xbd7f5dfd66c4a927, 0xbd7f5dfd66c4a927, 0xbd7f5dfd66c4a927, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, 0x3d7b626e1339f9fd, - 0x3d7b626e1339f9fd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7766debfaf4ad3, 0xbd7766debfaf4ad3, - 0xbd7766debfaf4ad3, 0xbd7766debfaf4ad3, 0xbd7766debfaf4ad3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d736b4f6c249ba9, 0x3d736b4f6c249ba9, 0x3d736b4f6c249ba9, 0x3d736b4f6c249ba9, 0x3d736b4f6c249ba9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6edf803133d8fd, 0xbd6edf803133d8fd, 0xbd6edf803133d8fd, 0xbd6edf803133d8fd, 0xbd6edf803133d8fd, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d66e8618a1e7aa9, 0x3d66e8618a1e7aa9, 0x3d66e8618a1e7aa9, 0x3d66e8618a1e7aa9, - 0x3d66e8618a1e7aa9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5de285c61238ab, 0xbd5de285c61238ab, - 0xbd5de285c61238ab, 0xbd5de285c61238ab, 0xbd5de285c61238ab, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d4be890efcef806, 0x3d4be890efcef806, 0x3d4be890efcef806, 0x3d4be890efcef806, 0x3d4be890efcef806, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d1f9f4d64340a4e, 0x3d1f9f4d64340a4e, 0x3d1f9f4d64340a4e, 0x3d1f9f4d64340a4e, 0x3d1f9f4d64340a4e, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd51e832246dfd4d, 0xbd51e832246dfd4d, 0xbd51e832246dfd4d, 0xbd51e832246dfd4d, - 0xbd51e832246dfd4d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d60eb37b94c5cfa, 0x3d60eb37b94c5cfa, - 0x3d60eb37b94c5cfa, 0x3d60eb37b94c5cfa, 0x3d60eb37b94c5cfa, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd68e2566061bb4e, 0xbd68e2566061bb4e, 0xbd68e2566061bb4e, 0xbd68e2566061bb4e, 0xbd68e2566061bb4e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d706cba83bb8cd1, 0x3d706cba83bb8cd1, 0x3d706cba83bb8cd1, 0x3d706cba83bb8cd1, 0x3d706cba83bb8cd1, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd746849d7463bfb, 0xbd746849d7463bfb, 0xbd746849d7463bfb, 0xbd746849d7463bfb, - 0xbd746849d7463bfb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7863d92ad0eb25, 0x3d7863d92ad0eb25, -] )) ), - -################ chunk 11264 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, - 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db4370d6e504bb, 0x40db4370d6e504bb, 0x40db4370d6e504bb, - 0x40db4370d6e504bb, 0x40db4370d6e504bb, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40dbaf0a52e5c89c, - 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, - 0x40dbe4d710e62a8d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, - 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, - 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, - 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd5d7042e8d820, - 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd933d00e93a11, 0x40dd933d00e93a11, 0x40dd933d00e93a11, 0x40dd933d00e93a11, - 0x40dd933d00e93a11, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, - 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, - 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, - 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40df0bd632ebe7a5, - 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, - 0x40df41a2f0ec4995, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, - 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, - 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e02751537719a4, 0x40e02751537719a4, 0x40e02751537719a4, - 0x40e02751537719a4, 0x40e02751537719a4, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e05d1e11777b94, - 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e078047077ac8d, 0x40e078047077ac8d, 0x40e078047077ac8d, 0x40e078047077ac8d, - 0x40e078047077ac8d, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e0add12e780e7d, 0x40e0add12e780e7d, - 0x40e0add12e780e7d, 0x40e0add12e780e7d, 0x40e0add12e780e7d, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, - 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0fe844b78a166, 0x40e0fe844b78a166, 0x40e0fe844b78a166, - 0x40e0fe844b78a166, 0x40e0fe844b78a166, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1345109790357, - 0x40e1345109790357, 0x40e1345109790357, 0x40e1345109790357, 0x40e1345109790357, 0x40e14f376879344f, 0x40e14f376879344f, 0x40e14f376879344f, 0x40e14f376879344f, - 0x40e14f376879344f, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e185042679963f, 0x40e185042679963f, - 0x40e185042679963f, 0x40e185042679963f, 0x40e185042679963f, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, - 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, - 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e20b84017a8b19, - 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e2266a607abc11, 0x40e2266a607abc11, 0x40e2266a607abc11, 0x40e2266a607abc11, - 0x40e2266a607abc11, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, - 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, - 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d7863d92ad0eb25, 0x3d7863d92ad0eb25, 0x3d7863d92ad0eb25, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd7c5f687e5b9a4f, 0xbd7c5f687e5b9a4f, 0xbd7c5f687e5b9a4f, 0xbd7c5f687e5b9a4f, 0xbd7c5f687e5b9a4f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7fa5082e19b687, 0xbd7fa5082e19b687, 0xbd7fa5082e19b687, 0xbd7fa5082e19b687, 0xbd7fa5082e19b687, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7ba978da8f075d, 0x3d7ba978da8f075d, 0x3d7ba978da8f075d, 0x3d7ba978da8f075d, - 0x3d7ba978da8f075d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd77ade987045833, 0xbd77ade987045833, - 0xbd77ade987045833, 0xbd77ade987045833, 0xbd77ade987045833, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d73b25a3379a909, 0x3d73b25a3379a909, 0x3d73b25a3379a909, 0x3d73b25a3379a909, 0x3d73b25a3379a909, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6f6d95bfddf3be, 0xbd6f6d95bfddf3be, 0xbd6f6d95bfddf3be, 0xbd6f6d95bfddf3be, 0xbd6f6d95bfddf3be, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d67767718c8956a, 0x3d67767718c8956a, 0x3d67767718c8956a, 0x3d67767718c8956a, - 0x3d67767718c8956a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5efeb0e3666e2c, 0xbd5efeb0e3666e2c, - 0xbd5efeb0e3666e2c, 0xbd5efeb0e3666e2c, 0xbd5efeb0e3666e2c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d4e20e72a776307, 0x3d4e20e72a776307, 0x3d4e20e72a776307, 0x3d4e20e72a776307, 0x3d4e20e72a776307, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d0bb9371de16488, 0x3d0bb9371de16488, 0x3d0bb9371de16488, 0x3d0bb9371de16488, 0x3d0bb9371de16488, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd50cc070719c7cc, 0xbd50cc070719c7cc, 0xbd50cc070719c7cc, 0xbd50cc070719c7cc, - 0xbd50cc070719c7cc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d605d222aa2423a, 0x3d605d222aa2423a, - 0x3d605d222aa2423a, 0x3d605d222aa2423a, 0x3d605d222aa2423a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d89eaefcb9217dc, 0x3d89eaefcb9217dc, 0x3d89eaefcb9217dc, 0x3d89eaefcb9217dc, 0x3d89eaefcb9217dc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7025afbc667f71, 0x3d7025afbc667f71, 0x3d7025afbc667f71, 0x3d7025afbc667f71, 0x3d7025afbc667f71, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d85ef60780768b2, 0x3d85ef60780768b2, 0x3d85ef60780768b2, 0x3d85ef60780768b2, - 0x3d85ef60780768b2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d781cce637bddc5, 0x3d781cce637bddc5, - 0x3d781cce637bddc5, 0x3d781cce637bddc5, 0x3d781cce637bddc5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d81f3d1247cb989, 0x3d81f3d1247cb989, 0x3d81f3d1247cb989, 0x3d81f3d1247cb989, 0x3d81f3d1247cb989, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8009f685489e0c, 0x3d8009f685489e0c, 0x3d8009f685489e0c, 0x3d8009f685489e0c, 0x3d8009f685489e0c, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7bf083a1e414bd, 0x3d7bf083a1e414bd, 0x3d7bf083a1e414bd, 0x3d7bf083a1e414bd, - 0x3d7bf083a1e414bd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d840585d8d34d36, 0x3d840585d8d34d36, - 0x3d840585d8d34d36, 0x3d840585d8d34d36, 0x3d840585d8d34d36, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d73f964faceb669, 0x3d73f964faceb669, 0x3d73f964faceb669, 0x3d73f964faceb669, 0x3d73f964faceb669, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8801152c5dfc60, 0x3d8801152c5dfc60, 0x3d8801152c5dfc60, 0x3d8801152c5dfc60, 0x3d8801152c5dfc60, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d68048ca772b02a, 0x3d68048ca772b02a, 0x3d68048ca772b02a, 0x3d68048ca772b02a, - 0x3d68048ca772b02a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8bfca47fe8ab8a, 0x3d8bfca47fe8ab8a, - 0x3d8bfca47fe8ab8a, 0x3d8bfca47fe8ab8a, 0x3d8bfca47fe8ab8a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d502c9eb28fe704, 0x3d502c9eb28fe704, 0x3d502c9eb28fe704, 0x3d502c9eb28fe704, 0x3d502c9eb28fe704, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 11776 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e3, 0x40e2c7d09a7be1e2, 0x40e2e2b6f97c12db, - 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, - 0x40e2fd9d587c43d3, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, - 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, - 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e3841d337d38ac, 0x40e3841d337d38ac, 0x40e3841d337d38ac, - 0x40e3841d337d38ac, 0x40e3841d337d38ac, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e3b9e9f17d9a9d, - 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, - 0x40e3d4d0507dcb95, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, - 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, - 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, - 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e4911ce97f225f, - 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4ac03487f5357, 0x40e4ac03487f5357, 0x40e4ac03487f5357, 0x40e4ac03487f5357, - 0x40e4ac03487f5357, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, - 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, - 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5328323804831, 0x40e5328323804831, 0x40e5328323804831, - 0x40e5328323804831, 0x40e5328323804831, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e5684fe180aa21, - 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e583364080db19, 0x40e583364080db19, 0x40e583364080db19, 0x40e583364080db19, - 0x40e583364080db19, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, - 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, - 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e609b61b81cff3, 0x40e609b61b81cff3, 0x40e609b61b81cff3, - 0x40e609b61b81cff3, 0x40e609b61b81cff3, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e63f82d98231e3, - 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e65a69388262dc, 0x40e65a69388262dc, 0x40e65a69388262dc, 0x40e65a69388262dc, - 0x40e65a69388262dc, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e69035f682c4cc, 0x40e69035f682c4cc, - 0x40e69035f682c4cc, 0x40e69035f682c4cc, 0x40e69035f682c4cc, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, - 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, - 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e716b5d183b9a5, - 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, - 0x40e7319c3083ea9e, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e76768ee844c8e, 0x40e76768ee844c8e, - 0x40e76768ee844c8e, 0x40e76768ee844c8e, 0x40e76768ee844c8e, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, - 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, - 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7ede8c9854168, - 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e808cf28857260, 0x40e808cf28857260, 0x40e808cf28857260, 0x40e808cf28857260, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8ff833d3735ab4, 0x3d8ff833d3735ab4, 0x3d8ff833d3735ab4, 0xbd9003e6164652a6, 0x3d8ff833d3735ab4, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4f5fb7d38b2497, 0xbd4f5fb7d38b2497, 0xbd4f5fb7d38b2497, 0xbd4f5fb7d38b2497, - 0xbd4f5fb7d38b2497, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8c0c3cd901f622, 0xbd8c0c3cd901f622, - 0xbd8c0c3cd901f622, 0xbd8c0c3cd901f622, 0xbd8c0c3cd901f622, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd67c62b430d85ce, 0xbd67c62b430d85ce, 0xbd67c62b430d85ce, 0xbd67c62b430d85ce, 0xbd67c62b430d85ce, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8810ad857746f8, 0xbd8810ad857746f8, 0xbd8810ad857746f8, 0xbd8810ad857746f8, 0xbd8810ad857746f8, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd73da34489c213b, 0xbd73da34489c213b, 0xbd73da34489c213b, 0xbd73da34489c213b, - 0xbd73da34489c213b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd84151e31ec97ce, 0xbd84151e31ec97ce, - 0xbd84151e31ec97ce, 0xbd84151e31ec97ce, 0xbd84151e31ec97ce, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd7bd152efb17f8f, 0xbd7bd152efb17f8f, 0xbd7bd152efb17f8f, 0xbd7bd152efb17f8f, 0xbd7bd152efb17f8f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd80198ede61e8a4, 0xbd80198ede61e8a4, 0xbd80198ede61e8a4, 0xbd80198ede61e8a4, 0xbd80198ede61e8a4, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd81e438cb636ef1, 0xbd81e438cb636ef1, 0xbd81e438cb636ef1, 0xbd81e438cb636ef1, - 0xbd81e438cb636ef1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd783bff15ae72f3, 0xbd783bff15ae72f3, - 0xbd783bff15ae72f3, 0xbd783bff15ae72f3, 0xbd783bff15ae72f3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd85dfc81eee1e1b, 0xbd85dfc81eee1e1b, 0xbd85dfc81eee1e1b, 0xbd85dfc81eee1e1b, 0xbd85dfc81eee1e1b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7044e06e99149f, 0xbd7044e06e99149f, 0xbd7044e06e99149f, 0xbd7044e06e99149f, 0xbd7044e06e99149f, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd89db577278cd45, 0xbd89db577278cd45, 0xbd89db577278cd45, 0xbd89db577278cd45, - 0xbd89db577278cd45, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd609b838f076c96, 0xbd609b838f076c96, - 0xbd609b838f076c96, 0xbd609b838f076c96, 0xbd609b838f076c96, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd8dd6e6c6037c6f, 0xbd8dd6e6c6037c6f, 0xbd8dd6e6c6037c6f, 0xbd8dd6e6c6037c6f, 0xbd8dd6e6c6037c6f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd15a8c81b95fdd0, 0xbd15a8c81b95fdd0, 0xbd15a8c81b95fdd0, 0xbd15a8c81b95fdd0, 0xbd15a8c81b95fdd0, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8e2d89e671d467, 0x3d8e2d89e671d467, 0x3d8e2d89e671d467, 0x3d8e2d89e671d467, - 0x3d8e2d89e671d467, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d5e81ee1a9c1973, 0x3d5e81ee1a9c1973, - 0x3d5e81ee1a9c1973, 0x3d5e81ee1a9c1973, 0x3d5e81ee1a9c1973, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d8a31fa92e7253d, 0x3d8a31fa92e7253d, 0x3d8a31fa92e7253d, 0x3d8a31fa92e7253d, 0x3d8a31fa92e7253d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6f2f345b78c961, 0x3d6f2f345b78c961, 0x3d6f2f345b78c961, 0x3d6f2f345b78c961, 0x3d6f2f345b78c961, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d86366b3f5c7613, 0x3d86366b3f5c7613, 0x3d86366b3f5c7613, 0x3d86366b3f5c7613, - 0x3d86366b3f5c7613, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d778eb8d4d1c305, 0x3d778eb8d4d1c305, - 0x3d778eb8d4d1c305, 0x3d778eb8d4d1c305, 0x3d778eb8d4d1c305, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d823adbebd1c6e9, 0x3d823adbebd1c6e9, 0x3d823adbebd1c6e9, 0x3d823adbebd1c6e9, 0x3d823adbebd1c6e9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7f85d77be72159, 0x3d7f85d77be72159, 0x3d7f85d77be72159, 0x3d7f85d77be72159, 0x3d7f85d77be72159, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7c7e99308e2f7d, 0x3d7c7e99308e2f7d, 0x3d7c7e99308e2f7d, 0x3d7c7e99308e2f7d, -] )) ), - -################ chunk 12288 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40e808cf28857260, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e83e9be685d450, 0x40e83e9be685d450, - 0x40e83e9be685d450, 0x40e83e9be685d450, 0x40e83e9be685d450, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, - 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e88f4f03866739, 0x40e88f4f03866739, 0x40e88f4f03866739, - 0x40e88f4f03866739, 0x40e88f4f03866739, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8c51bc186c92a, - 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8e0022086fa22, 0x40e8e0022086fa22, 0x40e8e0022086fa22, 0x40e8e0022086fa22, - 0x40e8e0022086fa22, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e915cede875c12, 0x40e915cede875c12, - 0x40e915cede875c12, 0x40e915cede875c12, 0x40e915cede875c12, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, - 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e96681fb87eefb, 0x40e96681fb87eefb, 0x40e96681fb87eefb, - 0x40e96681fb87eefb, 0x40e96681fb87eefb, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e99c4eb98850ec, - 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e9b735188881e4, 0x40e9b735188881e4, 0x40e9b735188881e4, 0x40e9b735188881e4, - 0x40e9b735188881e4, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, - 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, - 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, - 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea7381b189d8ae, - 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, - 0x40ea8e68108a09a6, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, - 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, - 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, - 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb4ab4a98b6070, - 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb659b088b9168, 0x40eb659b088b9168, 0x40eb659b088b9168, 0x40eb659b088b9168, - 0x40eb659b088b9168, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, - 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, - 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, - 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec21e7a18ce832, - 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec3cce008d192a, 0x40ec3cce008d192a, 0x40ec3cce008d192a, 0x40ec3cce008d192a, - 0x40ec3cce008d192a, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, - 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, - 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, - 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecf91a998e6ff4, - 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, - 0x40ed1400f88ea0ed, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, - 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d7c7e99308e2f7d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d83be7b117e3fd6, 0x3d83be7b117e3fd6, - 0x3d83be7b117e3fd6, 0x3d83be7b117e3fd6, 0x3d83be7b117e3fd6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d74877a8978d129, 0x3d74877a8978d129, 0x3d74877a8978d129, 0x3d74877a8978d129, 0x3d74877a8978d129, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d87ba0a6508ef00, 0x3d87ba0a6508ef00, 0x3d87ba0a6508ef00, 0x3d87ba0a6508ef00, 0x3d87ba0a6508ef00, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6920b7c4c6e5ab, 0x3d6920b7c4c6e5ab, 0x3d6920b7c4c6e5ab, 0x3d6920b7c4c6e5ab, - 0x3d6920b7c4c6e5ab, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8bb599b8939e2a, 0x3d8bb599b8939e2a, - 0x3d8bb599b8939e2a, 0x3d8bb599b8939e2a, 0x3d8bb599b8939e2a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d5264f4ed385206, 0x3d5264f4ed385206, 0x3d5264f4ed385206, 0x3d5264f4ed385206, 0x3d5264f4ed385206, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8fb1290c1e4d54, 0x3d8fb1290c1e4d54, 0x3d8fb1290c1e4d54, 0x3d8fb1290c1e4d54, 0x3d8fb1290c1e4d54, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4aef0b5e3a4e95, 0xbd4aef0b5e3a4e95, 0xbd4aef0b5e3a4e95, 0xbd4aef0b5e3a4e95, - 0xbd4aef0b5e3a4e95, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8c5347a0570382, 0xbd8c5347a0570382, - 0xbd8c5347a0570382, 0xbd8c5347a0570382, 0xbd8c5347a0570382, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd66aa0025b9504d, 0xbd66aa0025b9504d, 0xbd66aa0025b9504d, 0xbd66aa0025b9504d, 0xbd66aa0025b9504d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8857b84ccc5458, 0xbd8857b84ccc5458, 0xbd8857b84ccc5458, 0xbd8857b84ccc5458, 0xbd8857b84ccc5458, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd734c1eb9f2067b, 0xbd734c1eb9f2067b, 0xbd734c1eb9f2067b, 0xbd734c1eb9f2067b, - 0xbd734c1eb9f2067b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd845c28f941a52e, 0xbd845c28f941a52e, - 0xbd845c28f941a52e, 0xbd845c28f941a52e, 0xbd845c28f941a52e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd7b433d610764cf, 0xbd7b433d610764cf, 0xbd7b433d610764cf, 0xbd7b433d610764cf, 0xbd7b433d610764cf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd806099a5b6f604, 0xbd806099a5b6f604, 0xbd806099a5b6f604, 0xbd806099a5b6f604, 0xbd806099a5b6f604, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd819d2e040e6191, 0xbd819d2e040e6191, 0xbd819d2e040e6191, 0xbd819d2e040e6191, - 0xbd819d2e040e6191, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd78ca14a4588db4, 0xbd78ca14a4588db4, - 0xbd78ca14a4588db4, 0xbd78ca14a4588db4, 0xbd78ca14a4588db4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd8598bd579910bb, 0xbd8598bd579910bb, 0xbd8598bd579910bb, 0xbd8598bd579910bb, 0xbd8598bd579910bb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd70d2f5fd432f60, 0xbd70d2f5fd432f60, 0xbd70d2f5fd432f60, 0xbd70d2f5fd432f60, 0xbd70d2f5fd432f60, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd89944cab23bfe5, 0xbd89944cab23bfe5, 0xbd89944cab23bfe5, 0xbd89944cab23bfe5, - 0xbd89944cab23bfe5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd61b7aeac5ba217, 0xbd61b7aeac5ba217, - 0xbd61b7aeac5ba217, 0xbd61b7aeac5ba217, 0xbd61b7aeac5ba217, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd8d8fdbfeae6f0f, 0xbd8d8fdbfeae6f0f, 0xbd8d8fdbfeae6f0f, 0xbd8d8fdbfeae6f0f, 0xbd8d8fdbfeae6f0f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd2c9715e30e56f2, 0xbd2c9715e30e56f2, 0xbd2c9715e30e56f2, 0xbd2c9715e30e56f2, 0xbd2c9715e30e56f2, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8e7494adc6e1c7, 0x3d8e7494adc6e1c7, 0x3d8e7494adc6e1c7, 0x3d8e7494adc6e1c7, - 0x3d8e7494adc6e1c7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d5c4997dff3ae72, 0x3d5c4997dff3ae72, - 0x3d5c4997dff3ae72, 0x3d5c4997dff3ae72, 0x3d5c4997dff3ae72, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, -] )) ), - -################ chunk 12800 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, - 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edd04d918ff7b6, - 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edeb33f09028af, 0x40edeb33f09028af, 0x40edeb33f09028af, 0x40edeb33f09028af, - 0x40edeb33f09028af, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, - 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, - 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, - 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40eea78089917f79, - 0x40eea78089917f79, 0x40eea78089917f79, 0x40eea78089917f79, 0x40eea78089917f79, 0x40eec266e891b071, 0x40eec266e891b071, 0x40eec266e891b071, 0x40eec266e891b071, - 0x40eec266e891b071, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eef833a6921261, 0x40eef833a6921261, - 0x40eef833a6921261, 0x40eef833a6921261, 0x40eef833a6921261, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, - 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, - 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef7eb38193073b, - 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, - 0x40ef9999e0933833, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efcf669e939a23, 0x40efcf669e939a23, - 0x40efcf669e939a23, 0x40efcf669e939a23, 0x40efcf669e939a23, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, - 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f0100cddca1686, 0x40f0100cddca1686, 0x40f0100cddca1686, - 0x40f0100cddca1686, 0x40f0100cddca1686, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f02af33cca477e, - 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, - 0x40f038666c4a5ffb, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, - 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, - 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f07ba659cada67, 0x40f07ba659cada67, 0x40f07ba659cada67, - 0x40f07ba659cada67, 0x40f07ba659cada67, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f0968cb8cb0b5f, - 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, - 0x40f0a3ffe84b23dc, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, - 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, - 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, - 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f1022634cbcf41, - 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f10f99644be7bd, 0x40f10f99644be7bd, 0x40f10f99644be7bd, 0x40f10f99644be7bd, - 0x40f10f99644be7bd, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, - 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, - 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f152d951cc6229, 0x40f152d951cc6229, 0x40f152d951cc6229, - 0x40f152d951cc6229, 0x40f152d951cc6229, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f16dbfb0cc9322, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d8a79055a3c329d, 0x3d8a79055a3c329d, 0x3d8a79055a3c329d, 0x3d8a79055a3c329d, 0x3d8a79055a3c329d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6e13093e2493e1, 0x3d6e13093e2493e1, 0x3d6e13093e2493e1, 0x3d6e13093e2493e1, 0x3d6e13093e2493e1, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d867d7606b18373, 0x3d867d7606b18373, 0x3d867d7606b18373, 0x3d867d7606b18373, - 0x3d867d7606b18373, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7700a34627a844, 0x3d7700a34627a844, - 0x3d7700a34627a844, 0x3d7700a34627a844, 0x3d7700a34627a844, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d8281e6b326d449, 0x3d8281e6b326d449, 0x3d8281e6b326d449, 0x3d8281e6b326d449, 0x3d8281e6b326d449, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7ef7c1ed3d0698, 0x3d7ef7c1ed3d0698, 0x3d7ef7c1ed3d0698, 0x3d7ef7c1ed3d0698, 0x3d7ef7c1ed3d0698, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7d0caebf384a3e, 0x3d7d0caebf384a3e, 0x3d7d0caebf384a3e, 0x3d7d0caebf384a3e, - 0x3d7d0caebf384a3e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8377704a293276, 0x3d8377704a293276, - 0x3d8377704a293276, 0x3d8377704a293276, 0x3d8377704a293276, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d7515901822ebea, 0x3d7515901822ebea, 0x3d7515901822ebea, 0x3d7515901822ebea, 0x3d7515901822ebea, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8772ff9db3e1a0, 0x3d8772ff9db3e1a0, 0x3d8772ff9db3e1a0, 0x3d8772ff9db3e1a0, 0x3d8772ff9db3e1a0, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, 0x3d6a3ce2e21b1b2b, - 0x3d6a3ce2e21b1b2b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8b6e8ef13e90ca, 0x3d8b6e8ef13e90ca, - 0x3d8b6e8ef13e90ca, 0x3d8b6e8ef13e90ca, 0x3d8b6e8ef13e90ca, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d549d4b27e0bd07, 0x3d549d4b27e0bd07, 0x3d549d4b27e0bd07, 0x3d549d4b27e0bd07, 0x3d549d4b27e0bd07, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8f6a1e44c93ff4, 0x3d8f6a1e44c93ff4, 0x3d8f6a1e44c93ff4, 0x3d8f6a1e44c93ff4, 0x3d8f6a1e44c93ff4, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9f4c0d08b8b43b, 0x3d9f4c0d08b8b43b, 0x3d9f4c0d08b8b43b, 0x3d9f4c0d08b8b43b, - 0x3d9f4c0d08b8b43b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8c9a5267ac10e2, 0xbd8c9a5267ac10e2, - 0xbd8c9a5267ac10e2, 0xbd8c9a5267ac10e2, 0xbd8c9a5267ac10e2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd658dd508651acc, 0xbd658dd508651acc, 0xbd658dd508651acc, 0xbd658dd508651acc, 0xbd658dd508651acc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d93b09e75ef4f24, 0x3d93b09e75ef4f24, 0x3d93b09e75ef4f24, 0x3d93b09e75ef4f24, 0x3d93b09e75ef4f24, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9b507db52e0511, 0x3d9b507db52e0511, 0x3d9b507db52e0511, 0x3d9b507db52e0511, - 0x3d9b507db52e0511, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd84a333c096b28e, 0xbd84a333c096b28e, - 0xbd84a333c096b28e, 0xbd84a333c096b28e, 0xbd84a333c096b28e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd7ab527d25d4a0e, 0xbd7ab527d25d4a0e, 0xbd7ab527d25d4a0e, 0xbd7ab527d25d4a0e, 0xbd7ab527d25d4a0e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d97ac2dc979fe4e, 0x3d97ac2dc979fe4e, 0x3d97ac2dc979fe4e, 0x3d97ac2dc979fe4e, 0x3d97ac2dc979fe4e, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9754ee61a355e7, 0x3d9754ee61a355e7, 0x3d9754ee61a355e7, 0x3d9754ee61a355e7, - 0x3d9754ee61a355e7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd79582a3302a874, 0xbd79582a3302a874, - 0xbd79582a3302a874, 0xbd79582a3302a874, 0xbd79582a3302a874, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd8551b29044035b, 0xbd8551b29044035b, 0xbd8551b29044035b, 0xbd8551b29044035b, 0xbd8551b29044035b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9ba7bd1d04ad78, 0x3d9ba7bd1d04ad78, 0x3d9ba7bd1d04ad78, 0x3d9ba7bd1d04ad78, 0x3d9ba7bd1d04ad78, 0xbff0000000000000, -] )) ), - -################ chunk 13312 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, - 0x40f17b32e04cab9e, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f196193f4cdc96, 0x40f196193f4cdc96, - 0x40f196193f4cdc96, 0x40f196193f4cdc96, 0x40f196193f4cdc96, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, - 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, - 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1d9592ccd5703, - 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, - 0x40f1e6cc5c4d6f7f, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f201b2bb4da077, 0x40f201b2bb4da077, - 0x40f201b2bb4da077, 0x40f201b2bb4da077, 0x40f201b2bb4da077, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, - 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, - 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f244f2a8ce1ae4, - 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f25265d84e3360, 0x40f25265d84e3360, 0x40f25265d84e3360, 0x40f25265d84e3360, - 0x40f25265d84e3360, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f26d4c374e6458, 0x40f26d4c374e6458, - 0x40f26d4c374e6458, 0x40f26d4c374e6458, 0x40f26d4c374e6458, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, - 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, - 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2b08c24cedec5, - 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2bdff544ef741, 0x40f2bdff544ef741, 0x40f2bdff544ef741, 0x40f2bdff544ef741, - 0x40f2bdff544ef741, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, - 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, - 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, - 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f31c25a0cfa2a6, - 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f32998d04fbb22, 0x40f32998d04fbb22, 0x40f32998d04fbb22, 0x40f32998d04fbb22, - 0x40f32998d04fbb22, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, - 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, - 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, - 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f387bf1cd06687, - 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f395324c507f03, 0x40f395324c507f03, 0x40f395324c507f03, 0x40f395324c507f03, - 0x40f395324c507f03, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3b018ab50affb, 0x40f3b018ab50affb, - 0x40f3b018ab50affb, 0x40f3b018ab50affb, 0x40f3b018ab50affb, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, - 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3d87239d0f970, 0x40f3d87239d0f970, 0x40f3d87239d0f970, - 0x40f3d87239d0f970, 0x40f3d87239d0f970, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3f35898d12a68, - 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f400cbc85142e4, 0x40f400cbc85142e4, 0x40f400cbc85142e4, 0x40f400cbc85142e4, - 0x40f400cbc85142e4, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f41bb2275173dc, 0x40f41bb2275173dc, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d93595f0e18a6bd, 0x3d93595f0e18a6bd, 0x3d93595f0e18a6bd, 0x3d93595f0e18a6bd, - 0x3d93595f0e18a6bd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd62d3d9c9afd798, 0xbd62d3d9c9afd798, - 0xbd62d3d9c9afd798, 0xbd62d3d9c9afd798, 0xbd62d3d9c9afd798, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd8d48d1375961af, 0xbd8d48d1375961af, 0xbd8d48d1375961af, 0xbd8d48d1375961af, 0xbd8d48d1375961af, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9fa34c708f5ca2, 0x3d9fa34c708f5ca2, 0x3d9fa34c708f5ca2, 0x3d9fa34c708f5ca2, 0x3d9fa34c708f5ca2, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8ebb9f751bef27, 0x3d8ebb9f751bef27, 0x3d8ebb9f751bef27, 0x3d8ebb9f751bef27, - 0x3d8ebb9f751bef27, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d5a1141a54b4370, 0x3d5a1141a54b4370, - 0x3d5a1141a54b4370, 0x3d5a1141a54b4370, 0x3d5a1141a54b4370, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd929ff7ef376002, 0xbd929ff7ef376002, 0xbd929ff7ef376002, 0xbd929ff7ef376002, 0xbd929ff7ef376002, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9c61243be5f434, 0xbd9c61243be5f434, 0xbd9c61243be5f434, 0xbd9c61243be5f434, 0xbd9c61243be5f434, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d86c480ce0690d3, 0x3d86c480ce0690d3, 0x3d86c480ce0690d3, 0x3d86c480ce0690d3, - 0x3d86c480ce0690d3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d76728db77d8d84, 0x3d76728db77d8d84, - 0x3d76728db77d8d84, 0x3d76728db77d8d84, 0x3d76728db77d8d84, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd969b8742c20f2c, 0xbd969b8742c20f2c, 0xbd969b8742c20f2c, 0xbd969b8742c20f2c, 0xbd969b8742c20f2c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd986594e85b450a, 0xbd986594e85b450a, 0xbd986594e85b450a, 0xbd986594e85b450a, 0xbd986594e85b450a, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7d9ac44de264fe, 0x3d7d9ac44de264fe, 0x3d7d9ac44de264fe, 0x3d7d9ac44de264fe, - 0x3d7d9ac44de264fe, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d83306582d42516, 0x3d83306582d42516, - 0x3d83306582d42516, 0x3d83306582d42516, 0x3d83306582d42516, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd9a9716964cbe55, 0xbd9a9716964cbe55, 0xbd9a9716964cbe55, 0xbd9a9716964cbe55, 0xbd9a9716964cbe55, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd946a0594d095e0, 0xbd946a0594d095e0, 0xbd946a0594d095e0, 0xbd946a0594d095e0, 0xbd946a0594d095e0, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6b590dff6f50ac, 0x3d6b590dff6f50ac, 0x3d6b590dff6f50ac, 0x3d6b590dff6f50ac, - 0x3d6b590dff6f50ac, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8b278429e9836a, 0x3d8b278429e9836a, - 0x3d8b278429e9836a, 0x3d8b278429e9836a, 0x3d8b278429e9836a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd9e92a5e9d76d7f, 0xbd9e92a5e9d76d7f, 0xbd9e92a5e9d76d7f, 0xbd9e92a5e9d76d7f, 0xbd9e92a5e9d76d7f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd906e764145e6b6, 0xbd906e764145e6b6, 0xbd906e764145e6b6, 0xbd906e764145e6b6, 0xbd906e764145e6b6, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd420db27398a290, 0xbd420db27398a290, 0xbd420db27398a290, 0xbd420db27398a290, - 0xbd420db27398a290, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d918f51687f70df, 0x3d918f51687f70df, - 0x3d918f51687f70df, 0x3d918f51687f70df, 0x3d918f51687f70df, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d9d71cac29de357, 0x3d9d71cac29de357, 0x3d9d71cac29de357, 0x3d9d71cac29de357, 0x3d9d71cac29de357, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd88e5cddb766f18, 0xbd88e5cddb766f18, 0xbd88e5cddb766f18, 0xbd88e5cddb766f18, 0xbd88e5cddb766f18, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd722ff39c9dd0fa, 0xbd722ff39c9dd0fa, 0xbd722ff39c9dd0fa, 0xbd722ff39c9dd0fa, - 0xbd722ff39c9dd0fa, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d958ae0bc0a2009, 0x3d958ae0bc0a2009, -] )) ), - -################ chunk 13824 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f41bb2275173dc, 0x40f41bb2275173dc, 0x40f41bb2275173dc, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, - 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, - 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f45ef214d1ee49, - 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f46c65445206c5, 0x40f46c65445206c5, 0x40f46c65445206c5, 0x40f46c65445206c5, - 0x40f46c65445206c5, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f4874ba35237bd, 0x40f4874ba35237bd, - 0x40f4874ba35237bd, 0x40f4874ba35237bd, 0x40f4874ba35237bd, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, - 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4afa531d28132, 0x40f4afa531d28132, 0x40f4afa531d28132, - 0x40f4afa531d28132, 0x40f4afa531d28132, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4ca8b90d2b22a, - 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, - 0x40f4d7fec052caa6, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, - 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, - 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f51b3eadd34513, 0x40f51b3eadd34513, 0x40f51b3eadd34513, - 0x40f51b3eadd34513, 0x40f51b3eadd34513, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f536250cd3760b, - 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f543983c538e87, 0x40f543983c538e87, 0x40f543983c538e87, 0x40f543983c538e87, - 0x40f543983c538e87, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, - 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, - 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f586d829d408f4, 0x40f586d829d408f4, 0x40f586d829d408f4, - 0x40f586d829d408f4, 0x40f586d829d408f4, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5a1be88d439ec, - 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5af31b8545268, 0x40f5af31b8545268, 0x40f5af31b8545268, 0x40f5af31b8545268, - 0x40f5af31b8545268, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5ca1817548361, 0x40f5ca1817548361, - 0x40f5ca1817548361, 0x40f5ca1817548361, 0x40f5ca1817548361, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, - 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, - 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f60d5804d4fdcd, - 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f61acb34551649, 0x40f61acb34551649, 0x40f61acb34551649, 0x40f61acb34551649, - 0x40f61acb34551649, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f635b193554742, 0x40f635b193554742, - 0x40f635b193554742, 0x40f635b193554742, 0x40f635b193554742, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, - 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, - 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f678f180d5c1ae, - 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f68664b055da2a, 0x40f68664b055da2a, 0x40f68664b055da2a, 0x40f68664b055da2a, - 0x40f68664b055da2a, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, - 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, - 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d958ae0bc0a2009, 0x3d958ae0bc0a2009, 0x3d958ae0bc0a2009, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d99763b6f13342d, 0x3d99763b6f13342d, 0x3d99763b6f13342d, 0x3d99763b6f13342d, 0x3d99763b6f13342d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd80eeaf346110c4, 0xbd80eeaf346110c4, 0xbd80eeaf346110c4, 0xbd80eeaf346110c4, 0xbd80eeaf346110c4, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd810f18756446d1, 0xbd810f18756446d1, 0xbd810f18756446d1, 0xbd810f18756446d1, - 0xbd810f18756446d1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9986700f94cf33, 0x3d9986700f94cf33, - 0x3d9986700f94cf33, 0x3d9986700f94cf33, 0x3d9986700f94cf33, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d957aac1b888503, 0x3d957aac1b888503, 0x3d957aac1b888503, 0x3d957aac1b888503, 0x3d957aac1b888503, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd71ef211a9764e0, 0xbd71ef211a9764e0, 0xbd71ef211a9764e0, 0xbd71ef211a9764e0, 0xbd71ef211a9764e0, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8906371c79a525, 0xbd8906371c79a525, 0xbd8906371c79a525, 0xbd8906371c79a525, - 0xbd8906371c79a525, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9d81ff631f7e5d, 0x3d9d81ff631f7e5d, - 0x3d9d81ff631f7e5d, 0x3d9d81ff631f7e5d, 0x3d9d81ff631f7e5d, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d917f1cc7fdd5d9, 0x3d917f1cc7fdd5d9, 0x3d917f1cc7fdd5d9, 0x3d917f1cc7fdd5d9, 0x3d917f1cc7fdd5d9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd40071e636541c2, 0xbd40071e636541c2, 0xbd40071e636541c2, 0xbd40071e636541c2, 0xbd40071e636541c2, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd907eaae1c781bc, 0xbd907eaae1c781bc, 0xbd907eaae1c781bc, 0xbd907eaae1c781bc, - 0xbd907eaae1c781bc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9e82714955d279, 0xbd9e82714955d279, - 0xbd9e82714955d279, 0xbd9e82714955d279, 0xbd9e82714955d279, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d8b071ae8e64d5d, 0x3d8b071ae8e64d5d, 0x3d8b071ae8e64d5d, 0x3d8b071ae8e64d5d, 0x3d8b071ae8e64d5d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6bdab3037c28df, 0x3d6bdab3037c28df, 0x3d6bdab3037c28df, 0x3d6bdab3037c28df, 0x3d6bdab3037c28df, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd947a3a355230e6, 0xbd947a3a355230e6, 0xbd947a3a355230e6, 0xbd947a3a355230e6, - 0xbd947a3a355230e6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9a86e1f5cb234f, 0xbd9a86e1f5cb234f, - 0xbd9a86e1f5cb234f, 0xbd9a86e1f5cb234f, 0xbd9a86e1f5cb234f, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d830ffc41d0ef09, 0x3d830ffc41d0ef09, 0x3d830ffc41d0ef09, 0x3d830ffc41d0ef09, 0x3d830ffc41d0ef09, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7ddb96cfe8d118, 0x3d7ddb96cfe8d118, 0x3d7ddb96cfe8d118, 0x3d7ddb96cfe8d118, 0x3d7ddb96cfe8d118, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9875c988dce010, 0xbd9875c988dce010, 0xbd9875c988dce010, 0xbd9875c988dce010, - 0xbd9875c988dce010, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd968b52a2407425, 0xbd968b52a2407425, - 0xbd968b52a2407425, 0xbd968b52a2407425, 0xbd968b52a2407425, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d7631bb3577216a, 0x3d7631bb3577216a, 0x3d7631bb3577216a, 0x3d7631bb3577216a, 0x3d7631bb3577216a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d86e4ea0f09c6e0, 0x3d86e4ea0f09c6e0, 0x3d86e4ea0f09c6e0, 0x3d86e4ea0f09c6e0, 0x3d86e4ea0f09c6e0, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9c7158dc678f3a, 0xbd9c7158dc678f3a, 0xbd9c7158dc678f3a, 0xbd9c7158dc678f3a, - 0xbd9c7158dc678f3a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd928fc34eb5c4fb, 0xbd928fc34eb5c4fb, - 0xbd928fc34eb5c4fb, 0xbd928fc34eb5c4fb, 0xbd928fc34eb5c4fb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d590df79d319309, 0x3d590df79d319309, 0x3d590df79d319309, 0x3d590df79d319309, 0x3d590df79d319309, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 14336 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6e48afcd6858f, - 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, - 0x40f6f1fe2c569e0c, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, - 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, - 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f7353e19d71878, 0x40f7353e19d71878, 0x40f7353e19d71878, - 0x40f7353e19d71878, 0x40f7353e19d71878, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f7502478d74970, - 0x40f7502478d74970, 0x40f7502478d74970, 0x40f7502478d74970, 0x40f7502478d74970, 0x40f75d97a85761ed, 0x40f75d97a85761ed, 0x40f75d97a85761ed, 0x40f75d97a85761ed, - 0x40f75d97a85761ed, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f7787e075792e5, 0x40f7787e075792e5, - 0x40f7787e075792e5, 0x40f7787e075792e5, 0x40f7787e075792e5, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, - 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, - 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7bbbdf4d80d51, - 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7c931245825ce, 0x40f7c931245825ce, 0x40f7c931245825ce, 0x40f7c931245825ce, - 0x40f7c931245825ce, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7e417835856c6, 0x40f7e417835856c6, - 0x40f7e417835856c6, 0x40f7e417835856c6, 0x40f7e417835856c6, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, - 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, - 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f8275770d8d133, - 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f834caa058e9af, 0x40f834caa058e9af, 0x40f834caa058e9af, 0x40f834caa058e9af, - 0x40f834caa058e9af, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, - 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, - 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, - 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f892f0ecd99514, - 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, - 0x40f8a0641c59ad90, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, - 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, - 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, - 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8fe8a68da58f5, - 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f90bfd985a7171, 0x40f90bfd985a7171, 0x40f90bfd985a7171, 0x40f90bfd985a7171, - 0x40f90bfd985a7171, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f926e3f75aa269, 0x40f926e3f75aa269, - 0x40f926e3f75aa269, 0x40f926e3f75aa269, 0x40f926e3f75aa269, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, - 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, - 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f96a23e4db1cd6, - 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f97797145b3552, 0x40f97797145b3552, 0x40f97797145b3552, 0x40f97797145b3552, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8edc08b61f2534, 0x3d8edc08b61f2534, 0x3d8edc08b61f2534, 0x3d8edc08b61f2534, 0x3d8edc08b61f2534, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9f9317d00dc19c, 0x3d9f9317d00dc19c, 0x3d9f9317d00dc19c, 0x3d9f9317d00dc19c, - 0x3d9f9317d00dc19c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8d2867f6562ba2, 0xbd8d2867f6562ba2, - 0xbd8d2867f6562ba2, 0xbd8d2867f6562ba2, 0xbd8d2867f6562ba2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd63557ecdbcafcb, 0xbd63557ecdbcafcb, 0xbd63557ecdbcafcb, 0xbd63557ecdbcafcb, 0xbd63557ecdbcafcb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d936993ae9a41c4, 0x3d936993ae9a41c4, 0x3d936993ae9a41c4, 0x3d936993ae9a41c4, 0x3d936993ae9a41c4, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9b97887c831272, 0x3d9b97887c831272, 0x3d9b97887c831272, 0x3d9b97887c831272, - 0x3d9b97887c831272, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8531494f40cd4e, 0xbd8531494f40cd4e, - 0xbd8531494f40cd4e, 0xbd8531494f40cd4e, 0xbd8531494f40cd4e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd7998fcb509148e, 0xbd7998fcb509148e, 0xbd7998fcb509148e, 0xbd7998fcb509148e, 0xbd7998fcb509148e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9765230224f0ee, 0x3d9765230224f0ee, 0x3d9765230224f0ee, 0x3d9765230224f0ee, 0x3d9765230224f0ee, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d979bf928f86348, 0x3d979bf928f86348, 0x3d979bf928f86348, 0x3d979bf928f86348, - 0x3d979bf928f86348, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7a74555056ddf4, 0xbd7a74555056ddf4, - 0xbd7a74555056ddf4, 0xbd7a74555056ddf4, 0xbd7a74555056ddf4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd84c39d0199e89b, 0xbd84c39d0199e89b, 0xbd84c39d0199e89b, 0xbd84c39d0199e89b, 0xbd84c39d0199e89b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9b60b255afa018, 0x3d9b60b255afa018, 0x3d9b60b255afa018, 0x3d9b60b255afa018, 0x3d9b60b255afa018, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d93a069d56db41e, 0x3d93a069d56db41e, 0x3d93a069d56db41e, 0x3d93a069d56db41e, - 0x3d93a069d56db41e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd650c3004584299, 0xbd650c3004584299, - 0xbd650c3004584299, 0xbd650c3004584299, 0xbd650c3004584299, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd8cbabba8af46ef, 0xbd8cbabba8af46ef, 0xbd8cbabba8af46ef, 0xbd8cbabba8af46ef, 0xbd8cbabba8af46ef, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9f5c41a93a4f42, 0x3d9f5c41a93a4f42, 0x3d9f5c41a93a4f42, 0x3d9f5c41a93a4f42, 0x3d9f5c41a93a4f42, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8f49b503c609e7, 0x3d8f49b503c609e7, 0x3d8f49b503c609e7, 0x3d8f49b503c609e7, - 0x3d8f49b503c609e7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d55a0952ffa6d6e, 0x3d55a0952ffa6d6e, - 0x3d55a0952ffa6d6e, 0x3d55a0952ffa6d6e, 0x3d55a0952ffa6d6e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd9258ed27e252a1, 0xbd9258ed27e252a1, 0xbd9258ed27e252a1, 0xbd9258ed27e252a1, 0xbd9258ed27e252a1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9ca82f033b0194, 0xbd9ca82f033b0194, 0xbd9ca82f033b0194, 0xbd9ca82f033b0194, 0xbd9ca82f033b0194, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8752965cb0ab93, 0x3d8752965cb0ab93, 0x3d8752965cb0ab93, 0x3d8752965cb0ab93, - 0x3d8752965cb0ab93, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7556629a295803, 0x3d7556629a295803, - 0x3d7556629a295803, 0x3d7556629a295803, 0x3d7556629a295803, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd96547c7b6d01cb, 0xbd96547c7b6d01cb, 0xbd96547c7b6d01cb, 0xbd96547c7b6d01cb, 0xbd96547c7b6d01cb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd98ac9fafb0526a, 0xbd98ac9fafb0526a, 0xbd98ac9fafb0526a, 0xbd98ac9fafb0526a, 0xbd98ac9fafb0526a, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7eb6ef6b369a7f, 0x3d7eb6ef6b369a7f, 0x3d7eb6ef6b369a7f, 0x3d7eb6ef6b369a7f, -] )) ), - -################ chunk 14848 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f97797145b3552, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9927d735b664a, 0x40f9927d735b664a, - 0x40f9927d735b664a, 0x40f9927d735b664a, 0x40f9927d735b664a, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, - 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, - 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9d5bd60dbe0b7, - 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9e330905bf933, 0x40f9e330905bf933, 0x40f9e330905bf933, 0x40f9e330905bf933, - 0x40f9e330905bf933, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, - 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, - 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, - 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa4156dcdca498, - 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, - 0x40fa4eca0c5cbd14, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, - 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, - 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, - 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40faacf058dd6879, - 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faba63885d80f5, 0x40faba63885d80f5, 0x40faba63885d80f5, 0x40faba63885d80f5, - 0x40faba63885d80f5, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fad549e75db1ed, 0x40fad549e75db1ed, - 0x40fad549e75db1ed, 0x40fad549e75db1ed, 0x40fad549e75db1ed, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, - 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40fafda375ddfb62, 0x40fafda375ddfb62, 0x40fafda375ddfb62, - 0x40fafda375ddfb62, 0x40fafda375ddfb62, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb1889d4de2c5a, - 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, - 0x40fb25fd045e44d6, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, - 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, - 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb693cf1debf43, 0x40fb693cf1debf43, 0x40fb693cf1debf43, - 0x40fb693cf1debf43, 0x40fb693cf1debf43, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb842350def03b, - 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb9196805f08b7, 0x40fb9196805f08b7, 0x40fb9196805f08b7, 0x40fb9196805f08b7, - 0x40fb9196805f08b7, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, - 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, - 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, - 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbefbcccdfb41c, - 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, - 0x40fbfd2ffc5fcc98, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, - 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d7eb6ef6b369a7f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d82a24ff42a0a56, 0x3d82a24ff42a0a56, - 0x3d82a24ff42a0a56, 0x3d82a24ff42a0a56, 0x3d82a24ff42a0a56, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd9a500bcef7b0f5, 0xbd9a500bcef7b0f5, 0xbd9a500bcef7b0f5, 0xbd9a500bcef7b0f5, 0xbd9a500bcef7b0f5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd94b1105c25a340, 0xbd94b1105c25a340, 0xbd94b1105c25a340, 0xbd94b1105c25a340, 0xbd94b1105c25a340, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6d91643a17bbad, 0x3d6d91643a17bbad, 0x3d6d91643a17bbad, 0x3d6d91643a17bbad, - 0x3d6d91643a17bbad, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8a996e9b3f68aa, 0x3d8a996e9b3f68aa, - 0x3d8a996e9b3f68aa, 0x3d8a996e9b3f68aa, 0x3d8a996e9b3f68aa, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd9e4b9b2282601f, 0xbd9e4b9b2282601f, 0xbd9e4b9b2282601f, 0xbd9e4b9b2282601f, 0xbd9e4b9b2282601f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd90b581089af416, 0xbd90b581089af416, 0xbd90b581089af416, 0xbd90b581089af416, 0xbd90b581089af416, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd3258b311eded15, 0xbd3258b311eded15, 0xbd3258b311eded15, 0xbd3258b311eded15, - 0xbd3258b311eded15, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d914846a12a637f, 0x3d914846a12a637f, - 0x3d914846a12a637f, 0x3d914846a12a637f, 0x3d914846a12a637f, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d9db8d589f2f0b7, 0x3d9db8d589f2f0b7, 0x3d9db8d589f2f0b7, 0x3d9db8d589f2f0b7, 0x3d9db8d589f2f0b7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8973e36a2089d8, 0xbd8973e36a2089d8, 0xbd8973e36a2089d8, 0xbd8973e36a2089d8, 0xbd8973e36a2089d8, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7113c87f499b79, 0xbd7113c87f499b79, 0xbd7113c87f499b79, 0xbd7113c87f499b79, - 0xbd7113c87f499b79, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9543d5f4b512a9, 0x3d9543d5f4b512a9, - 0x3d9543d5f4b512a9, 0x3d9543d5f4b512a9, 0x3d9543d5f4b512a9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d99bd463668418d, 0x3d99bd463668418d, 0x3d99bd463668418d, 0x3d99bd463668418d, 0x3d99bd463668418d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd817cc4c30b2b84, 0xbd817cc4c30b2b84, 0xbd817cc4c30b2b84, 0xbd817cc4c30b2b84, 0xbd817cc4c30b2b84, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd808102e6ba2c11, 0xbd808102e6ba2c11, 0xbd808102e6ba2c11, 0xbd808102e6ba2c11, - 0xbd808102e6ba2c11, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d993f65483fc1d3, 0x3d993f65483fc1d3, - 0x3d993f65483fc1d3, 0x3d993f65483fc1d3, 0x3d993f65483fc1d3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d95c1b6e2dd9263, 0x3d95c1b6e2dd9263, 0x3d95c1b6e2dd9263, 0x3d95c1b6e2dd9263, 0x3d95c1b6e2dd9263, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd730b4c37eb9a61, 0xbd730b4c37eb9a61, 0xbd730b4c37eb9a61, 0xbd730b4c37eb9a61, 0xbd730b4c37eb9a61, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8878218dcf8a65, 0xbd8878218dcf8a65, 0xbd8878218dcf8a65, 0xbd8878218dcf8a65, - 0xbd8878218dcf8a65, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9d3af49bca70fd, 0x3d9d3af49bca70fd, - 0x3d9d3af49bca70fd, 0x3d9d3af49bca70fd, 0x3d9d3af49bca70fd, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d91c6278f52e339, 0x3d91c6278f52e339, 0x3d91c6278f52e339, 0x3d91c6278f52e339, 0x3d91c6278f52e339, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd48e8774e06edc7, 0xbd48e8774e06edc7, 0xbd48e8774e06edc7, 0xbd48e8774e06edc7, 0xbd48e8774e06edc7, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9037a01a72745c, 0xbd9037a01a72745c, 0xbd9037a01a72745c, 0xbd9037a01a72745c, - 0xbd9037a01a72745c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9ec97c10aadfd9, 0xbd9ec97c10aadfd9, - 0xbd9ec97c10aadfd9, 0xbd9ec97c10aadfd9, 0xbd9ec97c10aadfd9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, -] )) ), - -################ chunk 15360 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc406fe9e04705, 0x40fc406fe9e04705, 0x40fc406fe9e04705, - 0x40fc406fe9e04705, 0x40fc406fe9e04705, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc5b5648e077fd, - 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc68c978609079, 0x40fc68c978609079, 0x40fc68c978609079, 0x40fc68c978609079, - 0x40fc68c978609079, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc83afd760c172, 0x40fc83afd760c172, - 0x40fc83afd760c172, 0x40fc83afd760c172, 0x40fc83afd760c172, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, - 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, - 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcc6efc4e13bde, - 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcd462f461545a, 0x40fcd462f461545a, 0x40fcd462f461545a, 0x40fcd462f461545a, - 0x40fcd462f461545a, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fcef4953618553, 0x40fcef4953618553, - 0x40fcef4953618553, 0x40fcef4953618553, 0x40fcef4953618553, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, - 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, - 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd328940e1ffbf, - 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, - 0x40fd3ffc7062183b, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, - 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, - 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd833c5de292a8, 0x40fd833c5de292a8, 0x40fd833c5de292a8, - 0x40fd833c5de292a8, 0x40fd833c5de292a8, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd9e22bce2c3a0, - 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, - 0x40fdab95ec62dc1d, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, - 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, - 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, - 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fe09bc38e38781, - 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe172f68639ffe, 0x40fe172f68639ffe, 0x40fe172f68639ffe, 0x40fe172f68639ffe, - 0x40fe172f68639ffe, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, - 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, - 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, - 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe7555b4e44b62, - 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe82c8e46463df, 0x40fe82c8e46463df, 0x40fe82c8e46463df, 0x40fe82c8e46463df, - 0x40fe82c8e46463df, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe9daf436494d7, 0x40fe9daf436494d7, - 0x40fe9daf436494d7, 0x40fe9daf436494d7, 0x40fe9daf436494d7, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, - 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, - 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fee0ef30e50f44, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d8b95307790681d, 0x3d8b95307790681d, 0x3d8b95307790681d, 0x3d8b95307790681d, 0x3d8b95307790681d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d69a25cc8d3bdde, 0x3d69a25cc8d3bdde, 0x3d69a25cc8d3bdde, 0x3d69a25cc8d3bdde, 0x3d69a25cc8d3bdde, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd94332f6dfd2386, 0xbd94332f6dfd2386, 0xbd94332f6dfd2386, 0xbd94332f6dfd2386, - 0xbd94332f6dfd2386, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9acdecbd2030af, 0xbd9acdecbd2030af, - 0xbd9acdecbd2030af, 0xbd9acdecbd2030af, 0xbd9acdecbd2030af, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d839e11d07b09c9, 0x3d839e11d07b09c9, 0x3d839e11d07b09c9, 0x3d839e11d07b09c9, 0x3d839e11d07b09c9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7cbf6bb2949b97, 0x3d7cbf6bb2949b97, 0x3d7cbf6bb2949b97, 0x3d7cbf6bb2949b97, 0x3d7cbf6bb2949b97, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd982ebec187d2b0, 0xbd982ebec187d2b0, 0xbd982ebec187d2b0, 0xbd982ebec187d2b0, - 0xbd982ebec187d2b0, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd96d25d69958185, 0xbd96d25d69958185, - 0xbd96d25d69958185, 0xbd96d25d69958185, 0xbd96d25d69958185, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d774de652cb56eb, 0x3d774de652cb56eb, 0x3d774de652cb56eb, 0x3d774de652cb56eb, 0x3d774de652cb56eb, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8656d4805fac20, 0x3d8656d4805fac20, 0x3d8656d4805fac20, 0x3d8656d4805fac20, 0x3d8656d4805fac20, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9c2a4e151281da, 0xbd9c2a4e151281da, 0xbd9c2a4e151281da, 0xbd9c2a4e151281da, - 0xbd9c2a4e151281da, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd92d6ce160ad25b, 0xbd92d6ce160ad25b, - 0xbd92d6ce160ad25b, 0xbd92d6ce160ad25b, 0xbd92d6ce160ad25b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d5d7ea41282690c, 0x3d5d7ea41282690c, 0x3d5d7ea41282690c, 0x3d5d7ea41282690c, 0x3d5d7ea41282690c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8e4df327750a73, 0x3d8e4df327750a73, 0x3d8e4df327750a73, 0x3d8e4df327750a73, 0x3d8e4df327750a73, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9fda229762cefc, 0x3d9fda229762cefc, 0x3d9fda229762cefc, 0x3d9fda229762cefc, - 0x3d9fda229762cefc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8db67d85004663, 0xbd8db67d85004663, - 0xbd8db67d85004663, 0xbd8db67d85004663, 0xbd8db67d85004663, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd611d28931444ca, 0xbd611d28931444ca, 0xbd611d28931444ca, 0xbd611d28931444ca, 0xbd611d28931444ca, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d932288e7453464, 0x3d932288e7453464, 0x3d932288e7453464, 0x3d932288e7453464, 0x3d932288e7453464, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9bde9343d81fd2, 0x3d9bde9343d81fd2, 0x3d9bde9343d81fd2, 0x3d9bde9343d81fd2, - 0x3d9bde9343d81fd2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd85bf5eddeae80f, 0xbd85bf5eddeae80f, - 0xbd85bf5eddeae80f, 0xbd85bf5eddeae80f, 0xbd85bf5eddeae80f, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd787cd197b4df0d, 0xbd787cd197b4df0d, 0xbd787cd197b4df0d, 0xbd787cd197b4df0d, 0xbd787cd197b4df0d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d971e183acfe38e, 0x3d971e183acfe38e, 0x3d971e183acfe38e, 0x3d971e183acfe38e, 0x3d971e183acfe38e, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d97e303f04d70a8, 0x3d97e303f04d70a8, 0x3d97e303f04d70a8, 0x3d97e303f04d70a8, - 0x3d97e303f04d70a8, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7b90806dab1375, 0xbd7b90806dab1375, - 0xbd7b90806dab1375, 0xbd7b90806dab1375, 0xbd7b90806dab1375, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd84358772efcdda, 0xbd84358772efcdda, 0xbd84358772efcdda, 0xbd84358772efcdda, 0xbd84358772efcdda, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9b19a78e5a92b8, 0x3d9b19a78e5a92b8, 0x3d9b19a78e5a92b8, 0x3d9b19a78e5a92b8, 0x3d9b19a78e5a92b8, 0xbff0000000000000, -] )) ), - -################ chunk 15872 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40feee62606527c0, 0x40feee62606527c0, 0x40feee62606527c0, 0x40feee62606527c0, - 0x40feee62606527c0, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, - 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, - 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, - 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff4c88ace5d325, - 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, - 0x40ff59fbdc65eba1, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff74e23b661c99, 0x40ff74e23b661c99, - 0x40ff74e23b661c99, 0x40ff74e23b661c99, 0x40ff74e23b661c99, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, - 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, - 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffb82228e69706, - 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffc5955866af82, 0x40ffc5955866af82, 0x40ffc5955866af82, 0x40ffc5955866af82, - 0x40ffc5955866af82, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, - 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, - 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x4100046aa2f394f7, 0x4100046aa2f394f7, 0x4100046aa2f394f7, - 0x4100046aa2f394f7, 0x4100046aa2f394f7, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x410011ddd273ad73, - 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410018976a33b9b1, 0x410018976a33b9b1, 0x410018976a33b9b1, 0x410018976a33b9b1, - 0x410018976a33b9b1, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x4100260a99b3d22e, 0x4100260a99b3d22e, - 0x4100260a99b3d22e, 0x4100260a99b3d22e, 0x4100260a99b3d22e, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, - 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, - 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410047aa90740f64, - 0x410047aa90740f64, 0x410047aa90740f64, 0x410047aa90740f64, 0x410047aa90740f64, 0x41004e6428341ba2, 0x41004e6428341ba2, 0x41004e6428341ba2, 0x41004e6428341ba2, - 0x41004e6428341ba2, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x41005bd757b4341e, 0x41005bd757b4341e, - 0x41005bd757b4341e, 0x41005bd757b4341e, 0x41005bd757b4341e, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, - 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x410070041ef458d8, 0x410070041ef458d8, 0x410070041ef458d8, - 0x410070041ef458d8, 0x410070041ef458d8, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x41007d774e747154, - 0x41007d774e747154, 0x41007d774e747154, 0x41007d774e747154, 0x41007d774e747154, 0x41008430e6347d93, 0x41008430e6347d93, 0x41008430e6347d93, 0x41008430e6347d93, - 0x41008430e6347d92, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x410091a415b4960f, 0x410091a415b4960f, - 0x410091a415b4960f, 0x410091a415b4960f, 0x410091a415b4960f, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, - 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, - 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100b3440c74d345, - 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b9fda434df83, 0x4100b9fda434df83, 0x4100b9fda434df83, 0x4100b9fda434df83, - 0x4100b9fda434df83, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d93e7749cc2c17e, 0x3d93e7749cc2c17e, 0x3d93e7749cc2c17e, 0x3d93e7749cc2c17e, - 0x3d93e7749cc2c17e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd6744863f00ad9a, 0xbd6744863f00ad9a, - 0xbd6744863f00ad9a, 0xbd6744863f00ad9a, 0xbd6744863f00ad9a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd8c2ca61a052c2e, 0xbd8c2ca61a052c2e, 0xbd8c2ca61a052c2e, 0xbd8c2ca61a052c2e, 0xbd8c2ca61a052c2e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9f1536e1e541e2, 0x3d9f1536e1e541e2, 0x3d9f1536e1e541e2, 0x3d9f1536e1e541e2, 0x3d9f1536e1e541e2, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8fd7ca927024a8, 0x3d8fd7ca927024a8, 0x3d8fd7ca927024a8, 0x3d8fd7ca927024a8, - 0x3d8fd7ca927024a8, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d512fe8baa9976b, 0x3d512fe8baa9976b, - 0x3d512fe8baa9976b, 0x3d512fe8baa9976b, 0x3d512fe8baa9976b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd9211e2608d4541, 0xbd9211e2608d4541, 0xbd9211e2608d4541, 0xbd9211e2608d4541, 0xbd9211e2608d4541, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9cef39ca900ef4, 0xbd9cef39ca900ef4, 0xbd9cef39ca900ef4, 0xbd9cef39ca900ef4, 0xbd9cef39ca900ef4, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d87e0abeb5ac654, 0x3d87e0abeb5ac654, 0x3d87e0abeb5ac654, 0x3d87e0abeb5ac654, - 0x3d87e0abeb5ac654, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d743a377cd52283, 0x3d743a377cd52283, - 0x3d743a377cd52283, 0x3d743a377cd52283, 0x3d743a377cd52283, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd960d71b417f46b, 0xbd960d71b417f46b, 0xbd960d71b417f46b, 0xbd960d71b417f46b, 0xbd960d71b417f46b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3da3862ac47d501b, 0x3da3862ac47d501b, 0x3da3862ac47d501b, 0x3da3862ac47d501b, 0x3da3862ac47d501b, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdac059caeeea600, 0xbdac059caeeea600, 0xbdac059caeeea600, 0xbdac059caeeea600, - 0xbdac059caeeea600, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbdab7af166a0041b, 0xbdab7af166a0041b, - 0xbdab7af166a0041b, 0xbdab7af166a0041b, 0xbdab7af166a0041b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3da2fb7f7c2eae35, 0x3da2fb7f7c2eae35, 0x3da2fb7f7c2eae35, 0x3da2fb7f7c2eae35, 0x3da2fb7f7c2eae35, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd94f81b237ab0a0, 0xbd94f81b237ab0a0, 0xbd94f81b237ab0a0, 0xbd94f81b237ab0a0, 0xbd94f81b237ab0a0, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6fc9ba74c026af, 0x3d6fc9ba74c026af, 0x3d6fc9ba74c026af, 0x3d6fc9ba74c026af, - 0x3d6fc9ba74c026af, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8a0b590c954de9, 0x3d8a0b590c954de9, - 0x3d8a0b590c954de9, 0x3d8a0b590c954de9, 0x3d8a0b590c954de9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd9e04905b2d52bf, 0xbd9e04905b2d52bf, 0xbd9e04905b2d52bf, 0xbd9e04905b2d52bf, 0xbd9e04905b2d52bf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3da781ba1807ff45, 0x3da781ba1807ff45, 0x3da781ba1807ff45, 0x3da781ba1807ff45, 0x3da781ba1807ff45, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3daffed3fd86aad6, 0x3daffed3fd86aad6, 0x3daffed3fd86aad6, 0x3daffed3fd86aad6, - 0xbdb00096013caa95, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbda77f62131554f1, 0xbda77f62131554f1, - 0xbda77f62131554f1, 0xbda77f62131554f1, 0xbda77f62131554f1, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d9dffe05147fe17, 0x3d9dffe05147fe17, 0x3d9dffe05147fe17, 0x3d9dffe05147fe17, 0x3d9dffe05147fe17, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8a01f8f8caa499, 0xbd8a01f8f8caa499, 0xbd8a01f8f8caa499, 0xbd8a01f8f8caa499, 0xbd8a01f8f8caa499, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6fef3ac3eacbf1, 0xbd6fef3ac3eacbf1, 0xbd6fef3ac3eacbf1, 0xbd6fef3ac3eacbf1, - 0xbd6fef3ac3eacbf1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d94fccb2d600549, 0x3d94fccb2d600549, -] )) ), - -################ chunk 16384 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, - 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, - 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e910ca753535, - 0x4100e910ca753535, 0x4100e910ca753535, 0x4100e910ca753535, 0x4100e910ca753535, 0x4100efca62354174, 0x4100efca62354174, 0x4100efca62354174, 0x4100efca62354174, - 0x4100efca62354174, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, - 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, - 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x4101116a58f57eaa, 0x4101116a58f57eaa, 0x4101116a58f57eaa, - 0x4101116a58f57eaa, 0x4101116a58f57eaa, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011edd88759726, - 0x41011edd88759726, 0x41011edd88759726, 0x41011edd88759726, 0x41011edd88759726, 0x410125972035a364, 0x410125972035a364, 0x410125972035a364, 0x410125972035a364, - 0x410125972035a364, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, - 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, - 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101473716f5e09a, 0x4101473716f5e09a, 0x4101473716f5e09a, - 0x4101473716f5e09a, 0x4101473716f5e09a, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x410154aa4675f917, - 0x410154aa4675f917, 0x410154aa4675f917, 0x410154aa4675f917, 0x410154aa4675f917, 0x41015b63de360555, 0x41015b63de360555, 0x41015b63de360555, 0x41015b63de360555, - 0x41015b63de360555, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x410168d70db61dd1, 0x410168d70db61dd1, - 0x410168d70db61dd1, 0x410168d70db61dd1, 0x410168d70db61dd1, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, - 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x41017d03d4f6428b, 0x41017d03d4f6428b, 0x41017d03d4f6428b, - 0x41017d03d4f6428b, 0x41017d03d4f6428b, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x41018a7704765b07, - 0x41018a7704765b07, 0x41018a7704765b07, 0x41018a7704765b07, 0x41018a7704765b07, 0x410191309c366745, 0x410191309c366745, 0x410191309c366745, 0x410191309c366745, - 0x410191309c366745, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, - 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, - 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, - 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101c043c276bcf8, - 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, - 0x4101c6fd5a36c936, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, - 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, - 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e89d50f7066c, 0x4101e89d50f7066c, 0x4101e89d50f7066c, - 0x4101e89d50f7066c, 0x4101e89d50f7066c, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101f61080771ee8, - 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101fcca18372b26, 0x4101fcca18372b26, 0x4101fcca18372b26, 0x4101fcca18372b26, - 0x4101fcca18372b26, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020a3d47b743a2, 0x41020a3d47b743a2, - 0x41020a3d47b743a2, 0x41020a3d47b743a2, 0x41020a3d47b743a2, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, - 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d94fccb2d600549, 0x3d94fccb2d600549, 0x3d94fccb2d600549, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbda2fdd78121588a, 0xbda2fdd78121588a, 0xbda2fdd78121588a, 0xbda2fdd78121588a, 0xbda2fdd78121588a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3dab7d496b92ae6f, 0x3dab7d496b92ae6f, 0x3dab7d496b92ae6f, 0x3dab7d496b92ae6f, 0x3dab7d496b92ae6f, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3dac0344a9fbfbac, 0x3dac0344a9fbfbac, 0x3dac0344a9fbfbac, 0x3dac0344a9fbfbac, - 0x3dac0344a9fbfbac, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbda383d2bf8aa5c7, 0xbda383d2bf8aa5c7, - 0xbda383d2bf8aa5c7, 0xbda383d2bf8aa5c7, 0xbda383d2bf8aa5c7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d9608c1aa329fc3, 0x3d9608c1aa329fc3, 0x3d9608c1aa329fc3, 0x3d9608c1aa329fc3, 0x3d9608c1aa329fc3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbd742777553fcfe1, 0xbd742777553fcfe1, 0xbd742777553fcfe1, 0xbd742777553fcfe1, 0xbd742777553fcfe1, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd87ea0bff256fa4, 0xbd87ea0bff256fa4, 0xbd87ea0bff256fa4, 0xbd87ea0bff256fa4, - 0xbd87ea0bff256fa4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9cf3e9d475639d, 0x3d9cf3e9d475639d, - 0x3d9cf3e9d475639d, 0x3d9cf3e9d475639d, 0x3d9cf3e9d475639d, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbda6f966d4ac07b4, 0xbda6f966d4ac07b4, 0xbda6f966d4ac07b4, 0xbda6f966d4ac07b4, 0xbda6f966d4ac07b4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3daf78d8bf1d5d99, 0x3daf78d8bf1d5d99, 0x3daf78d8bf1d5d99, 0x3daf78d8bf1d5d99, 0x3daf78d8bf1d5d99, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da807b556714c82, 0x3da807b556714c82, 0x3da807b556714c82, 0x3da807b556714c82, - 0x3da807b556714c82, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9f1086d7ffed39, 0xbd9f1086d7ffed39, - 0xbd9f1086d7ffed39, 0xbd9f1086d7ffed39, 0xbd9f1086d7ffed39, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d8c2346063a82de, 0x3d8c2346063a82de, 0x3d8c2346063a82de, 0x3d8c2346063a82de, 0x3d8c2346063a82de, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d676a068e2b52dd, 0x3d676a068e2b52dd, 0x3d676a068e2b52dd, 0x3d676a068e2b52dd, 0x3d676a068e2b52dd, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd93ec24a6a81626, 0xbd93ec24a6a81626, 0xbd93ec24a6a81626, 0xbd93ec24a6a81626, - 0xbd93ec24a6a81626, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3da275843dc560f8, 0x3da275843dc560f8, - 0x3da275843dc560f8, 0x3da275843dc560f8, 0x3da275843dc560f8, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbdaaf4f62836b6de, 0xbdaaf4f62836b6de, 0xbdaaf4f62836b6de, 0xbdaaf4f62836b6de, 0xbdaaf4f62836b6de, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbdac8b97ed57f33d, 0xbdac8b97ed57f33d, 0xbdac8b97ed57f33d, 0xbdac8b97ed57f33d, 0xbdac8b97ed57f33d, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da40c2602e69d58, 0x3da40c2602e69d58, 0x3da40c2602e69d58, 0x3da40c2602e69d58, - 0x3da40c2602e69d58, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd97196830ea8ee5, 0xbd97196830ea8ee5, - 0xbd97196830ea8ee5, 0xbd97196830ea8ee5, 0xbd97196830ea8ee5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3d786a11701f8c6c, 0x3d786a11701f8c6c, 0x3d786a11701f8c6c, 0x3d786a11701f8c6c, 0x3d786a11701f8c6c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d85c8bef1b5915f, 0x3d85c8bef1b5915f, 0x3d85c8bef1b5915f, 0x3d85c8bef1b5915f, 0x3d85c8bef1b5915f, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9be3434dbd747a, 0xbd9be3434dbd747a, 0xbd9be3434dbd747a, 0xbd9be3434dbd747a, - 0xbd9be3434dbd747a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3da6711391501022, 0x3da6711391501022, - 0x3da6711391501022, 0x3da6711391501022, 0x3da6711391501022, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbdaef0857bc16608, 0xbdaef0857bc16608, 0xbdaef0857bc16608, 0xbdaef0857bc16608, 0xbdaef0857bc16608, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 16896 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022bdd3e7780d9, - 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41023296d6378d17, 0x41023296d6378d17, 0x41023296d6378d17, 0x41023296d6378d17, - 0x41023296d6378d17, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x4102400a05b7a593, 0x4102400a05b7a593, - 0x4102400a05b7a593, 0x4102400a05b7a593, 0x4102400a05b7a593, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, - 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, - 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x410261a9fc77e2c9, - 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, - 0x410268639437ef07, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x410275d6c3b80783, 0x410275d6c3b80783, - 0x410275d6c3b80783, 0x410275d6c3b80783, 0x410275d6c3b80783, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, - 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028a038af82c3e, 0x41028a038af82c3e, 0x41028a038af82c3e, - 0x41028a038af82c3e, 0x41028a038af82c3e, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x41029776ba7844ba, - 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029e30523850f8, 0x41029e30523850f8, 0x41029e30523850f8, 0x41029e30523850f8, - 0x41029e30523850f8, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102aba381b86974, 0x4102aba381b86974, - 0x4102aba381b86974, 0x4102aba381b86974, 0x4102aba381b86974, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, - 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, - 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102cd437878a6aa, - 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, - 0x4102d3fd1038b2e8, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, - 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, - 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, - 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x410303103679089b, - 0x410303103679089b, 0x410303103679089b, 0x410303103679089b, 0x410303103679089b, 0x410309c9ce3914d9, 0x410309c9ce3914d9, 0x410309c9ce3914d9, 0x410309c9ce3914d9, - 0x410309c9ce3914d9, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103173cfdb92d55, 0x4103173cfdb92d55, - 0x4103173cfdb92d55, 0x4103173cfdb92d55, 0x4103173cfdb92d55, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, - 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x41032b69c4f9520f, 0x41032b69c4f9520f, 0x41032b69c4f9520f, - 0x41032b69c4f9520f, 0x41032b69c4f9520f, 0x4090000000000000, 0x4090040000000000, 0x408ff80000000000, 0x4090020000000000, 0x408ffc0000000000, 0x40a0000000000000, - 0x40a0020000000000, 0x409ffc0000000000, 0x40a0010000000000, 0x409ffe0000000000, 0x40b0000000000000, 0x40b0010000000000, 0x40affe0000000000, 0x40b0008000000000, - 0x40afff0000000000, 0x40c0000000000000, 0x40c0008000000000, 0x40bfff0000000000, 0x40c0004000000000, 0x40bfff8000000000, 0x40d0000000000000, 0x40d0004000000000, - 0x40cfff8000000000, 0x40d0002000000000, 0x40cfffc000000000, 0x40e0000000000000, 0x40e0002000000000, 0x40dfffc000000000, 0x40e0001000000000, 0x40dfffe000000000, - 0x40f0000000000000, 0x40f0001000000000, 0x40efffe000000000, 0x40f0000800000000, 0x40effff000000000, 0x4100000000000000, 0x4100000800000000, 0x40fffff000000000, - 0x4100000400000000, 0x40fffff800000000, 0x4110000000000000, 0x4110000400000000, 0x410ffff800000000, 0x4110000200000000, 0x410ffffc00000000, 0x4120000000000000, - 0x4120000200000000, 0x411ffffc00000000, 0x4120000100000000, 0x411ffffe00000000, 0x4130000000000000, 0x4130000100000000, 0x412ffffe00000000, 0x4130000080000000, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0xbda8900899cd4413, 0xbda8900899cd4413, 0xbda8900899cd4413, 0xbda8900899cd4413, 0xbda8900899cd4413, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da01096af5bee2e, 0x3da01096af5bee2e, 0x3da01096af5bee2e, 0x3da01096af5bee2e, - 0x3da01096af5bee2e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8e449313aa6123, 0xbd8e449313aa6123, - 0xbd8e449313aa6123, 0xbd8e449313aa6123, 0xbd8e449313aa6123, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd5dc9a4b0d7b391, 0xbd5dc9a4b0d7b391, 0xbd5dc9a4b0d7b391, 0xbd5dc9a4b0d7b391, 0xbd5dc9a4b0d7b391, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d92db7e1ff02704, 0x3d92db7e1ff02704, 0x3d92db7e1ff02704, 0x3d92db7e1ff02704, 0x3d92db7e1ff02704, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, 0xbda1ed30fa696967, - 0xbda1ed30fa696967, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3daa6ca2e4dabf4c, 0x3daa6ca2e4dabf4c, - 0x3daa6ca2e4dabf4c, 0x3daa6ca2e4dabf4c, 0x3daa6ca2e4dabf4c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3dad13eb30b3eace, 0x3dad13eb30b3eace, 0x3dad13eb30b3eace, 0x3dad13eb30b3eace, 0x3dad13eb30b3eace, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbda49479464294e9, 0xbda49479464294e9, 0xbda49479464294e9, 0xbda49479464294e9, 0xbda49479464294e9, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d982a0eb7a27e08, 0x3d982a0eb7a27e08, 0x3d982a0eb7a27e08, 0x3d982a0eb7a27e08, - 0x3d982a0eb7a27e08, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7cacab8aff48f6, 0xbd7cacab8aff48f6, - 0xbd7cacab8aff48f6, 0xbd7cacab8aff48f6, 0xbd7cacab8aff48f6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd83a771e445b31a, 0xbd83a771e445b31a, 0xbd83a771e445b31a, 0xbd83a771e445b31a, 0xbd83a771e445b31a, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9ad29cc7058558, 0x3d9ad29cc7058558, 0x3d9ad29cc7058558, 0x3d9ad29cc7058558, 0x3d9ad29cc7058558, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda5e8c04df41891, 0xbda5e8c04df41891, 0xbda5e8c04df41891, 0xbda5e8c04df41891, - 0xbda5e8c04df41891, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3dae683238656e76, 0x3dae683238656e76, - 0x3dae683238656e76, 0x3dae683238656e76, 0x3dae683238656e76, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0x3da9185bdd293ba4, 0x3da9185bdd293ba4, 0x3da9185bdd293ba4, 0x3da9185bdd293ba4, 0x3da9185bdd293ba4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbda098e9f2b7e5bf, 0xbda098e9f2b7e5bf, 0xbda098e9f2b7e5bf, 0xbda098e9f2b7e5bf, 0xbda098e9f2b7e5bf, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9032f0108d1fb4, 0x3d9032f0108d1fb4, 0x3d9032f0108d1fb4, 0x3d9032f0108d1fb4, - 0x3d9032f0108d1fb4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d497e788ab182d1, 0x3d497e788ab182d1, - 0x3d497e788ab182d1, 0x3d497e788ab182d1, 0x3d497e788ab182d1, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, - 0xbd91cad7993837e1, 0xbd91cad7993837e1, 0xbd91cad7993837e1, 0xbd91cad7993837e1, 0xbd91cad7993837e1, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0xbfc44ad2614e80ab, 0x3fe7d87608cdaac9, 0xbfed53d921a57389, 0x3fd564211cf43f56, 0xbfe39981d6dbe861, 0xbfd4092047ede3e2, - 0x3fe4293171fcc2ef, 0xbfeefc78c81772e1, 0x3fc71db03e7e77dd, 0xbfe75ca75b2251da, 0xbfe3074ea233620d, 0x3fd6bc638485c160, 0xbfefee26bf3a602e, 0xbfc1755a2c0d1b82, - 0xbfed089c41dfa9bc, 0xbfee98f87098c8e4, 0xbfd14b95b48a4f3c, 0xbfe86a8d36dca1db, 0xbfe65c1cd5a1c02d, 0xbfef580b4012d43a, 0xbfe1eb0412ba4ffd, 0xbfeffdbc337f08ca, - 0x3fd941f81f42730a, 0xbfec6f83df75b0b8, 0xbfb81ba44a8da908, 0x3fedb0ffc3ecc6e4, 0x3fea159ef81c29f6, 0x3fc80036fa7b61fa, 0x3fefc7334ee4fa4a, 0x3fe455ceddf6197d, - 0x3fe62566735b8513, 0xbfcde29f1835c200, 0x3fef67090db1f5c3, 0x3fd0b8c9b549bc53, 0x3fee8256ebff7bd0, 0xbfeff8bd7b10d6b0, 0xbfe024168cf6f781, 0xbfe268613f60babc, - 0xbfeb6979ba1ad0dc, 0xbfecb4185081f8c6, 0xbfb58809c5ce39b6, 0xbfec492d1cc46dbf, 0x3fe960a26db13c6e, 0xbfe1a632508b1f3d, 0x3fd9d9c2402d796d, 0x3fc57481ec90fde3, - 0x3fed71b50aeb5e24, 0xbfe7a5e663c6210f, 0x3fe3d4ebb04eb632, 0xbfd4d5b66675b7b0, 0x3fd526ccb2fc8656, 0x3fef20cc1ff62d21, 0xbfe3b32b2ca06654, 0x3fe7c2bb1d7c0924, -] )) ), - -################ chunk 17408 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x412fffff00000000, 0x4140000000000000, 0x4140000080000000, 0x413fffff00000000, 0x4140000040000000, 0x413fffff80000000, 0x4150000000000000, 0x4150000040000000, - 0x414fffff80000000, 0x4150000020000000, 0x414fffffc0000000, 0x4160000000000000, 0x4160000020000000, 0x415fffffc0000000, 0x4160000010000000, 0x415fffffe0000000, - 0x4170000000000000, 0x4170000010000000, 0x416fffffe0000000, 0x4170000008000000, 0x416ffffff0000000, 0x4180000000000000, 0x4180000008000000, 0x417ffffff0000000, - 0x4180000004000000, 0x417ffffff8000000, 0x4190000000000000, 0x4190000004000000, 0x418ffffff8000000, 0x4190000002000000, 0x418ffffffc000000, 0x41a0000000000000, - 0x41a0000002000000, 0x419ffffffc000000, 0x41a0000001000000, 0x419ffffffe000000, 0x41b0000000000000, 0x41b0000001000000, 0x41affffffe000000, 0x41b0000000800000, - 0x41afffffff000000, 0x41c0000000000000, 0x41c0000000800000, 0x41bfffffff000000, 0x41c0000000400000, 0x41bfffffff800000, 0x41d0000000000000, 0x41d0000000400000, - 0x41cfffffff800000, 0x41d0000000200000, 0x41cfffffffc00000, 0x41e0000000000000, 0x41e0000000200000, 0x41dfffffffc00000, 0x41e0000000100000, 0x41dfffffffe00000, - 0x41f0000000000000, 0x41f0000000100000, 0x41efffffffe00000, 0x41f0000000080000, 0x41effffffff00000, 0x4200000000000000, 0x4200000000080000, 0x41fffffffff00000, - 0x4200000000040000, 0x41fffffffff80000, 0x4210000000000000, 0x4210000000040000, 0x420ffffffff80000, 0x4210000000020000, 0x420ffffffffc0000, 0x4220000000000000, - 0x4220000000020000, 0x421ffffffffc0000, 0x4220000000010000, 0x421ffffffffe0000, 0x4230000000000000, 0x4230000000010000, 0x422ffffffffe0000, 0x4230000000008000, - 0x422fffffffff0000, 0x4240000000000000, 0x4240000000008000, 0x423fffffffff0000, 0x4240000000004000, 0x423fffffffff8000, 0x4250000000000000, 0x4250000000004000, - 0x424fffffffff8000, 0x4250000000002000, 0x424fffffffffc000, 0x4260000000000000, 0x4260000000002000, 0x425fffffffffc000, 0x4260000000001000, 0x425fffffffffe000, - 0x4270000000000000, 0x4270000000001000, 0x426fffffffffe000, 0x4270000000000800, 0x426ffffffffff000, 0x4280000000000000, 0x4280000000000800, 0x427ffffffffff000, - 0x4280000000000400, 0x427ffffffffff800, 0x4290000000000000, 0x4290000000000400, 0x428ffffffffff800, 0x4290000000000200, 0x428ffffffffffc00, 0x42a0000000000000, - 0x42a0000000000200, 0x429ffffffffffc00, 0x42a0000000000100, 0x429ffffffffffe00, 0x42b0000000000000, 0x42b0000000000100, 0x42affffffffffe00, 0x42b0000000000080, - 0x42afffffffffff00, 0x42c0000000000000, 0x42c0000000000080, 0x42bfffffffffff00, 0x42c0000000000040, 0x42bfffffffffff80, 0x42d0000000000000, 0x42d0000000000040, - 0x42cfffffffffff80, 0x42d0000000000020, 0x42cfffffffffffc0, 0x42e0000000000000, 0x42e0000000000020, 0x42dfffffffffffc0, 0x42e0000000000010, 0x42dfffffffffffe0, - 0x42f0000000000000, 0x42f0000000000010, 0x42efffffffffffe0, 0x42f0000000000008, 0x42effffffffffff0, 0x4300000000000000, 0x4300000000000008, 0x42fffffffffffff0, - 0x4300000000000004, 0x42fffffffffffff8, 0x4310000000000000, 0x4310000000000004, 0x430ffffffffffff8, 0x4310000000000002, 0x430ffffffffffffc, 0x408f400000000000, - 0x4091300000000000, 0x408c200000000000, 0x408f480000000000, 0x408f380000000000, 0x40c3880000000000, 0x40c57c0000000000, 0x40c1940000000000, 0x40c3888000000000, - 0x40c3878000000000, 0x40f86a0000000000, 0x40fadb0000000000, 0x40f5f90000000000, 0x40f86a1000000000, 0x40f869f000000000, 0x412e848000000000, 0x4130c8e000000000, - 0x412b774000000000, 0x412e848200000000, 0x412e847e00000000, 0x416312d000000000, 0x4164fb1800000000, 0x41612a8800000000, 0x416312d020000000, 0x416312cfe0000000, - 0x4197d78400000000, 0x419a39de00000000, 0x4195752a00000000, 0x4197d78404000000, 0x4197d783fc000000, 0x41cdcd6500000000, 0x41d0642ac0000000, 0x41cad27480000000, - 0x41cdcd6500800000, 0x41cdcd64ff800000, 0x4202a05f20000000, 0x42047d3570000000, 0x4200c388d0000000, 0x4202a05f20080000, 0x4202a05f1ff80000, 0x42374876e8000000, - 0x42399c82cc000000, 0x4234f46b04000000, 0x42374876e8010000, 0x42374876e7ff0000, 0x426d1a94a2000000, 0x427001d1bf800000, 0x426a3185c5000000, 0x426d1a94a2002000, - 0x426d1a94a1ffe000, 0x42a2309ce5400000, 0x42a402462f600000, 0x42a05ef39b200000, 0x42a2309ce5400200, 0x42a2309ce53ffe00, 0x42d6bcc41e900000, 0x42d902d7bb380000, - 0x42d476b081e80000, 0x42d6bcc41e900040, 0x42d6bcc41e8fffc0, 0x430c6bf526340000, 0x430f438daa060000, 0x4309945ca2620000, 0x430c6bf526340008, 0x430c6bf52633fff8, - 0x4341c37937e08000, 0x43438a388a43c000, 0x433ff973cafa8000, 0x4341c37937e08000, 0x4341c37937e08000, 0x4376345785d8a000, 0x43786cc6acd4b000, 0x4373fbe85edc9000, - 0x4376345785d8a000, 0x4376345785d8a000, 0x43abc16d674ec800, 0x43ae87f85809dc00, 0x43a8fae27693b400, 0x43abc16d674ec800, 0x43abc16d674ec800, 0x409f400000000000, - 0x40d3880000000000, 0x40a7700000000000, 0x40dd4c0000000000, 0x40b3880000000000, 0x40e86a0000000000, 0x40bf400000000000, 0x40f3880000000000, 0x40c9640000000000, - 0x40ffbd0000000000, 0x40d4820000000000, 0x4109a28000000000, 0x40e09a0000000000, 0x4114c08000000000, 0x40eadb0000000000, 0x4120c8e000000000, 0x40f5ba8000000000, - 0x412b292000000000, 0x4101940000000000, 0x4135f90000000000, 0x410c714000000000, 0x4141c6c800000000, 0x411702a000000000, 0x414cc34800000000, 0x41229da000000000, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbfc4cb305757fa66, 0x3fe3f68887a137ef, 0x3fefd4b493511761, 0xbfd4847a9fa86457, 0x3fed826936582d64, 0x3fc61dace9df937b, 0x3fef34428f9492a2, 0x3fe6d3e342a8da7f, - 0x3fd5c886960b0385, 0x3feec8d2fd2832e5, 0x3fe7fbe42484ae3f, 0x3fdba9f45d1ca7c5, 0xbfe0cee506ee9ba3, 0x3fefc14a7f82c4ee, 0xbfab219a0777ecea, 0x3fe9f919943e1642, - 0xbfe8f22f8433d6ee, 0x3fbb17d7d79c02c7, 0xbfee57ec09221973, 0xbfd89119d0101972, 0xbfef804285107093, 0xbfef3fa130939baf, 0xbfe6af4f91aff747, 0xbfd62a40725b6bf4, - 0xbfeeba76604d7d1c, 0xbfe81e3563c21998, 0x3fdaedbaec15d29d, 0xbfe127165d2723d5, 0x3fefb3c921361b15, 0xbfb0cfbe00d6ada7, 0x3fe9bbc8ffdc13f7, 0xbfe86dcc9babb0a4, - 0x3fc0c673c05e481d, 0xbfee977f5248d0df, 0xbfd70eca6d554d52, 0xbfef590e12828184, 0xbfef8eef8d66d4ea, 0xbfe58263a7d63adc, 0xbfd92f7ded4de5d5, 0xbfee3c329b9ac56a, - 0xbfe927ab2823b59a, 0x3fd4e67c0e2622de, 0xbfe3cdf4af50b48c, 0x3fef18d5c013070d, 0xbfc55185e2d58276, 0x3fe7abdf6ac21262, 0xbfe3c12353728caf, 0x3fd5054c2710443f, - 0xbfefdb6a55d0ac16, 0xbfc51133452478d7, 0xbfed67cfe9ce9163, 0xbfef14f913e9af98, 0xbfd4c7a68801a084, 0xbfe7328434159860, 0xbfe7a0e377dc0a48, 0xbfeeece9b2af55a0, - 0xbfdd9130288cfb14, 0xbfefde6de9d02bc9, 0x3fdfc98f21cff7b4, 0xbfea948056c27030, 0x3f943d3e0a1072f3, 0x3fea39038f075705, 0x3fed99e0cfab06b1, 0xbfa43c3aef6afaea, - 0x3fefce313ed33418, 0x3fdc7082d2332cbf, 0x3fee0ef35be1984d, 0x3fcc03f72f708c75, 0x3fe97a352e2f015c, 0x3fe51db9e52b9c0e, 0x3fefa42ecc59a7fa, 0xbfe49f2c66463c18, - 0xbfefbb6c9ee315ad, 0x3fd2e5734563cd31, 0xbfedd416e09afdee, 0xbfc976ed4b1b0a3d, 0x3fef8993cb9a6586, 0x3fe59a08acba61b8, 0x3fd8f49f3c1d3a16, 0x3fee469dbe20bae5, - 0x3fe913d85ca21b52, 0x3fd55f4563b24793, 0xbfe39b8b4fa69e9d, 0x3fef27af3ea82d4e, 0xbfc45500060eba5e, 0x3fe7d6bdf99ece77, 0xbfe4253076d8fcd2, 0x3fd412ea7328d96f, - 0xbfefce5728c09868, 0xbfc709688f854575, 0xbfed995de0b0b273, 0xbfef4df2000a12ae, 0xbfd6a91c74874834, 0xbfe67f59c69f7fdf, 0xbfe84a80f5385c3d, 0xbfeea74b27c68d03, - 0xbfd9f7122716d5d9, 0xbfefa03eef64f6d7, 0x3fe198d16f110c40, 0xbfe96a62be7156b6, 0x3fb50841f2a3a079, 0x3fe7bb732b2dad26, 0x3feee2ac4b52abe3, 0xbfc4f60e33791a08, - 0x3fef1e45a64f3b02, 0x3fd5124a94ee9629, 0x3fefd6e8410105ec, 0x3fdd04be050796e6, 0x3fe3e5896d4047fd, 0x3fea6834d1d1e374, 0x3fed79fb56b08182, 0xbfc97b16c2c7f89e, - 0xbfedd47947d27ef4, 0x3fe6f240f69503e8, 0xbfe49ffc39e4939f, 0x3fd2e36be37df8e8, 0x3fd8f888558cee10, 0x3fef89efd2bec663, 0xbfe20c096719e44d, 0x3fe91529fb2b0291, - 0xbfb95982d9b925ca, 0x3fe6fde1730cde37, 0x3fef26b6c690d836, 0xbfc9399de16530b7, 0x3feed9081dc974e1, 0x3fd303524e94ba25, 0x3feffbaee934d6b7, 0x3fe06811fd510f22, - 0x3fe22793f808c0a1, 0x3feb91e28c4ae147, 0x3fec90d9e34e365f, 0xbfb09c493c272925, 0xbfebfdfe938da733, 0x3fe9bf9d4c58fbde, 0xbfe121a4fb359a9d, 0x3fdaf96c40be2b2b, - 0x3fc0935354934b3e, 0x3fecf0752c36971a, 0xbfe8761e51402e11, 0x3fe2d95a0b9a29b5, 0xbfd726d5c310c3b5, 0x3fd06f98b1c26e7a, 0x3fee76d368c145ca, 0xbfe59573a5a6c11f, - 0x3fe609fd6f94f5c5, 0xbfce75e8244d93da, 0x3fdfc4f5e3aaeddb, 0x3feff53351c90edb, 0xbfdd95e2e4d8b9a5, 0x3feb421432e72efb, 0x3f93e87e45dd1094, 0x3fea75cc150a206b, - 0x3fdb68af0cc5c275, 0x3fefee0121ef7d8e, 0x3fed70901f28580e, 0xbf9b18870e886e35, 0xbfd38f2fa75d9289, 0xbfeeb1acfc3e865e, 0x3fe3b1bd2f54d581, 0xbfeeec37f4165d6a, - 0x3fe45ad3086449bd, 0x3fa24daa9c527e96, 0x3fd15e4cdf6372ca, 0xbfd5b9abc00c4d18, 0xbfea4ab1c2190342, 0x3feb8727670dd450, 0xbfd6664b2568d867, 0x3fd8874aae64b2ca, - 0x3fd43df6f7e4dd85, 0x3fe32c3740018a1e, 0xbfef4677c48458b4, 0x3fdaea414a8a3352, 0x3fe6c4820542653f, 0x3fb38fa01c1d0e61, 0xbfe128b4404d1668, 0x3fefb38658ea8f8c, - 0x3fedcffca623a20b, 0xbfeff02f05e37abe, 0xbfe6285e2422bcfc, 0x3fc94a963242eec7, 0x3fe9e48379b16e88, 0x3fe1778cae83c69b, 0x3fe2a1d97d8b7f0a, 0xbfef53a3700fd412, - 0x3fefffd25631c5bb, 0xbfda3fb06c32730b, 0xbfdf334c7896a4e3, 0x3fb16fc2a542bfb8, 0xbfec526cdd1b5da5, 0x3fde29d91695253f, 0xbfeff07adba199b5, 0x3fedb7dbc47abb83, - 0x3fe42988d2d410b6, 0x3fefbb9b4791d423, 0x3fea0aeb77d9ffdf, 0x3fc848ab289c9124, 0xbfe38f4477984352, 0x3fe0444701b85824, 0xbfeec6254143f8a0, 0x3fd57c867773a0a3, - 0xbfefe12390d37ff4, 0xbfd27d18bf625778, 0xbfea0ac5a8b1ef51, 0x3fd6d18f7cd6b5e3, 0x3fe4c8c5d664a7c3, 0xbfeec6136abda3d6, 0xbfcacde4341a9ee7, 0x3fb4fdf8b49bdc84, - 0xbfdee8d199afee96, 0xbfedf35e082ce4d4, 0x3fe6b59e9336e0c3, 0x3feb76f88136ceba, 0xbfe76ab64e9bd2a1, 0xbfee4b73b59e9766, 0x3fa053c59eb80c2c, 0x3feca876b117e178, - 0x3fe8f334432ebba5, 0xbfee00718543d9ee, 0x3fc192c9d38ecf36, 0x3fe8f334432ebba5, 0x3fe8f334432ebba5, 0xbfddbadc7a119fc8, 0xbfd992caa7729851, 0x3fef671338313e14, - 0xbfddbadc7a119fc8, 0xbfddbadc7a119fc8, 0xbfefc66798d05d2e, 0x3fea610678789f8e, 0x3fede5f02534c3db, 0xbfefc66798d05d2e, 0xbfefc66798d05d2e, 0x3fedc2e234ee9247, - 0x3fe29f9e81f1259b, 0x3fcc0e6ac593f0c1, 0xbfe9af6f6fce6470, 0xbfef9d6bcb019088, 0xbfeffeb0da2bbf4d, 0x3fefee5482d13679, 0x3fe38ab87c8733f8, 0x3fb6e822b8885eb0, - 0x3fe8fc90c249a140, 0x3feffda8b771cac7, 0xbfce4f75ee8bf91d, 0x3fefcb48ed51bfcd, 0xbfed028db65d479a, 0xbfc1889c9b40edb6, 0x3fef621893002b55, 0xbfeeff765c3dfcaf, - 0xbfe2ea16e3a56e06, 0x3fed9e08ba91b14a, 0x3fe59e5002ff92a3, 0x3fe317522b8eb58a, 0x3fbbf04d68ee66a0, 0x3fe08a53763de013, 0x3fe8106be83248b7, 0xbfb88cbd88643c0a, -] )) ), - -################ chunk 17920 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4157450800000000, 0x412e1ef000000000, 0x4162d35600000000, 0x41385e4800000000, 0x416e75da00000000, 0x4143b6e000000000, 0x4178a49800000000, 0x414fe60400000000, - 0x4183efc280000000, 0x4159ce7200000000, 0x4190210740000000, 0x4164e0ba00000000, 0x419a18e880000000, 0x40f8a88000000000, 0x412ed2a000000000, 0x416343a400000000, - 0x4073d4d0507dcb95, 0x4063d4d0507dcb95, 0x40f9258000000000, 0x412f6ee000000000, 0x4163a54c00000000, 0x407439583dcedc4a, 0x406439583dcedc4a, 0x40fa1f8000000000, - 0x413053b000000000, 0x4164689c00000000, 0x407502681870fdb2, 0x406502681870fdb2, 0x40fa9c8000000000, 0x4130a1d000000000, 0x4164ca4400000000, 0x407566f005c20e67, - 0x406566f005c20e67, 0x40fb968000000000, 0x41313e1000000000, 0x41658d9400000000, 0x40762fffe0642fcf, 0x40662fffe0642fcf, 0x40ff018000000000, 0x413360f000000000, - 0x4168392c00000000, 0x4078efb75d9ba4be, 0x4068efb75d9ba4be, 0x40fffb8000000000, 0x4133fd3000000000, 0x4168fc7c00000000, 0x4079b8c7383dc627, 0x4069b8c7383dc627, - 0x4100b94000000000, 0x4134e79000000000, 0x416a217400000000, 0x407ae65f0030f844, 0x406ae65f0030f844, 0x4100f7c000000000, 0x413535b000000000, 0x416a831c00000000, - 0x407b4ae6ed8208f8, 0x406b4ae6ed8208f8, 0x4102304000000000, 0x4136bc5000000000, 0x416c6b6400000000, 0x407d418e90175c7e, 0x406d418e90175c7e, 0x41026ec000000000, - 0x41370a7000000000, 0x416ccd0c00000000, 0x407da6167d686d33, 0x406da6167d686d33, 0x41032a4000000000, 0x4137f4d000000000, 0x416df20400000000, 0x407ed3ae455b9f50, - 0x406ed3ae455b9f50, 0x4103e5c000000000, 0x4138df3000000000, 0x416f16fc00000000, 0x408000a306a768b6, 0x407000a306a768b6, 0x410462c000000000, 0x41397b7000000000, - 0x416fda4c00000000, 0x4080652af3f8796b, 0x4070652af3f8796b, 0x41051e4000000000, 0x413a65d000000000, 0x41707fa200000000, 0x4080fbf6d7f21279, 0x4070fbf6d7f21279, - 0x4105d9c000000000, 0x413b503000000000, 0x4171121e00000000, 0x408192c2bbebab88, 0x407192c2bbebab88, 0x4106184000000000, 0x413b9e5000000000, 0x417142f200000000, - 0x4081c506b29433e2, 0x4071c506b29433e2, 0x410750c000000000, 0x413d24f000000000, 0x4172371600000000, 0x4082c05a83dedda5, 0x4072c05a83dedda5, 0x41078f4000000000, - 0x413d731000000000, 0x417267ea00000000, 0x4082f29e7a8765ff, 0x4072f29e7a8765ff, 0x41080c4000000000, 0x413e0f5000000000, 0x4172c99200000000, 0x4083572667d876b4, - 0x4073572667d876b4, 0x41084ac000000000, 0x413e5d7000000000, 0x4172fa6600000000, 0x4083896a5e80ff0e, 0x4073896a5e80ff0e, 0x4109c1c000000000, 0x4140191800000000, - 0x41741f5e00000000, 0x4084b7022674312b, 0x4074b7022674312b, 0x410b38c000000000, 0x4141037800000000, 0x4175445600000000, 0x4085e499ee676348, 0x4075e499ee676348, - 0x410bb5c000000000, 0x4141519800000000, 0x4175a5fe00000000, 0x40864921dbb873fd, 0x40764921dbb873fd, 0x410bf44000000000, 0x414178a800000000, 0x4175d6d200000000, - 0x40867b65d260fc57, 0x40767b65d260fc57, 0x410c714000000000, 0x4141c6c800000000, 0x4176387a00000000, 0x4086dfedbfb20d0b, 0x4076dfedbfb20d0b, 0x410d2cc000000000, - 0x41423bf800000000, 0x4176caf600000000, 0x408776b9a3aba61a, 0x407776b9a3aba61a, 0x410d6b4000000000, 0x4142630800000000, 0x4176fbca00000000, 0x4087a8fd9a542e74, - 0x4077a8fd9a542e74, 0x410ea3c000000000, 0x4143265800000000, 0x4177efee00000000, 0x4088a4516b9ed837, 0x4078a4516b9ed837, 0x410f5f4000000000, 0x41439b8800000000, - 0x4178826a00000000, 0x40893b1d4f987145, 0x40793b1d4f987145, 0x41100d6000000000, 0x414410b800000000, 0x417914e600000000, 0x4089d1e933920a54, 0x4079d1e933920a54, - 0x41106b2000000000, 0x414485e800000000, 0x4179a76200000000, 0x408a68b5178ba363, 0x407a68b5178ba363, 0x41108a6000000000, 0x4144acf800000000, 0x4179d83600000000, - 0x408a9af90e342bbd, 0x407a9af90e342bbd, 0x4110e82000000000, 0x4145222800000000, 0x417a6ab200000000, 0x408b31c4f22dc4cb, 0x407b31c4f22dc4cb, 0x411126a000000000, - 0x4145704800000000, 0x417acc5a00000000, 0x408b964cdf7ed580, 0x407b964cdf7ed580, 0x411145e000000000, 0x4145975800000000, 0x417afd2e00000000, 0x408bc890d6275dda, - 0x407bc890d6275dda, 0x4111e22000000000, 0x41465aa800000000, 0x417bf15200000000, 0x408cc3e4a772079d, 0x407cc3e4a772079d, 0x4112bce000000000, 0x41476c1800000000, - 0x417d471e00000000, 0x408e23c0660dc214, 0x407e23c0660dc214, 0x4112fb6000000000, 0x4147ba3800000000, 0x417da8c600000000, 0x408e8848535ed2c8, 0x407e8848535ed2c8, - 0x41131aa000000000, 0x4147e14800000000, 0x417dd99a00000000, 0x408eba8c4a075b23, 0x407eba8c4a075b23, 0x4113592000000000, 0x41482f6800000000, 0x417e3b4200000000, - 0x408f1f1437586bd7, 0x407f1f1437586bd7, 0x411433e000000000, 0x414940d800000000, 0x417f910e00000000, 0x40903f77fafa1327, 0x40803f77fafa1327, 0x411491a000000000, - 0x4149b60800000000, 0x418011c500000000, 0x40908addecf6dfae, 0x40808addecf6dfae, 0x41152de000000000, 0x414a795800000000, 0x41808bd700000000, 0x40910887d59c3490, - 0x40810887d59c3490, 0x41154d2000000000, 0x414aa06800000000, 0x4180a44100000000, 0x409121a9d0f078bd, 0x408121a9d0f078bd, 0x41158ba000000000, 0x414aee8800000000, - 0x4180d51500000000, 0x409153edc7990117, 0x408153edc7990117, 0x4115e96000000000, 0x414b63b800000000, 0x41811e5300000000, 0x40919f53b995cd9f, 0x40819f53b995cd9f, - 0x4116666000000000, 0x414bfff800000000, 0x41817ffb00000000, 0x409203dba6e6de53, 0x408203dba6e6de53, 0x7fdfffffffffffff, 0x7fe1ccf385ebc8a0, 0x7fac7b1f3cac7433, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3fea38efc974a4e1, 0xbfdbac9a08357b9f, 0x3fef13bb808eecfd, 0x3fd6033f9bbb89a4, 0x3fd71e7a62925fd3, 0x3fe6eac4855ed218, 0xbfefbc1a22eaf6f4, 0xbfed335ae38cbc2e, - 0x3fec1b4ea7a22e8d, 0x3fedc10b7a145b56, 0xbfe2c83111f32d3c, 0x3fa6c80193e16f32, 0x3fdb8e01f4aacb59, 0xbfe9ccc5bb2b1247, 0x3fa80b919cfcd695, 0xbfdcf93f241d585d, - 0x3d03da34489c213b, 0x3ff0000000000000, 0xbfd04060d3e63c1e, 0xbfe1618082d1affe, 0xbfe07d0f9cf4b767, 0xbd1dcc4d42e59df2, 0xbff0000000000000, 0xbfde729d3484aea4, - 0xbfef09ec2bbbad1b, 0xbfe43ab1afb29456, 0x3d12c0e3eeb304ee, 0xbff0000000000000, 0xbfe4955674dd38ce, 0xbfe4b5da68de5d47, 0xbfe5f2fe83279015, 0xbd14f8837880a9a2, - 0x3ff0000000000000, 0xbfab8de76d5dd0c4, 0x3fe068c47b7729b6, 0xbfe90b51b30a31d4, 0x3d1b94adb917f93e, 0x3ff0000000000000, 0xbfecc2ce3b0fbf34, 0xbfef84004c79b4de, - 0xbfef881179df3c35, 0x3cf60b679ab8cd3b, 0xbff0000000000000, 0x3fee952ca6abda83, 0xbfc3aa70079d955e, 0xbfeffcb85b826be2, 0xbd03dfe9cf7253a2, 0xbff0000000000000, - 0x3fefac1c2b8aca4d, 0x3fefb19aee8f23f2, 0xbfef7256bff69eaa, 0xbcd1c2b1d543580a, 0x3ff0000000000000, 0xbfcd8f62b209e496, 0x3fe733fc0cc60000, 0xbfeef16107a4572a, - 0x3d172a6d7b781bef, 0xbff0000000000000, 0x3fe08d3fa6f0021e, 0xbfe7f9dc78830c89, 0xbfea21824a00fc5d, 0x3d108b687775b320, 0x3ff0000000000000, 0x3fe363853d00c597, - 0xbfcca71b656d0d46, 0xbfe8be8bbf276711, 0xbd172dfeefbdfb70, 0xbff0000000000000, 0x3fec6a10c1c7d6b1, 0x3fefeda6bb72f8c4, 0xbfe3db7159e2f695, 0xbd0cb46a4ab20e3f, - 0x3ff0000000000000, 0x3feffab3d8ab843a, 0xbfd686442e3e672f, 0xbfdc1e85c60822a8, 0x3d2d3cca5285f698, 0xbff0000000000000, 0xbfe68e86897d86bc, 0xbfeffc043f9421c0, - 0xbfd3a326d1c3cf91, 0xbd14f93a295b6fef, 0xbff0000000000000, 0xbfee18fdab171543, 0x3fd45e58716cd55a, 0xbfb8e03da0c4e666, 0x3d29ed47d084c231, 0x3ff0000000000000, - 0xbfefdabbffe1000b, 0x3fea1b73513475fa, 0x3fbdf01cb30636ce, 0xbcea8d34a48c3a73, 0xbff0000000000000, 0x3fd1bd49fd9c50a1, 0x3fd4ec17290ea1e1, 0x3fc80388279e6ea4, - 0x3d14f4f2043aca22, 0x3ff0000000000000, 0xbfe1d781421b3058, 0xbfd712319b43f87d, 0x3fe09fea8995cfbc, 0x3d0cabda0070c2a5, 0xbff0000000000000, 0xbfe2265b98838e3a, - 0x3fcff670a9ba0ab0, 0x3fe2892e69e66547, 0x3d234e42cc825961, 0x3ff0000000000000, 0xbfc30fa8dab692af, 0x3fefe84d22c17c1c, 0x3fe61090516d9823, 0xbd246b249ab1552f, - 0x3ff0000000000000, 0xbfebada9ca1f6dda, 0x3feb5cd82cfa7249, 0x3fe7aa1022fac760, 0xbd108fb09c9658ed, 0xbff0000000000000, 0xbfedf81450c3d424, 0xbfdb470e3d562c7f, - 0x3fee7b11fa4c6874, 0x3cd17e2f8338fb35, 0xbff0000000000000, 0xbfd4a881479c33e8, 0xbfc28248f25987d3, 0x3fefc562042cb1ac, 0x3d12bf768cfd7854, 0xbff0000000000000, - 0x3fec3db64af224c9, 0xbfef76af9d2f9658, 0x3feee6e606d64fff, 0xbd2e59ac20b4f266, 0xbff0000000000000, 0x3fbcf13b012cf2c7, 0xbfecfb54e56ce174, 0x3fee3aa8eba29a09, - 0xbd22365fd44ec9ae, 0x3ff0000000000000, 0x3fe317522b8eb58a, 0x3fbbf04d68ee66a0, 0x3fec6c9654f886a9, 0x3d0840e311f61f09, 0x3ff0000000000000, 0x3fc916cc12ea7353, - 0x3fed72bf88d153be, 0x3fe8a4a40903c908, 0xbd2585e2564ffe16, 0xbff0000000000000, 0x3feae1109e04df38, 0x3fe0a8df7a7b1416, 0x3fe71f1dd2f357ff, 0xbd12c52c13d3aabb, - 0x3ff0000000000000, 0xbfe4495359816e28, 0xbfe1a02ef3727ccc, 0x3fdbd54196c5b536, 0xbd19643117d6138b, 0xbff0000000000000, 0xbfecec1cda9f333d, 0x3feea87a0a595c64, - 0x3fcdd9df3365cce6, 0x3d27b7cc59477063, 0x3ff0000000000000, 0xbfeffffff4575ea5, 0xbf611289d7a9b5db, 0x3f9556c81450dc26, 0xbcfef2760c30aba7, 0xbff0000000000000, - 0xbfeced92ba281bb3, 0xbfee9e9fdbc1ff8d, 0xbfc8a37c42ef0549, 0xbd2f7469dc539b4d, 0x3ff0000000000000, 0xbfb0c07d916f1ad7, 0xbfe37d30c964fea9, 0xbfd0c6750a02b9de, - 0xbd23511d8fed7295, 0xbff0000000000000, 0xbfdf19d73784b692, 0x3fedecb0bab73482, 0xbfdd8a261ea2f692, 0x3d2118c755450793, 0x3ff0000000000000, 0xbfcf0f40f7a53449, - 0x3fe462470a98b7a0, 0xbfe2aa5306481984, 0xbd26a0a011eea6fc, 0x3ff0000000000000, 0xbfea04bcf62fb0bc, 0x3fb1c26e55fdd894, 0xbfe4798e6065b0b3, 0xbd14faa78b10fc89, - 0xbff0000000000000, 0x3fe314948db94ddd, 0xbfbae0b6bb8cde28, 0xbfebc977e6964a96, 0xbd1b99ac8f136558, 0x3ff0000000000000, 0xbfda58fdec7bd106, 0xbfec89f075e39fb9, - 0xbfeffe9ec3579e10, 0x3d0ca8ff3d05a971, 0xbff0000000000000, 0x3fed8c81c297d4d4, 0xbfe6e862512d6024, 0xbfefc06b2668bf4c, 0x3d2f70d8680dbbcc, 0xbff0000000000000, - 0x3f9217cad0b8c45f, 0xbfc67ff57e8e2937, 0xbfef62db74569927, 0xbd246bdb4b8c1b7c, 0x3ff0000000000000, 0x3fe574bbe1ac632a, 0x3fec00cba8f0add3, 0xbfee2d33da734b79, - 0x3cfed5ea6a01afa4, 0x3ff0000000000000, 0x3fef2d6efa1f627b, 0xbfe87218b10b5208, 0xbfe55d13db051020, 0x3d28d1d3640b52fd, 0xbff0000000000000, 0x3fef43d52c97dfc6, - 0x3fead3339e63378f, 0xbfdf9a7974cef390, 0x3d3e9ddc249ee693, 0x3ff0000000000000, 0xbfefda688990a945, 0xbfea2f2314657fd1, 0xbfc440c2017d7a47, 0xbd084f28e30d9d0b, - 0xbff0000000000000, 0x3fdd1aef026cafcb, 0xbfefffafefd19019, 0xbfb6575413fff6c9, 0x3d083e084e8b05d6, 0x3ff0000000000000, 0xbfee1a26641236d4, 0xbfd41d8fbb6310af, - 0x3fac79abaa9c7b7a, 0x3d2e561aac6f12e5, 0x3ff0000000000000, 0xbfe690f26bd072e4, 0x3feffd0299235712, 0x3fd1150465f07ffd, 0xbd3ea000372f3979, 0xbff0000000000000, - 0xbfe81ef2cf53896c, 0xbfe8cd855c477457, 0x3fe0e54f5d66f889, 0xbd19659e798ba024, 0xbff0000000000000, 0x3feffff98bb3443c, 0x3fdd0472b6b4d936, 0xbfed79f508e080c1, -] )) ), - -################ chunk 18432 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x7f76c8e5ca239029, 0x40b0000000000001, 0x40affffffffffffe, 0x40b0000000000002, 0x40affffffffffffc, 0x40c0000000000001, 0x40bffffffffffffe, 0x40c0000000000002, - 0x40bffffffffffffc, 0x40d0000000000001, 0x40cffffffffffffe, 0x40d0000000000002, 0x40cffffffffffffc, 0x40e0000000000001, 0x40dffffffffffffe, 0x40e0000000000002, - 0x40dffffffffffffc, 0x40f0000000000001, 0x40effffffffffffe, 0x40f0000000000002, 0x40effffffffffffc, 0x4100000000000001, 0x40fffffffffffffe, 0x4100000000000002, - 0x40fffffffffffffc, 0x4110000000000001, 0x410ffffffffffffe, 0x4110000000000002, 0x410ffffffffffffc, 0x4120000000000001, 0x411ffffffffffffe, 0x4120000000000002, - 0x411ffffffffffffc, 0x4130000000000001, 0x412ffffffffffffe, 0x4130000000000002, 0x412ffffffffffffc, 0x4144bd24ea0af22d, 0x4179ec6e248daeb8, 0x41b033c4d6d88d33, - 0x413594458ff7aee3, 0x416af956f3f59a9c, 0x419086a2783956a1, 0x4175f58baee1093f, 0x40a88b2f6c200000, 0x40a8d54d48547b05, 0x40b88b2f6c200000, 0x40b8d54d48547b05, - 0x40c2686391180000, 0x40c29ff9f63f5c44, 0x40c88b2f6c200000, 0x40c8d54d48547b05, 0x40ceadfb47280000, 0x40cf0aa09a6999c6, 0x40d2686391180000, 0x40d29ff9f63f5c44, - 0x40d579c97e9c0000, 0x40d5baa39f49eba4, 0x40d88b2f6c200000, 0x40d8d54d48547b05, 0x40db9c9559a40000, 0x40dbeff6f15f0a66, 0x40deadfb47280000, 0x40df0aa09a6999c6, - 0x40e0dfb09a560000, 0x40e112a521ba1493, 0x40e2686391180000, 0x40e29ff9f63f5c44, 0x40e3f11687da0000, 0x40e42d4ecac4a3f4, 0x40e579c97e9c0000, 0x40e5baa39f49eba4, - 0x40e7027c755e0000, 0x40e747f873cf3355, 0x40e88b2f6c200000, 0x40e8d54d48547b05, 0x40ea13e262e20000, 0x40ea62a21cd9c2b5, 0x40eb9c9559a40000, 0x40ebeff6f15f0a66, - 0x40ed254850660000, 0x40ed7d4bc5e45216, 0x40eeadfb47280000, 0x40ef0aa09a6999c6, 0x40f01b571ef50000, 0x40f04bfab77770bb, 0x40f0dfb09a560000, 0x40f112a521ba1493, - 0x40f1a40a15b70000, 0x40f1d94f8bfcb86c, 0x40f2686391180000, 0x40f29ff9f63f5c44, 0x40f32cbd0c790000, 0x40f366a46082001c, 0x40f3f11687da0000, 0x40f42d4ecac4a3f4, - 0x40f4b570033b0000, 0x40f4f3f9350747cc, 0x40f579c97e9c0000, 0x40f5baa39f49eba4, 0x40f63e22f9fd0000, 0x40f6814e098c8f7d, 0x40f7027c755e0000, 0x40f747f873cf3355, - 0x40f7c6d5f0bf0000, 0x40f80ea2de11d72d, 0x40f88b2f6c200000, 0x40f8d54d48547b05, 0x40f94f88e7810000, 0x40f99bf7b2971edd, 0x40fa13e262e20000, 0x40fa62a21cd9c2b5, - 0x40fad83bde430000, 0x40fb294c871c668d, 0x40fb9c9559a40000, 0x40fbeff6f15f0a66, 0x40fc60eed5050000, 0x40fcb6a15ba1ae3e, 0x40fd254850660000, 0x40fd7d4bc5e45216, - 0x40fde9a1cbc70000, 0x40fe43f63026f5ee, 0x40feadfb47280000, 0x40ff0aa09a6999c6, 0x40ff7254c2890000, 0x40ffd14b04ac3d9e, 0x41001b571ef50000, 0x41004bfab77770bb, - 0x41007d83dca58000, 0x4100af4fec98c2a7, 0x4100dfb09a560000, 0x410112a521ba1493, 0x410141dd58068000, 0x410175fa56db6680, 0x4101a40a15b70000, 0x4101d94f8bfcb86c, - 0x41020636d3678000, 0x41023ca4c11e0a58, 0x4102686391180000, 0x41029ff9f63f5c44, 0x4102ca904ec88000, 0x4103034f2b60ae30, 0x41032cbd0c790000, 0x410366a46082001c, - 0x41038ee9ca298000, 0x4103c9f995a35208, 0x4103f11687da0000, 0x41042d4ecac4a3f4, 0x41045343458a8000, 0x410490a3ffe5f5e0, 0x4104b570033b0000, 0x4104f3f9350747cc, - 0x4105179cc0eb8000, 0x4105574e6a2899b8, 0x410579c97e9c0000, 0x4105baa39f49eba4, 0x4105dbf63c4c8000, 0x41061df8d46b3d90, 0x41063e22f9fd0000, 0x4106814e098c8f7d, - 0x4106a04fb7ad8000, 0x4106e4a33eade169, 0x4107027c755e0000, 0x410747f873cf3355, 0x410764a9330e8000, 0x4107ab4da8f08541, 0x4107c6d5f0bf0000, 0x41080ea2de11d72d, - 0x41082902ae6f8000, 0x410871f813332919, 0x41088b2f6c200000, 0x4108d54d48547b05, 0x4108ed5c29d08000, 0x410938a27d75ccf1, 0x41094f88e7810000, 0x41099bf7b2971edd, - 0x4109b1b5a5318000, 0x4109ff4ce7b870c9, 0x410a13e262e20000, 0x410a62a21cd9c2b5, 0x410a760f20928000, 0x410ac5f751fb14a1, 0x410ad83bde430000, 0x410b294c871c668d, - 0x410b3a689bf38000, 0x410b8ca1bc3db87a, 0x410b9c9559a40000, 0x410beff6f15f0a66, 0x410bfec217548000, 0x410c534c26805c52, 0x410c60eed5050000, 0x410cb6a15ba1ae3e, - 0x410cc31b92b58000, 0x410d19f690c3002a, 0x410d254850660000, 0x410d7d4bc5e45216, 0x410d87750e168000, 0x410de0a0fb05a402, 0x410de9a1cbc70000, 0x410e43f63026f5ee, - 0x410e4bce89778000, 0x410ea74b654847da, 0x410eadfb47280000, 0x410f0aa09a6999c6, 0x410f102804d88000, 0x410f6df5cf8aebb2, 0x410f7254c2890000, 0x410fd14b04ac3d9e, - 0x410fd48180398000, 0x41101a501ce6c7c5, 0x41101b571ef50000, 0x41104bfab77770bb, 0x41104c6d7dcd4000, 0x41107da5520819b1, 0x41107d83dca58000, 0x4110af4fec98c2a7, - 0x4110ae9a3b7dc000, 0x4110e0fa87296b9d, 0x4110dfb09a560000, 0x411112a521ba1493, 0x411110c6f92e4000, 0x4111444fbc4abd89, 0x411141dd58068000, 0x411175fa56db6680, - 0x411172f3b6dec000, 0x4111a7a4f16c0f76, 0x4111a40a15b70000, 0x4111d94f8bfcb86c, 0x4111d520748f4000, 0x41120afa268d6162, 0x41120636d3678000, 0x41123ca4c11e0a58, - 0x4112374d323fc000, 0x41126e4f5baeb34e, 0x4112686391180000, 0x41129ff9f63f5c44, 0x41129979eff04000, 0x4112d1a490d0053a, 0x4112ca904ec88000, 0x4113034f2b60ae30, - 0x4112fba6ada0c000, 0x411334f9c5f15726, 0x41132cbd0c790000, 0x411366a46082001c, 0x41135dd36b514000, 0x4113984efb12a912, 0x41138ee9ca298000, 0x4113c9f995a35208, - 0x4113c0002901c000, 0x4113fba43033fafe, 0x4113f11687da0000, 0x41142d4ecac4a3f4, 0x4114222ce6b24000, 0x41145ef965554cea, 0x41145343458a8000, 0x411490a3ffe5f5e0, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3feffef7ac4de5a8, 0xbfe3074ea2334853, 0xbfe3074ea2337bc8, 0xbfe3074ea2332e99, 0xbfe3074ea2339582, 0xbfee98f87098b627, 0xbfee98f87098dba1, 0xbfee98f87098a369, - 0xbfee98f87098ee5e, 0xbfe1eb0412baba0b, 0xbfe1eb0412b9e5f0, 0xbfe1eb0412bb2418, 0xbfe1eb0412b97be2, 0x3fedb0ffc3ed265d, 0x3fedb0ffc3ec676b, 0x3fedb0ffc3ed85d5, - 0x3fedb0ffc3ec07f2, 0x3fe62566735a137f, 0x3fe62566735cf6a8, 0x3fe625667358a1eb, 0x3fe62566735e683c, 0xbfeff8bd7b10ab96, 0xbfeff8bd7b1101ca, 0xbfeff8bd7b10807c, - 0xbfeff8bd7b112ce3, 0xbfb58809c60dffa8, 0xbfb58809c58e73c3, 0xbfb58809c64dc59a, 0xbfb58809c54eadd1, 0x3fc57481ecd01616, 0x3fc57481ec51e5b0, 0x3fc57481ed0f2e49, - 0x3fc57481ec12cd7d, 0x3fd526ccb338edb1, 0x3fd526ccb2c01efa, 0x3fd526ccb375550c, 0x3fd526ccb283b79f, 0xbfb087b112a0b303, 0xbfe3449254ac655f, 0xbfc6b5890f176ab6, - 0x3fde7e3de6d6080a, 0xbfeef994dd12e39b, 0x3fa88b66094d5bf6, 0xbfa20548049c4960, 0xbf00aa5026c7b66e, 0xbfe321a18722a2b7, 0xbf10aa5026a38d79, 0xbfeeabebd6f4c8a7, - 0xbf18ff78399aedd0, 0xbfee0aa1d4bd2106, 0xbf20aa502612e9a4, 0xbfe17dc30bd17dec, 0xbf24d4e42f100a76, 0x3faffd92e4e6cd85, 0xbf28ff7837b2c4e3, 0x3fe4b25c7e2046a3, - 0xbf2d2a0c3fe90471, 0x3fef2e86e74f02a4, 0xbf30aa5023d05a52, 0x3fed4b4a3a906fe3, 0xbf32bf9a2763e082, 0x3fdf90ca281869d3, 0xbf34d4e42aa60a8a, 0xbfbfed9287cc9793, - 0xbf36ea2e2d8dce2e, 0xbfe62e630e53386f, 0xbf38ff783012212f, 0xbfef91f05ddb4f8c, 0xbf3b14c23229f952, 0xbfec6ea472e59ddd, 0xbf3d2a0c33cc4c57, 0xbfdc067a51ce2dc9, - 0xbf3f3f5634f01004, 0x3fc7de35726f2c1c, 0xbf40aa501ac61d0c, 0x3fe794390bb3bd43, 0xbf41b4f51acbe02d, 0x3fefd5c4c756a9f5, 0xbf42bf9a1a84cc45, 0x3feb758d3944d6c1, - 0xbf43ca3f19ec5c36, 0x3fd860213df54e5f, 0xbf44d4e418fe0ae1, 0xbfcfadc11134baa4, 0xbf45df8917b55327, 0xbfe8e2787cff870c, 0xbf46ea2e160dafea, 0xbfeff9c048a79dc1, - 0xbf47f4d314029c0c, 0xbfea60fdbd7590a0, 0xbf48ff78118f926e, 0xbfd4a165a1bb093f, 0xbf4a0a1d0eb00df1, 0x3fd3aecde7ba01e6, 0xbf4b14c20b5f8977, 0x3fea17d301d0ee8f, - 0xbf4c1f6707997fe1, 0x3feffdbee2c0d304, 0xbf4d2a0c03596c11, 0x3fe9320aaa35a175, 0xbf4e34b0fe9ac8e7, 0x3fd0ce06973e1af2, 0xbf4f3f55f9591147, 0xbfd7730a883b0b39, - 0xbf5024fd79c7e008, 0xbfeb33132124fca6, 0xbf50aa4ff69d2813, 0xbfefe1bc96a37c30, 0xbf512fa2732a1e34, 0xbfe7e9e31077dc9b, 0xbf51b4f4ef6c7fdc, 0xbfc9d3afbc20d7f7, - 0xbf523a476b620a7d, 0x3fdb1fd1ce732fa2, 0xbf52bf99e7087b86, 0x3fec331d7ef046e7, 0xbf5344ec625d9069, 0x3fefa5d5695e8baf, 0xbf53ca3edd5f0697, 0x3fe689cf382e2760, - 0xbf544f91580a9b7f, 0x3fc1f17c0e4d0ded, 0xbf54d4e3d25e0c94, 0xbfdeb1769657753b, 0xbf555a364c571745, 0xbfed16f1f7986c48, 0xbf55df88c5f37904, 0xbfef4a454806908c, - 0xbf5664db3f30ef42, 0xbfe5132f57e44a87, 0xbf56ea2db80d376e, 0xbfb3faaa3f24538a, 0xbf576f8030860efb, 0x3fe112337087d50e, 0xbf57f4d2a8993358, 0x3fedddaca02cc58e, - 0xbf587a25204461f7, 0x3feecf67cbc4d168, 0xbf58ff7797855849, 0x3fe3877a346d1123, 0xbf5984ca0e59d3be, 0x3f8ff2fdfaef93a5, 0xbf5a0a1c84bf91c7, 0xbfe2ba97b3a8b9b6, - 0xbf5a8f6efab44fd5, 0xbfee8686aa70ba37, 0xbf5b14c17035cb59, 0xbfee35b7de304397, 0xbf5b9a13e541c1c4, 0xbfe1e83ba9e7d389, 0xbf5c1f6659d5f087, 0x3fa803d30a2091ef, - 0xbf5ca4b8cdf01513, 0x3fe4503f8671d78a, 0xbf5d2a0b418decd8, 0x3fef10d72bb33942, 0xbf5daf5db4ad3547, 0x3fed7dcf3e5dc3b4, 0xbf5e34b0274babd2, 0x3fe037131fd4a25c, - 0xbf5eba0299670de9, 0xbfbbf62fb0d489e6, 0xbf5f3f550afd18fd, 0xbfe5d19519105d79, 0xbf5fc4a77c0b8a7f, 0xbfef7c13c5cfc9c4, 0xbf6024fcf6480ff0, 0xbfeca865e7100857, - 0xbf6067a62e444b49, 0xbfdceb63d2d3eed2, 0xbf60aa4f65f95602, 0x3fc5e73e75b22239, 0xbf60ecf89d660ed5, 0x3fe73d16effb6a26, 0xbf612fa1d4895479, 0x3fefc7d1319bc339, - 0xbf61724b0b6205a6, 0x3febb65156a4aea3, 0xbf61b4f441ef0117, 0x3fd94bb3285c2984, 0xbf61f79d782f2582, 0xbfcdbd7babc426bf, 0xbf623a46ae2151a1, 0xbfe89159658387ef, - 0xbf627cefe3c4642c, 0xbfeff3c3aa32cd8d, 0xbf62bf9919173bdb, 0xbfeaa883b98d069a, 0xbf6302424e18b768, 0xbfd592b44c6719be, 0xbf6344eb82c7b58a, 0x3fd2bafc3bcacc25, - 0xbf638794b72314fb, 0x3fe9cd0815a60a66, 0xbf63ca3deb29b472, 0x3fefffbf38c7f501, 0xbf640ce71eda72a9, 0x3fe9800af7faaf01, 0xbf644f9052342e57, 0x3fd1c4209bb39398, - 0xbf6492398535c636, 0xbfd6847dccd17af3, 0xbf64d4e2b7de18fe, 0xbfeaeee732993128, 0xbf65178bea2c0567, 0xbfefebb7e09dc7fd, 0xbf655a351c1e6a2b, 0xbfe83e0fa7eaf942, - 0xbf659cde4db42601, 0xbfcbc78e14180948, 0xbf65df877eec17a2, 0x3fda3778a7cae7bf, 0xbf662230afc51dc8, 0x3febf5d4c0aa49a1, 0xbf6664d9e03e172a, 0x3fefb7c1ab05e219, - 0xbf66a7831055e281, 0x3fe6e3d3e46b78f2, 0xbf66ea2c400b5e86, 0x3fc3eb10a5a9f38b, 0xbf672cd56f5d69f1, 0xbfddd03974822827, 0xbf676f7e9e4ae37c, 0xbfece0c9b85c9397, - 0xbf67b227ccd2a9de, 0xbfef64109356b6de, 0xbf67f4d0faf39bd0, 0xbfe572b20b672581, 0xbf68377a28ac980b, 0xbfb7f54c601c957f, 0xbf687a2355fc7d48, 0x3fe0a5938bac62b8, - 0xbf68bccc82e22a40, 0x3fedaedb0d96568b, 0xbf68ff75af5c7daa, 0x3feef0f852e56309, 0xbf69421edb6a5640, 0x3fe3ec1b630ee38b, 0xbf6984c8070a92ba, 0x3f9ff1ff2ea931ff, - 0xbf69c771323c11d1, 0xbfe25263257a276a, 0xbf6a0a1a5cfdb23e, 0xbfee5f3a9aae23fd, 0xbf6a4cc3874e52b9, 0xbfee5eec0d4bedd1, 0xbf6a8f6cb12cd1fc, 0xbfe25196a891821c, - 0xbf6ad215da980ebe, 0x3fa00894243d1412, 0xbf6b14bf038ee7b9, 0x3fe3ecde8dc40c2d, 0xbf6b57682c103ba6, 0x3feef137eeb3f1a8, 0xbf6b9a11541ae93c, 0x3fedae7ddd359960, -] )) ), - -################ chunk 18944 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x41148459a462c000, 0x4114c24e9a769ed6, 0x4114b570033b0000, 0x4114f3f9350747cc, 0x4114e68662134000, 0x411525a3cf97f0c2, 0x4115179cc0eb8000, 0x4115574e6a2899b8, - 0x411548b31fc3c000, 0x411588f904b942ae, 0x411579c97e9c0000, 0x4115baa39f49eba4, 0x4115aadfdd744000, 0x4115ec4e39da949a, 0x4115dbf63c4c8000, 0x41161df8d46b3d90, - 0x41160d0c9b24c000, 0x41164fa36efbe687, 0x41163e22f9fd0000, 0x4116814e098c8f7d, 0x41166f3958d54000, 0x4116b2f8a41d3873, 0x4116a04fb7ad8000, 0x4116e4a33eade169, - 0x4116d1661685c000, 0x4117164dd93e8a5f, 0x4117027c755e0000, 0x411747f873cf3355, 0x41173392d4364000, 0x411779a30e5fdc4b, 0x411764a9330e8000, 0x4117ab4da8f08541, - 0x411795bf91e6c000, 0x4117dcf843812e37, 0x4117c6d5f0bf0000, 0x41180ea2de11d72d, 0x4117f7ec4f974000, 0x4118404d78a28023, 0x41182902ae6f8000, 0x411871f813332919, - 0x41185a190d47c000, 0x4118a3a2adc3d20f, 0x41188b2f6c200000, 0x4118d54d48547b05, 0x4118bc45caf84000, 0x411906f7e2e523fb, 0x4118ed5c29d08000, 0x411938a27d75ccf1, - 0x41191e7288a8c000, 0x41196a4d180675e7, 0x41194f88e7810000, 0x41199bf7b2971edd, 0x4119809f46594000, 0x4119cda24d27c7d3, 0x4119b1b5a5318000, 0x4119ff4ce7b870c9, - 0x4119e2cc0409c000, 0x411a30f7824919bf, 0x411a13e262e20000, 0x411a62a21cd9c2b5, 0x411a44f8c1ba4000, 0x411a944cb76a6bab, 0x411a760f20928000, 0x411ac5f751fb14a1, - 0x411aa7257f6ac000, 0x411af7a1ec8bbd97, 0x411ad83bde430000, 0x411b294c871c668d, 0x411b09523d1b4000, 0x411b5af721ad0f84, 0x411b3a689bf38000, 0x411b8ca1bc3db87a, - 0x411b6b7efacbc000, 0x411bbe4c56ce6170, 0x411b9c9559a40000, 0x411beff6f15f0a66, 0x411bcdabb87c4000, 0x411c21a18befb35c, 0x411bfec217548000, 0x411c534c26805c52, - 0x411c2fd8762cc000, 0x411c84f6c1110548, 0x411c60eed5050000, 0x411cb6a15ba1ae3e, 0x411c920533dd4000, 0x411ce84bf6325734, 0x411cc31b92b58000, 0x411d19f690c3002a, - 0x411cf431f18dc000, 0x411d4ba12b53a920, 0x411d254850660000, 0x411d7d4bc5e45216, 0x411d565eaf3e4000, 0x411daef66074fb0c, 0x411d87750e168000, 0x411de0a0fb05a402, - 0x411db88b6ceec000, 0x411e124b95964cf8, 0x411de9a1cbc70000, 0x411e43f63026f5ee, 0x411e1ab82a9f4000, 0x411e75a0cab79ee4, 0x411e4bce89778000, 0x411ea74b654847da, - 0x411e7ce4e84fc000, 0x411ed8f5ffd8f0d0, 0x411eadfb47280000, 0x411f0aa09a6999c6, 0x411edf11a6004000, 0x411f3c4b34fa42bc, 0x411f102804d88000, 0x411f6df5cf8aebb2, - 0x411f413e63b0c000, 0x411f9fa06a1b94a8, 0x411f7254c2890000, 0x411fd14b04ac3d9e, 0x411fa36b21614000, 0x4120017acf9e734a, 0x411fd48180398000, 0x41201a501ce6c7c5, - 0x412002cbef88e000, 0x412033256a2f1c40, 0x41201b571ef50000, 0x41204bfab77770bb, 0x412033e24e612000, 0x412064d004bfc536, 0x41204c6d7dcd4000, 0x41207da5520819b1, - 0x412064f8ad396000, 0x4120967a9f506e2c, 0x41207d83dca58000, 0x4120af4fec98c2a7, 0x4120960f0c11a000, 0x4120c82539e11722, 0x4120ae9a3b7dc000, 0x4120e0fa87296b9d, - 0x4120c7256ae9e000, 0x4120f9cfd471c018, 0x4120dfb09a560000, 0x412112a521ba1493, 0x4120f83bc9c22000, 0x41212b7a6f02690e, 0x412110c6f92e4000, 0x4121444fbc4abd89, - 0x41212952289a6000, 0x41215d2509931205, 0x412141dd58068000, 0x412175fa56db6680, 0x41215a688772a000, 0x41218ecfa423bafb, 0x412172f3b6dec000, 0x4121a7a4f16c0f76, - 0x41218b7ee64ae000, 0x4121c07a3eb463f1, 0x4121a40a15b70000, 0x4121d94f8bfcb86c, 0x4121bc9545232000, 0x4121f224d9450ce7, 0x4121d520748f4000, 0x41220afa268d6162, - 0x4121edaba3fb6000, 0x412223cf73d5b5dd, 0x41220636d3678000, 0x41223ca4c11e0a58, 0x41221ec202d3a000, 0x4122557a0e665ed3, 0x4122374d323fc000, 0x41226e4f5baeb34e, - 0x41224fd861abe000, 0x41228724a8f707c9, 0x4122686391180000, 0x41229ff9f63f5c44, 0x412280eec0842000, 0x4122b8cf4387b0bf, 0x41229979eff04000, 0x4122d1a490d0053a, - 0x4122b2051f5c6000, 0x4122ea79de1859b5, 0x4122ca904ec88000, 0x4123034f2b60ae30, 0x4122e31b7e34a000, 0x41231c2478a902ab, 0x4122fba6ada0c000, 0x412334f9c5f15726, - 0x41231431dd0ce000, 0x41234dcf1339aba1, 0x41232cbd0c790000, 0x412366a46082001c, 0x412345483be52000, 0x41237f79adca5497, 0x41235dd36b514000, 0x4123984efb12a912, - 0x4123765e9abd6000, 0x4123b124485afd8d, 0x41238ee9ca298000, 0x4123c9f995a35208, 0x4123a774f995a000, 0x4123e2cee2eba683, 0x4123c0002901c000, 0x4123fba43033fafe, - 0x4123d88b586de000, 0x412414797d7c4f79, 0x4123f11687da0000, 0x41242d4ecac4a3f4, 0x412409a1b7462000, 0x41244624180cf86f, 0x4124222ce6b24000, 0x41245ef965554cea, - 0x41243ab8161e6000, 0x412477ceb29da165, 0x41245343458a8000, 0x412490a3ffe5f5e0, 0x41246bce74f6a000, 0x4124a9794d2e4a5b, 0x41248459a462c000, 0x4124c24e9a769ed6, - 0x41249ce4d3cee000, 0x4124db23e7bef351, 0x4124b570033b0000, 0x4124f3f9350747cc, 0x4124cdfb32a72000, 0x41250cce824f9c47, 0x4124e68662134000, 0x412525a3cf97f0c2, - 0x4124ff11917f6000, 0x41253e791ce0453d, 0x4125179cc0eb8000, 0x4125574e6a2899b8, 0x41253027f057a000, 0x41257023b770ee33, 0x412548b31fc3c000, 0x412588f904b942ae, - 0x4125613e4f2fe000, 0x4125a1ce52019729, 0x412579c97e9c0000, 0x4125baa39f49eba4, 0x41259254ae082000, 0x4125d378ec92401f, 0x4125aadfdd744000, 0x4125ec4e39da949a, - 0x4125c36b0ce06000, 0x412605238722e915, 0x4125dbf63c4c8000, 0x41261df8d46b3d90, 0x4125f4816bb8a000, 0x412636ce21b3920b, 0x41260d0c9b24c000, 0x41264fa36efbe687, - 0x41262597ca90e000, 0x41266878bc443b02, 0x41263e22f9fd0000, 0x4126814e098c8f7d, 0x412656ae29692000, 0x41269a2356d4e3f8, 0x41266f3958d54000, 0x4126b2f8a41d3873, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbf6bdcba7badcf36, 0x3fe0a4be892151d6, 0xbf6c1f63a2c7cc4b, 0xbfb7fd0edb85c75b, 0xbf6c620cc967bf34, 0xbfe5736b20aadf15, 0xbf6ca4b5ef8c86ab, 0xbfef6440fdef8a28, - 0xbf6ce75f15350167, 0xbfece05e4236dfdf, 0xbf6d2a083a600e23, 0xbfddce800e481bf1, 0xbf6d6cb15f0c8b95, 0x3fc3eeea1c5904dc, 0xbf6daf5a83395879, 0x3fe6e4822b1bd827, - 0xbf6df203a6e55385, 0x3fefb7e2b3f99ba2, 0xbf6e34acca0f5b74, 0x3febf55b70405d2d, 0xbf6e7755ecb64efd, 0x3fda35b19a1af12d, 0xbf6eb9ff0ed90cda, 0xbfcbcb5be9aaa638, - 0xbf6efca8307673c4, 0xbfe83eb271a4f72b, 0xbf6f3f51518d6273, 0xbfefebc966e03224, 0xbf6f81fa721cb7a1, 0xbfeaee6081476b25, 0xbf6fc4a392235205, 0xbfd682aaded7fd08, - 0xbf7003a658d0082d, 0x3fd1c5ffcee3acc7, 0xbf7024fae848e8ac, 0x3fe980a1a1ea1c7d, 0xbf70464f777bb9dc, 0x3fefffc12ad1131d, 0xbf7067a40667eb19, 0x3fe9cc748a2b03b4, - 0xbf7088f8950cebc0, 0x3fd2b91f40a3c7c9, 0xbf70aa4d236a2b2d, 0xbfd59489e89b9079, 0xbf70cba1b17f18be, 0xbfeaa90dacf91a18, 0xbf70ecf63f4b23cd, 0xbfeff3b606106567, - 0xbf710e4acccdbbb9, 0xbfe890b99376b6e1, 0xbf712f9f5a064fdc, 0xbfcdb9b1555fd96b, 0xbf7150f3e6f44f95, 0x3fd94d7d57d1d784, 0xbf71724873972a3e, 0x3febb6ce098e62c6, - 0xbf71939cffee4f36, 0x3fefc7b404f2d7c0, 0xbf71b4f18bf92dd7, 0x3fe73c6b7740fa80, 0xbf71d64617b73580, 0x3fc5e36789fce8a2, 0xbf71f79aa327d58c, 0xbfdced20cb26ab85, - 0xbf7218ef2e4a7d57, 0xbfeca8d4dcb5f214, 0xbf723a43b91e9c3f, 0xbfef7be72dd01c14, 0xbf725b9843a3a1a0, 0xbfe5d0dea537cb38, 0xbf727ceccdd8fcd6, 0xbfbbee705da110b8, - 0xbf729e4157be1d3f, 0x3fe037ea21d38a97, 0xbf72bf95e1527235, 0x3fed7e3007bdbfc0, 0xbf72e0ea6a956b17, 0x3fef109b54fa2443, 0xbf73023ef3867741, 0x3fe44f7ecdf86042, - 0xbf7323937c25060e, 0x3fa7f440eb96f569, 0xbf7344e8047086dd, 0xbfe1e90a5aaf885a, 0xbf73663c8c686909, 0xbfee360a1a792edd, 0xbf738791140c1bef, 0xbfee863bd0da25cf, - 0xbf73a8e59b5b0eeb, 0xbfe2b9cd775cc36c, 0xbf73ca3a2254b15a, 0x3f9018ab030224fe, 0xbf73eb8ea8f87299, 0x3fe3883fc534f7ff, 0xbf740ce32f45c205, 0x3feecfab28b247b1, - 0xbf742e37b53c0ef9, 0x3feddd530e99a93a, 0xbf744f8c3adac8d3, 0x3fe111607ab99b53, 0xbf7470e0c0215eef, 0xbfb4026f66fe8d6c, 0xbf749235450f40aa, 0xbfe513eb030b2456, - 0xbf74b389c9a3dd61, 0xbfef4a798235d6e9, 0xbf74d4de4ddea46f, 0xbfed168a07a184cf, 0xbf74f632d1bf0532, 0xbfdeafc0ddc4a9c9, 0xbf75178755446f07, 0x3fc1f557d27004ad, - 0xbf7538dbd86e5149, 0x3fe68a8041f32218, 0xbf755a305b3c1b56, 0x3fefa5fa4c8f3836, 0xbf757b84ddad3c8b, 0x3fec32a7989139d6, 0xbf759cd95fc12444, 0x3fdb1e0dfed0ea0e, - 0xbf75be2de17741dd, 0xbfc9d780d45bfc37, 0xbf75df8262cf04b4, 0xbfe7ea88c7c113bf, 0xbf7600d6e3c7dc24, 0xbfefe1d1fdeee748, 0xbf76222b6461378c, 0xbfeb328fba4ebaa3, - 0xbf76437fe49a8647, 0xbfd7713a6588fa3a, 0xbf7664d4647337b3, 0x3fd0cfe7e4a78768, 0xbf768628e3eabb2b, 0x3fe932a4693b45fd, 0xbf76a77d6300800d, 0x3feffdc4b8bd5560, - 0xbf76c8d1e1b3f5b5, 0x3fea17429df70b84, 0xbf76ea2660048b81, 0x3fd3acf34244ca16, 0xbf770b7addf1b0cc, 0xbfd4a33dcef73dd4, 0xbf772ccf5b7ad4f5, 0xbfea618aea6820c2, - 0xbf774e23d89f6756, 0xbfeff9b6877f0814, 0xbf776f78555ed74e, 0xbfe8e1dbac9df40f, 0xbf7790ccd1b89438, 0xbfcfa9fa76aa3031, 0xbf77b2214dac0d73, 0x3fd861ee728ac39a, - 0xbf77d375c938b259, 0x3feb760d46e24551, 0xbf77f4ca445df24a, 0x3fefd5ab78cb549e, 0xbf78161ebf1b3ca0, 0x3fe793906ba1890e, 0xbf783773397000b9, 0x3fc7da614f0522b7, - 0xbf7858c7b35badf2, 0xbfdc083ac078f0e8, 0xbf787a1c2cddb3a7, 0xbfec6f16e11c854f, 0xbf789b70a5f58136, 0xbfef91c79b3e24b3, 0xbf78bcc51ea285fb, 0xbfe62daf4740448c, - 0xbf78de1996e43153, 0xbfbfe5d6d83978af, 0xbf78ff6e0eb9f29b, 0x3fdf927c103ba608, 0xbf7920c28623392f, 0x3fed4bae96e6e52e, 0xbf794216fd1f746e, 0x3fef2e4ed9664afc, - 0xbf79636b73ae13b2, 0x3fe4b19e43e5f5c6, 0xbf7984bfe9ce865a, 0x3fafee042d2f68a3, 0xbf79a6145f803bc3, 0xbfe17e93e39674ed, 0xbf79c768d4c2a348, 0xbfee0af7baccbd15, - 0xbf79e8bd49952c48, 0xbfeeaba4b5d3e2c5, 0xbf7a0a11bdf7461e, 0xbfe320d9980d4dfd, 0xbf7a2b6631e86028, 0x3f1f2d0010d1c417, 0xbf7a4cbaa567e9c3, 0x3fe3226971ae523a, - 0xbf7a6e0f1875524c, 0x3feeac32f0cee034, 0xbf7a8f638b100920, 0x3fee0a4be78bf0a1, 0xbf7ab0b7fd377d9b, 0x3fe17cf22fe3eab6, 0xbf7ad20c6eeb1f1a, 0xbfb00690ca9b68f5, - 0xbf7af360e02a5cfb, 0xbfe4b31ab374686c, 0xbf7b14b550f4a69b, 0xbfef2ebeedd27917, 0xbf7b3609c1496b56, 0xbfed4ae5d7447aae, 0xbf7b575e31281a89, 0xbfdf8f18386d44f1, - 0xbf7b78b2a0902392, 0x3fbff54e2ffbda10, 0xbf7b9a070f80f5cd, 0x3fe62f16d027167e, 0xbf7bbb5b7dfa0098, 0x3fef921918fc0ada, 0xbf7bdcafebfab34f, 0x3fec6e31fdebe942, - 0xbf7bfe0459827d4f, 0x3fdc04b9dc6e9e63, 0xbf7c1f58c690cdf6, 0xbfc7e2099056a1af, 0xbf7c40ad332514a1, 0xbfe794e1a6346248, 0xbf7c62019f3ec0ac, 0xbfefd5de0e552c6b, - 0xbf7c83560add4175, 0xbfeb750d251d3885, 0xbf7ca4aa76000658, 0xbfd85e540380f3dd, 0xbf7cc5fee0a67eb4, 0x3fcfb187a4696f09, 0xbf7ce7534ad019e4, 0x3fe8e3154781036d, - 0xbf7d08a7b47c4746, 0x3feff9ca023a4b24, 0xbf7d29fc1daa7637, 0x3fea60708a4099ac, 0xbf7d4b50865a1614, 0x3fd49f8d6f999ec9, 0xbf7d6ca4ee8a963a, 0xbfd3b0a888839449, - 0xbf7d8df9563b6607, 0xbfea18635f79c75b, 0xbf7daf4dbd6bf4d7, 0xbfeffdb9052cfd42, 0xbf7dd0a2241bb208, 0xbfe93170e53578f8, 0xbf7df1f68a4a0cf7, 0xbfd0cc2545ef05d2, - 0xbf7e134aeff67500, 0x3fd774daa5465537, 0xbf7e349f55205982, 0x3feb33968180ac3f, 0xbf7e55f3b9c729d9, 0x3fefe1a727c86b6b, 0xbf7e77481dea5563, 0x3fe7e93d5389f925, -] )) ), - -################ chunk 19456 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x412687c488416000, 0x4126cbcdf1658cee, 0x4126a04fb7ad8000, 0x4126e4a33eade169, 0x4126b8dae719a000, 0x4126fd788bf635e4, 0x4126d1661685c000, 0x4127164dd93e8a5f, - 0x4126e9f145f1e000, 0x41272f232686deda, 0x4127027c755e0000, 0x412747f873cf3355, 0x41271b07a4ca2000, 0x412760cdc11787d0, 0x41273392d4364000, 0x412779a30e5fdc4b, - 0x41274c1e03a26000, 0x412792785ba830c6, 0x412764a9330e8000, 0x4127ab4da8f08541, 0x41277d34627aa000, 0x4127c422f638d9bc, 0x412795bf91e6c000, 0x4127dcf843812e37, - 0x4127ae4ac152e000, 0x4127f5cd90c982b2, 0x4127c6d5f0bf0000, 0x41280ea2de11d72d, 0x4127df61202b2000, 0x412827782b5a2ba8, 0x4127f7ec4f974000, 0x4128404d78a28023, - 0x412810777f036000, 0x41285922c5ead49e, 0x41282902ae6f8000, 0x412871f813332919, 0x4128418ddddba000, 0x41288acd607b7d94, 0x41285a190d47c000, 0x4128a3a2adc3d20f, - 0x412872a43cb3e000, 0x4128bc77fb0c268a, 0x41288b2f6c200000, 0x4128d54d48547b05, 0x4128a3ba9b8c2000, 0x4128ee22959ccf80, 0x4128bc45caf84000, 0x412906f7e2e523fb, - 0x4128d4d0fa646000, 0x41291fcd302d7876, 0x4128ed5c29d08000, 0x412938a27d75ccf1, 0x412905e7593ca000, 0x41295177cabe216c, 0x41291e7288a8c000, 0x41296a4d180675e7, - 0x412936fdb814e000, 0x41298322654eca62, 0x41294f88e7810000, 0x41299bf7b2971edd, 0x4129681416ed2000, 0x4129b4ccffdf7358, 0x4129809f46594000, 0x4129cda24d27c7d3, - 0x4129992a75c56000, 0x4129e6779a701c4e, 0x4129b1b5a5318000, 0x4129ff4ce7b870c9, 0x4129ca40d49da000, 0x412a18223500c544, 0x4129e2cc0409c000, 0x412a30f7824919bf, - 0x4129fb573375e000, 0x412a49cccf916e3a, 0x412a13e262e20000, 0x412a62a21cd9c2b5, 0x412a2c6d924e2000, 0x412a7b776a221730, 0x412a44f8c1ba4000, 0x412a944cb76a6bab, - 0x412a5d83f1266000, 0x412aad2204b2c026, 0x412a760f20928000, 0x412ac5f751fb14a1, 0x412a8e9a4ffea000, 0x412adecc9f43691c, 0x412aa7257f6ac000, 0x412af7a1ec8bbd97, - 0x412abfb0aed6e000, 0x412b107739d41212, 0x412ad83bde430000, 0x412b294c871c668d, 0x412af0c70daf2000, 0x412b4221d464bb09, 0x412b09523d1b4000, 0x412b5af721ad0f84, - 0x412b21dd6c876000, 0x412b73cc6ef563ff, 0x412b3a689bf38000, 0x412b8ca1bc3db87a, 0x412b52f3cb5fa000, 0x412ba57709860cf5, 0x412b6b7efacbc000, 0x412bbe4c56ce6170, - 0x412b840a2a37e000, 0x412bd721a416b5eb, 0x412b9c9559a40000, 0x412beff6f15f0a66, 0x412bb52089102000, 0x412c08cc3ea75ee1, 0x412bcdabb87c4000, 0x412c21a18befb35c, - 0x412be636e7e86000, 0x412c3a76d93807d7, 0x412bfec217548000, 0x412c534c26805c52, 0x412c174d46c0a000, 0x412c6c2173c8b0cd, 0x412c2fd8762cc000, 0x412c84f6c1110548, - 0x412c4863a598e000, 0x412c9dcc0e5959c3, 0x412c60eed5050000, 0x412cb6a15ba1ae3e, 0x412c797a04712000, 0x412ccf76a8ea02b9, 0x412c920533dd4000, 0x412ce84bf6325734, - 0x412caa9063496000, 0x412d0121437aabaf, 0x412cc31b92b58000, 0x412d19f690c3002a, 0x412cdba6c221a000, 0x412d32cbde0b54a5, 0x412cf431f18dc000, 0x412d4ba12b53a920, - 0x412d0cbd20f9e000, 0x412d6476789bfd9b, 0x412d254850660000, 0x412d7d4bc5e45216, 0x412d3dd37fd22000, 0x412d9621132ca691, 0x412d565eaf3e4000, 0x412daef66074fb0c, - 0x412d6ee9deaa6000, 0x412dc7cbadbd4f87, 0x412d87750e168000, 0x412de0a0fb05a402, 0x412da0003d82a000, 0x412df976484df87d, 0x412db88b6ceec000, 0x412e124b95964cf8, - 0x412dd1169c5ae000, 0x412e2b20e2dea173, 0x412de9a1cbc70000, 0x412e43f63026f5ee, 0x412e022cfb332000, 0x412e5ccb7d6f4a69, 0x412e1ab82a9f4000, 0x412e75a0cab79ee4, - 0x412e33435a0b6000, 0x412e8e7617fff35f, 0x412e4bce89778000, 0x412ea74b654847da, 0x412e6459b8e3a000, 0x412ec020b2909c55, 0x412e7ce4e84fc000, 0x412ed8f5ffd8f0d0, - 0x412e957017bbe000, 0x412ef1cb4d21454b, 0x412eadfb47280000, 0x412f0aa09a6999c6, 0x412ec68676942000, 0x412f2375e7b1ee41, 0x412edf11a6004000, 0x412f3c4b34fa42bc, - 0x412ef79cd56c6000, 0x412f552082429737, 0x412f102804d88000, 0x412f6df5cf8aebb2, 0x412f28b33444a000, 0x412f86cb1cd3402d, 0x412f413e63b0c000, 0x412f9fa06a1b94a8, - 0x412f59c9931ce000, 0x412fb875b763e923, 0x412f7254c2890000, 0x412fd14b04ac3d9e, 0x412f8adff1f52000, 0x412fea2051f49219, 0x412fa36b21614000, 0x4130017acf9e734a, - 0x412fbbf650cd6000, 0x41300de576429d88, 0x412fd48180398000, 0x41301a501ce6c7c5, 0x412fed0cafa5a000, 0x413026bac38af203, 0x413002cbef88e000, 0x413033256a2f1c40, - 0x41300f11873ef000, 0x41303f9010d3467e, 0x41301b571ef50000, 0x41304bfab77770bb, 0x4130279cb6ab1000, 0x413058655e1b9af9, 0x413033e24e612000, 0x413064d004bfc536, - 0x41304027e6173000, 0x4130713aab63ef74, 0x41304c6d7dcd4000, 0x41307da5520819b1, 0x413058b315835000, 0x41308a0ff8ac43ef, 0x413064f8ad396000, 0x4130967a9f506e2c, - 0x4130713e44ef7000, 0x4130a2e545f4986a, 0x41307d83dca58000, 0x4130af4fec98c2a7, 0x413089c9745b9000, 0x4130bbba933cece5, 0x4130960f0c11a000, 0x4130c82539e11722, - 0x4130a254a3c7b000, 0x4130d48fe0854160, 0x4130ae9a3b7dc000, 0x4130e0fa87296b9d, 0x4130badfd333d000, 0x4130ed652dcd95db, 0x4130c7256ae9e000, 0x4130f9cfd471c018, - 0x4130d36b029ff000, 0x4131063a7b15ea56, 0x4130dfb09a560000, 0x413112a521ba1493, 0x4130ebf6320c1000, 0x41311f0fc85e3ed1, 0x4130f83bc9c22000, 0x41312b7a6f02690e, - 0x4131048161783000, 0x413137e515a6934c, 0x413110c6f92e4000, 0x4131444fbc4abd89, 0x41311d0c90e45000, 0x413150ba62eee7c7, 0x41312952289a6000, 0x41315d2509931205, - 0x41313597c0507000, 0x4131698fb0373c42, 0x413141dd58068000, 0x413175fa56db6680, 0x41314e22efbc9000, 0x41318264fd7f90bd, 0x41315a688772a000, 0x41318ecfa423bafb, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbf7e989c81894b7c, 0x3fc9cfde9df3d832, 0xbf7eb9f0e4a37b82, 0xbfdb2195979009e5, 0xbf7edb45473854d2, 0xbfec33935e9a8a8a, 0xbf7efc99a94746c9, 0xbfefa5b07eac9789, - 0xbf7f1dee0acfc0c4, 0xbfe6891e2915c006, 0xbf7f3f426bd13222, 0xbfc1eda04607cc5d, 0xbf7f6096cc4b0a3e, 0x3fdeb32c4793bc39, 0xbf7f81eb2c3cb877, 0x3fed1759e0a4ed52, - 0xbf7fa33f8ba5ac29, 0x3fef4a11066c3a92, 0xbf7fc493ea8554b2, 0x3fe51273a7c34029, 0xbf7fe5e848db216f, 0x3fb3f2e512cc425a, 0xbf80039e535340de, 0xbfe113066249105d, - 0xbf80144881f3727d, 0xbfedde062aa9a8e7, 0xbf8024f2b04ddd41, 0xbfeecf246787c60a, 0xbf80359cde6238da, 0xbfe386b49f02da16, 0xbf8046470c303cf6, 0xbf8fb4a5e84617a0, - 0xbf8056f139b7a145, 0x3fe2bb61eb82fda9, 0xbf80679b66f81d73, 0x3fee86d17cc904a5, 0xbf80784593f16932, 0x3fee35659abc3b10, 0xbf8088efc0a33c2e, 0x3fe1e76cf4e056ca, - 0xbf809999ed0d4e16, 0xbfa8136522f76142, 0xbf80aa44192f569b, 0xbfe451003a195ab1, 0xbf80baee45090d69, 0xbfef1112fb0d3249, 0xbf80cb98709a2a30, 0xbfed7d6e6dfe4e0b, - 0xbf80dc429be2649e, 0xbfe0363c19f5d50e, 0xbf80ececc6e17462, 0x3fbbfdeefda514d2, 0xbf80fd96f197112c, 0x3fe5d24b87c1665f, 0xbf810e411c02f2a9, 0x3fef7c405656e916, - 0xbf811eeb4624d088, 0x3feca7f6ea9d4892, 0xbf812f956ffc6279, 0x3fdce9a6d3a476a2, 0xbf81403f99896029, 0xbfc5eb155c34d451, 0xbf8150e9c2cb8147, 0xbfe73dc2633234ac, - 0xbf816193ebc27d83, 0xbfefc7ee56ba2776, 0xbf81723e146e0c8b, 0xbfebb5d49d2795ca, 0xbf8182e83ccde60e, 0xbfd949e8f2e5e122, 0xbf81939264e1c1ba, 0x3fcdc145fb19de59, - 0xbf81a43c8ca9573f, 0x3fe891f931bbf698, 0xbf81b4e6b4245e4b, 0x3feff3d146c0b0c2, 0xbf81c590db528e8c, 0x3feaa7f9bfc926e0, 0xbf81d63b02339fb2, 0x3fd590deab051aa4, - 0xbf81e6e528c7496c, 0xbfd2bcd9328f52d2, 0xbf81f78f4f0d4367, 0xbfe9cd9b9b0681d7, 0xbf82083975054554, 0xbfefffbd3f26fa13, 0xbf8218e39aaf06e1, 0xbfe97f7447f96640, - 0xbf82298dc00a3fbc, 0xbfd1c241643ce496, 0xbf823a37e516a794, 0x3fd68650b5821b62, 0xbf824ae209d3f619, 0x3feaef6ddd829281, 0xbf825b8c2e41e2f9, 0x3fefeba652c8e245, - 0xbf826c36526025e2, 0x3fe83d6cd8759588, 0xbf827ce0762e7684, 0x3fcbc3c0380d2db7, 0xbf828d8a99ac8c8e, 0xbfda393faf33b9ac, 0xbf829e34bcda1faf, 0xbfebf64e0a6ddb94, - 0xbf82aededfb6e794, 0xbfefb7a09a8c80cf, 0xbf82bf8902429bee, 0xbfe6e3259857d15f, 0xbf82d033247cf46a, 0xbfc3e7372a8028f1, 0xbf82e0dd4665a8b8, 0x3fddd1f2d38cdb89, - 0xbf82f18767fc7087, 0x3fece13527a8100e, 0xbf83023189410386, 0x3fef63e0214b081b, 0xbf8312dbaa331963, 0x3fe571f8f10c8c67, 0xbf832385cad269cd, 0x3fb7ed89df0408d3, - 0xbf83342feb1eac73, 0xbfe0a6688a443ba4, 0xbf8344da0b179905, 0xbfedaf3836ebf6c2, 0xbf8355842abce730, 0xbfeef0b8afbf4870, 0xbf83662e4a0e4ea4, 0xbfe3eb58339f89eb, - 0xbf8376d8690b8711, 0xbf9fd2d60d43b2a0, 0xbf83878287b44824, 0x3fe2532f9e09d462, 0xbf83982ca608498c, 0x3fee5f8920db634f, 0xbf83a8d6c40742f9, 0x3fee5e9d78b4d36f, - 0xbf83b980e1b0ec1a, 0x3fe250ca275014ff, 0xbf83ca2aff04fc9d, 0xbfa01828ad57981a, 0xbf83dad51c032c32, 0xbfe3eda1b3bed580, 0xbf83eb7f38ab3287, 0xbfeef177832ae534, - 0xbf83fc2954fcc74b, 0xbfedae20a5c9d55d, 0xbf840cd370f7a22d, 0xbfe0a3e982a33b89, 0xbf841d7d8c9b7add, 0x3fb804d1513dc709, 0xbf842e27a7e80909, 0x3fe5742430d78d37, - 0xbf843ed1c2dd0460, 0x3fef64716115767a, 0xbf844f7bdd7a2492, 0x3fecdff2c5370e68, 0xbf846025f7bf214c, 0x3fddccc6a10998f2, 0xbf8470d011abb23f, 0xbfc3f2c38e2d9e6e, - 0xbf84817a2b3f8f19, 0xbfe6e5306c58002c, 0xbf849224447a6f89, 0xbfefb803b567a4db, 0xbf84a2ce5d5c0b3f, 0xbfebf4e21930325d, 0xbf84b37875e419e8, 0xbfda33ea86244159, - 0xbf84c4228e125335, 0x3fcbcf29b8c41cd1, 0xbf84d4cca5e66ed4, 0x3fe83f5535a36812, 0xbf84e576bd602475, 0x3fefebdae5901bd8, 0xbf84f620d47f2bc6, 0x3feaedd9c98d5fd1, - 0xbf8506caeb433c76, 0x3fd680d7eb781c0b, 0xbf85177501ac0e35, 0xbfd1c7defdeb7c55, 0xbf85281f17b958b1, 0xbfe9813845d13550, 0xbf8538c92d6ad39a, 0xbfefffc3154273e3, - 0xbf85497342c0369f, 0xbfe9cbe0f88c19a2, 0xbf855a1d57b9396f, 0xbfd2b74240fc1d76, 0xbf856ac76c5593b8, 0x3fd5965f7fc02fd0, 0xbf857b718094fd2a, 0x3feaa9979a161a30, - 0xbf858c1b94772d75, 0x3feff3a85a597c47, 0xbf859cc5a7fbdc46, 0x3fe89019bb931905, 0xbf85ad6fbb22c14e, 0x3fcdb5e6f81c8d00, 0xbf85be19cdeb943c, 0xbfd94f47814dd775, - 0xbf85cec3e0560cbd, 0xbfebb74ab5de9523, 0xbf85df6df261e283, 0xbfefc796d0bef3ff, 0xbf85f018040ecd3b, 0xbfe73bbff90b4ee1, 0xbf8600c2155c8495, 0xbfc5df9099064d07, - 0xbf86116c264ac041, 0x3fdceeddbc86dad4, 0xbf86221636d937ec, 0x3feca943cb90b2dd, 0xbf8632c04707a347, 0x3fef7bba8e5a106a, 0xbf86436a56d5ba01, 0x3fe5d0282c235eca, - 0xbf865414664333c8, 0x3fbbe6b103ad12f0, 0xbf8664be754fc84c, 0xbfe038c1200a7dd6, 0xbf86756883fb2f3d, 0xbfed7e90ca1e2b35, 0xbf86861292452048, 0xbfef105f76de2a0d, - 0xbf8696bca02d531f, 0xbfe44ebe10ad2294, 0xbf86a766adb37f6f, 0xbfa7e4aec65e84ef, 0xbf86b810bad75ce8, 0x3fe1e9d907374431, 0xbf86c8bac798a339, 0x3fee365c4f9c2f39, - 0xbf86d964d3f70a11, 0x3fee85f0f005592f, 0xbf86ea0edff24920, 0x3fe2b90336925108, 0xbf86fab8eb8a1815, 0xbf9037d704bab7c3, 0xbf870b62f6be2e9f, 0xbfe3890551670bf6, - 0xbf871c0d018e446e, 0xbfeecfee7e5018eb, 0xbf872cb70bfa1130, 0xbfeddcf975eaa982, 0xbf873d6116014c95, 0xbfe1108d80de953a, 0xbf874e0b1fa3ae4c, 0x3fb40a348979c782, - 0xbf875eb528e0ee05, 0x3fe514a6a92e9960, 0xbf876f5f31b8c36e, 0x3fef4aadb4f424c7, 0xbf8780093a2ae638, 0x3fed162210c54fa0, 0xbf8790b342370e10, 0x3fdeae0b1e0ce67e, -] )) ), - -################ chunk 19968 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x413166ae1f28b000, 0x41319b3a4ac7e538, 0x413172f3b6dec000, 0x4131a7a4f16c0f76, 0x41317f394e94d000, 0x4131b40f981039b3, 0x41318b7ee64ae000, 0x4131c07a3eb463f1, - 0x413197c47e00f000, 0x4131cce4e5588e2e, 0x4131a40a15b70000, 0x4131d94f8bfcb86c, 0x4131b04fad6d1000, 0x4131e5ba32a0e2a9, 0x4131bc9545232000, 0x4131f224d9450ce7, - 0x4131c8dadcd93000, 0x4131fe8f7fe93724, 0x4131d520748f4000, 0x41320afa268d6162, 0x4131e1660c455000, 0x41321764cd318b9f, 0x4131edaba3fb6000, 0x413223cf73d5b5dd, - 0x4131f9f13bb17000, 0x4132303a1a79e01a, 0x41320636d3678000, 0x41323ca4c11e0a58, 0x4132127c6b1d9000, 0x4132490f67c23495, 0x41321ec202d3a000, 0x4132557a0e665ed3, - 0x41322b079a89b000, 0x413261e4b50a8910, 0x4132374d323fc000, 0x41326e4f5baeb34e, 0x41324392c9f5d000, 0x41327aba0252dd8b, 0x41324fd861abe000, 0x41328724a8f707c9, - 0x41325c1df961f000, 0x4132938f4f9b3206, 0x4132686391180000, 0x41329ff9f63f5c44, 0x413274a928ce1000, 0x4132ac649ce38681, 0x413280eec0842000, 0x4132b8cf4387b0bf, - 0x41328d34583a3000, 0x4132c539ea2bdafc, 0x41329979eff04000, 0x4132d1a490d0053a, 0x4132a5bf87a65000, 0x4132de0f37742f77, 0x4132b2051f5c6000, 0x4132ea79de1859b5, - 0x4132be4ab7127000, 0x4132f6e484bc83f2, 0x4132ca904ec88000, 0x4133034f2b60ae30, 0x4132d6d5e67e9000, 0x41330fb9d204d86d, 0x4132e31b7e34a000, 0x41331c2478a902ab, - 0x4132ef6115eab000, 0x4133288f1f4d2ce8, 0x4132fba6ada0c000, 0x413334f9c5f15726, 0x413307ec4556d000, 0x413341646c958163, 0x41331431dd0ce000, 0x41334dcf1339aba1, - 0x4133207774c2f000, 0x41335a39b9ddd5de, 0x41332cbd0c790000, 0x413366a46082001c, 0x41333902a42f1000, 0x4133730f07262a59, 0x413345483be52000, 0x41337f79adca5497, - 0x4133518dd39b3000, 0x41338be4546e7ed4, 0x41335dd36b514000, 0x4133984efb12a912, 0x41336a1903075000, 0x4133a4b9a1b6d34f, 0x4133765e9abd6000, 0x4133b124485afd8d, - 0x413382a432737000, 0x4133bd8eeeff27ca, 0x41338ee9ca298000, 0x4133c9f995a35208, 0x41339b2f61df9000, 0x4133d6643c477c46, 0x4133a774f995a000, 0x4133e2cee2eba683, - 0x4133b3ba914bb000, 0x4133ef39898fd0c1, 0x4133c0002901c000, 0x4133fba43033fafe, 0x4133cc45c0b7d000, 0x4134080ed6d8253c, 0x4133d88b586de000, 0x413414797d7c4f79, - 0x4133e4d0f023f000, 0x413420e4242079b7, 0x4133f11687da0000, 0x41342d4ecac4a3f4, 0x4133fd5c1f901000, 0x413439b97168ce32, 0x413409a1b7462000, 0x41344624180cf86f, - 0x413415e74efc3000, 0x4134528ebeb122ad, 0x4134222ce6b24000, 0x41345ef965554cea, 0x41342e727e685000, 0x41346b640bf97728, 0x41343ab8161e6000, 0x413477ceb29da165, - 0x413446fdadd47000, 0x413484395941cba3, 0x41345343458a8000, 0x413490a3ffe5f5e0, 0x41345f88dd409000, 0x41349d0ea68a201e, 0x41346bce74f6a000, 0x4134a9794d2e4a5b, - 0x413478140cacb000, 0x4134b5e3f3d27499, 0x41348459a462c000, 0x4134c24e9a769ed6, 0x4134909f3c18d000, 0x4134ceb9411ac914, 0x41349ce4d3cee000, 0x4134db23e7bef351, - 0x4134a92a6b84f000, 0x4134e78e8e631d8f, 0x4134b570033b0000, 0x4134f3f9350747cc, 0x4134c1b59af11000, 0x41350063dbab720a, 0x4134cdfb32a72000, 0x41350cce824f9c47, - 0x4134da40ca5d3000, 0x4135193928f3c685, 0x4134e68662134000, 0x413525a3cf97f0c2, 0x4134f2cbf9c95000, 0x4135320e763c1b00, 0x4134ff11917f6000, 0x41353e791ce0453d, - 0x41350b5729357000, 0x41354ae3c3846f7b, 0x4135179cc0eb8000, 0x4135574e6a2899b8, 0x413523e258a19000, 0x413563b910ccc3f6, 0x41353027f057a000, 0x41357023b770ee33, - 0x41353c6d880db000, 0x41357c8e5e151871, 0x413548b31fc3c000, 0x413588f904b942ae, 0x413554f8b779d000, 0x41359563ab5d6cec, 0x4135613e4f2fe000, 0x4135a1ce52019729, - 0x41356d83e6e5f000, 0x4135ae38f8a5c167, 0x413579c97e9c0000, 0x4135baa39f49eba4, 0x4135860f16521000, 0x4135c70e45ee15e2, 0x41359254ae082000, 0x4135d378ec92401f, - 0x41359e9a45be3000, 0x4135dfe393366a5d, 0x4135aadfdd744000, 0x4135ec4e39da949a, 0x4135b725752a5000, 0x4135f8b8e07ebed8, 0x4135c36b0ce06000, 0x413605238722e915, - 0x4135cfb0a4967000, 0x4136118e2dc71353, 0x4135dbf63c4c8000, 0x41361df8d46b3d90, 0x4135e83bd4029000, 0x41362a637b0f67ce, 0x4135f4816bb8a000, 0x413636ce21b3920b, - 0x413600c7036eb000, 0x41364338c857bc49, 0x41360d0c9b24c000, 0x41364fa36efbe687, 0x4136195232dad000, 0x41365c0e15a010c4, 0x41362597ca90e000, 0x41366878bc443b02, - 0x413631dd6246f000, 0x413674e362e8653f, 0x41363e22f9fd0000, 0x4136814e098c8f7d, 0x41364a6891b31000, 0x41368db8b030b9ba, 0x413656ae29692000, 0x41369a2356d4e3f8, - 0x413662f3c11f3000, 0x4136a68dfd790e35, 0x41366f3958d54000, 0x4136b2f8a41d3873, 0x41367b7ef08b5000, 0x4136bf634ac162b0, 0x413687c488416000, 0x4136cbcdf1658cee, - 0x4136940a1ff77000, 0x4136d8389809b72b, 0x4136a04fb7ad8000, 0x4136e4a33eade169, 0x4136ac954f639000, 0x4136f10de5520ba6, 0x4136b8dae719a000, 0x4136fd788bf635e4, - 0x4136c5207ecfb000, 0x413709e3329a6021, 0x4136d1661685c000, 0x4137164dd93e8a5f, 0x4136ddabae3bd000, 0x413722b87fe2b49c, 0x4136e9f145f1e000, 0x41372f232686deda, - 0x4136f636dda7f000, 0x41373b8dcd2b0917, 0x4137027c755e0000, 0x413747f873cf3355, 0x41370ec20d141000, 0x413754631a735d92, 0x41371b07a4ca2000, 0x413760cdc11787d0, - 0x4137274d3c803000, 0x41376d3867bbb20d, 0x41373392d4364000, 0x413779a30e5fdc4b, 0x41373fd86bec5000, 0x4137860db5040688, 0x41374c1e03a26000, 0x413792785ba830c6, - 0x413758639b587000, 0x41379ee3024c5b03, 0x413764a9330e8000, 0x4137ab4da8f08541, 0x413770eecac49000, 0x4137b7b84f94af7e, 0x41377d34627aa000, 0x4137c422f638d9bc, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbf87a15d49dcf2a8, 0xbfc1f93392403f91, 0xbf87b207511c4bad, 0xbfe68b314650a670, 0xbf87c2b157f4d0d0, 0xbfefa61f283ccdd4, 0xbf87d35b5e6639bf, 0xbfec3231ab8abc48, - 0xbf87e40564703e2a, 0xbfdb1c4a28ca3fbf, 0xbf87f4af6a1295c0, 0x3fc9db51e61f29f9, 0xbf8805596f4cf831, 0x3fe7eb2e7959814b, 0xbf881603741f1d2c, 0x3fefe1e75da7bd1e, - 0xbf8826ad7888bc61, 0x3feb320c4d0780e9, 0xbf8837577c898d7e, 0x3fd76f6a3d6fd682, 0xbf88480180214833, 0xbfd0d1c92e081c5e, 0xbf8858ab834fa430, 0xbfe9333e2237777d, - 0xbf88695586145923, 0xbfeffdca87225365, 0xbf8879ff886f1ebd, 0xbfea16b233fa265c, 0xbf888aa98a5facad, 0xbfd3ab1898339741, 0xbf889b538be5baa1, 0x3fd4a515f7205d5e, - 0xbf88abfd8d01004a, 0x3fea62181113a19d, 0xbf88bca78db13557, 0x3feff9acbebfd878, 0xbf88cd518df61177, 0x3fe8e13ed6470eaf, 0xbf88ddfb8dcf4c5a, 0x3fcfa633d484f274, - 0xbf88eea58d3c9db0, 0xbfd863bba17fc553, 0xbf88ff4f8c3dbd27, 0xbfeb768d4dfea3f6, 0xbf890ff98ad2626f, 0xbfefd59222b00ca7, 0xbf8920a388fa4537, 0xbfe792e7c5f3c99a, - 0xbf89314d86b51d30, 0xbfc7d68d259f9a1b, 0xbf8941f78402a209, 0x3fdc09fb288410f4, 0xbf8952a180e28b70, 0x3fec6f89489d5cb6, 0xbf89634b7d549116, 0x3fef919ed1229e19, - 0xbf8973f579586aaa, 0x3fe62cfb7adc5fcf, 0xbf89849f74edcfdc, 0x3fbfde1b20fce311, 0xbf8995497014785b, 0xbfdf942df1021079, 0xbf89a5f36acc1bd6, 0xbfed4c12ec4ac774, - 0xbf89b69d651471fd, 0xbfef2e16c4136d01, 0xbf89c7475eed3281, 0xbfe4b0e004c10f7b, 0xbf89d7f15856150f, 0xbfafde756cccf76a, 0xbf89e89b514ed158, 0x3fe17f64b735c210, - 0xbf89f94549d71f0c, 0x3fee0b4d99c13b00, 0xbf8a09ef41eeb5d9, 0x3feeab5d8d6bb694, 0xbf8a1a9939954d70, 0x3fe32011a460ef26, 0xbf8a2b4330ca9d80, 0xbf2f2d000d1eded0, - 0xbf8a3bed278e5db9, 0xbfe3233157bc3f7d, 0xbf8a4c971de045ca, 0xbfeeac7a03618fb2, 0xbf8a5d4113c00d63, 0xbfee09f5f334c4fb, 0xbf8a6deb092d6c33, 0xbfe17c214fd110bf, - 0xbf8a7e94fe2819eb, 0x3fb00e581f69b3e4, 0xbf8a8f3ef2afce39, 0x3fe4b3d8e3dd9a81, 0xbf8a9fe8e6c440ce, 0x3fef2ef6ecebb084, 0xbf8ab092da652959, 0x3fed4a816d062216, - 0xbf8ac13ccd923f89, 0x3fdf8d6641661e25, 0xbf8ad1e6c04b3b0f, 0xbfbffd09d07dfa51, 0xbf8ae290b28fd39a, 0xbfe62fca8ca9afbe, 0xbf8af33aa45fc0d9, 0xbfef9241cc9e5712, - 0xbf8b03e495baba7d, 0xbfec6dbf823c5ca8, 0xbf8b148e86a07835, 0xbfdc02f9607040bb, 0xbf8b25387710b1b1, 0x3fc7e5dda840c85a, 0xbf8b35e2670b1ea0, 0x3fe7958a3b192c09, - 0xbf8b468c568f76b3, 0x3fefd5f74dc3b230, 0xbf8b5736459d7198, 0x3feb748d0a74c725, 0xbf8b67e03434c700, 0x3fd85c86c36d0237, 0xbf8b788a22552e9b, 0xbfcfb54e3001a56e, - 0xbf8b89340ffe6017, 0xbfe8e3b20c0ce484, 0xbf8b99ddfd301326, 0xbfeff9d3b43659f8, 0xbf8baa87e9e9ff76, 0xbfea5fe350d6f4b4, 0xbf8bbb31d62bdcb7, 0xbfd49db538a29429, - 0xbf8bcbdbc1f5629a, 0x3fd3b28324736512, 0xbf8bdc85ad4648ce, 0x3fea18f3b6ecd27c, 0xbf8bed2f981e4702, 0x3feffdb320026715, 0xbf8bfdd9827d14e7, 0x3fe930d71a3fdffb, - 0xbf8c0e836c626a2d, 0x3fd0ca43f097fd9e, 0xbf8c1f2d55cdfe83, 0xbfd776aabce9aecb, 0xbf8c2fd73ebf8998, 0xbfeb3419db6b25c7, 0xbf8c40812736c31e, 0xbfefe191b15acd9d, - 0xbf8c512b0f3362c3, 0xbfe7e89790eb9abd, 0xbf8c61d4f6b52038, 0xbfc9cc0d7950b012, 0xbf8c727eddbbb32d, 0x3fdb23595a47a903, 0xbf8c8328c446d350, 0x3fec3409379d2406, - 0xbf8c93d2aa563853, 0x3fefa58b8c779dfd, 0xbf8ca47c8fe999e5, 0x3fe6886d149634f3, 0xbf8cb5267500afb6, 0x3fc1e9c47971a3b7, 0xbf8cc5d0599b3175, 0xbfdeb4e1f1aa39c6, - 0xbf8cd67a3db8d6d4, 0xbfed17c1c2cbef53, 0xbf8ce72421595781, 0xbfef49dcbd6102fc, 0xbf8cf7ce047c6b2d, 0xbfe511b7f29f2a16, 0xbf8d0877e721c987, 0xbfb3eb1fe118e029, - 0xbf8d1921c9492a3f, 0x3fe113d94ffd1b31, 0xbf8d29cbaaf24507, 0x3fedde5fae15fbe0, 0xbf8d3a758c1cd18c, 0x3feecee0fbfb3596, 0xbf8d4b1f6cc88780, 0x3fe385ef04e9d45d, - 0xbf8d5bc94cf51e92, 0x3f8f764dce16a10c, 0xbf8d6c732ca24e72, 0xbfe2bc2c1ef857e1, 0xbf8d7d1d0bcfced1, 0xbfee871c47e2f358, 0xbf8d8dc6ea7d575e, 0xbfee35135017e117, - 0xbf8d9e70c8aa9fc9, 0xbfe1e69e3b994329, 0xbf8daf1aa6575fc3, 0x3fa822f7371768aa, 0xbf8dbfc483834efb, 0x3fe451c0e8eebbfe, 0xbf8dd06e602e2521, 0x3fef114ec30bd6b3, - 0xbf8de1183c5799e6, 0x3fed7d0d969f75bd, 0xbf8df1c217ff64f9, 0x3fe03565104f79cb, 0xbf8e026bf3253e0b, 0xbfbc05ae43b16de9, 0xbf8e1315cdc8dccb, 0xbfe5d301f1363fd7, - 0xbf8e23bfa7e9f8ea, 0xbfef7c6cdf64b8ac, 0xbf8e346981884a18, 0xbfeca787e766b455, 0xbf8e45135aa38805, 0xbfdce7e9cd9fcfc1, 0xbf8e55bd333b6a60, 0x3fc5eeec3d354497, - 0xbf8e66670b4fa8db, 0x3fe73e6dd0e27198, 0xbf8e7710e2dffb25, 0x3fefc80b744ba824, 0xbf8e87bab9ec18ee, 0x3febb557dd193613, 0xbf8e98649073b9e6, 0x3fd9481eb7942a44, - 0xbf8ea90e667695bf, 0xbfcdc51043508a4c, 0xbf8eb9b83bf46427, 0xbfe89298f8130d2f, 0xbf8eca6210ecdcce, 0xbfeff3dedbb92c40, 0xbf8edb0be55fb766, 0xbfeaa76fbfbf5035, - 0xbf8eebb5b94cab9f, 0xbfd58f0904942358, 0xbf8efc5f8cb37127, 0x3fd2beb624b3b8b6, 0xbf8f0d095f93bfb1, 0x3fe9ce2f1a42d04a, 0xbf8f1db331ed4eeb, 0x3fefffbb3dee6464, - 0xbf8f2e5d03bfd687, 0x3fe97edd91f010bb, 0xbf8f3f06d50b0e33, 0x3fd1c06228bd8e37, 0xbf8f4fb0a5ceada1, 0xbfd6882398cb7b80, 0xbf8f605a760a6c81, 0xbfeaeff4820c12e2, - 0xbf8f710445be0284, 0xbfefeb94bd5f43da, 0xbf8f81ae14e92758, 0xbfe83cca033a80c7, 0xbf8f9257e38b92af, 0xbfcbbff2550e068e, 0xbf8fa301b1a4fc39, 0x3fda3b06b0722bee, - 0xbf8fb3ab7f351ba6, 0x3febf6c74d9a8570, 0xbf8fc4554c3ba8a6, 0x3fefb77f828b6099, 0xbf8fd4ff18b85aeb, 0x3fe6e27746c51651, 0xbf8fe5a8e4aaea23, 0x3fc3e35daa7dba46, -] )) ), - -################ chunk 20480 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x41378979fa30b000, 0x4137d08d9cdd03f9, 0x413795bf91e6c000, 0x4137dcf843812e37, 0x4137a205299cd000, 0x4137e962ea255874, 0x4137ae4ac152e000, 0x4137f5cd90c982b2, - 0x4137ba905908f000, 0x41380238376dacef, 0x4137c6d5f0bf0000, 0x41380ea2de11d72d, 0x4137d31b88751000, 0x41381b0d84b6016a, 0x4137df61202b2000, 0x413827782b5a2ba8, - 0x4137eba6b7e13000, 0x413833e2d1fe55e5, 0x4137f7ec4f974000, 0x4138404d78a28023, 0x41380431e74d5000, 0x41384cb81f46aa60, 0x413810777f036000, 0x41385922c5ead49e, - 0x41381cbd16b97000, 0x4138658d6c8efedb, 0x41382902ae6f8000, 0x413871f813332919, 0x4138354846259000, 0x41387e62b9d75356, 0x4138418ddddba000, 0x41388acd607b7d94, - 0x41384dd37591b000, 0x41389738071fa7d1, 0x41385a190d47c000, 0x4138a3a2adc3d20f, 0x4138665ea4fdd000, 0x4138b00d5467fc4c, 0x413872a43cb3e000, 0x4138bc77fb0c268a, - 0x41387ee9d469f000, 0x4138c8e2a1b050c8, 0x41388b2f6c200000, 0x4138d54d48547b05, 0x4138977503d61000, 0x4138e1b7eef8a543, 0x4138a3ba9b8c2000, 0x4138ee22959ccf80, - 0x4138b00033423000, 0x4138fa8d3c40f9be, 0x4138bc45caf84000, 0x413906f7e2e523fb, 0x4138c88b62ae5000, 0x4139136289894e39, 0x4138d4d0fa646000, 0x41391fcd302d7876, - 0x4138e116921a7000, 0x41392c37d6d1a2b4, 0x4138ed5c29d08000, 0x413938a27d75ccf1, 0x4138f9a1c1869000, 0x4139450d2419f72f, 0x413905e7593ca000, 0x41395177cabe216c, - 0x4139122cf0f2b000, 0x41395de271624baa, 0x41391e7288a8c000, 0x41396a4d180675e7, 0x41392ab8205ed000, 0x413976b7beaaa025, 0x413936fdb814e000, 0x41398322654eca62, - 0x413943434fcaf000, 0x41398f8d0bf2f4a0, 0x41394f88e7810000, 0x41399bf7b2971edd, 0x41395bce7f371000, 0x4139a862593b491b, 0x4139681416ed2000, 0x4139b4ccffdf7358, - 0x41397459aea33000, 0x4139c137a6839d96, 0x4139809f46594000, 0x4139cda24d27c7d3, 0x41398ce4de0f5000, 0x4139da0cf3cbf211, 0x4139992a75c56000, 0x4139e6779a701c4e, - 0x4139a5700d7b7000, 0x4139f2e24114468c, 0x4139b1b5a5318000, 0x4139ff4ce7b870c9, 0x4139bdfb3ce79000, 0x413a0bb78e5c9b07, 0x4139ca40d49da000, 0x413a18223500c544, - 0x4139d6866c53b000, 0x413a248cdba4ef82, 0x4139e2cc0409c000, 0x413a30f7824919bf, 0x4139ef119bbfd000, 0x413a3d6228ed43fd, 0x4139fb573375e000, 0x413a49cccf916e3a, - 0x413a079ccb2bf000, 0x413a563776359878, 0x413a13e262e20000, 0x413a62a21cd9c2b5, 0x413a2027fa981000, 0x413a6f0cc37decf3, 0x413a2c6d924e2000, 0x413a7b776a221730, - 0x413a38b32a043000, 0x413a87e210c6416e, 0x413a44f8c1ba4000, 0x413a944cb76a6bab, 0x413a513e59705000, 0x413aa0b75e0e95e9, 0x413a5d83f1266000, 0x413aad2204b2c026, - 0x413a69c988dc7000, 0x413ab98cab56ea64, 0x413a760f20928000, 0x413ac5f751fb14a1, 0x413a8254b8489000, 0x413ad261f89f3edf, 0x413a8e9a4ffea000, 0x413adecc9f43691c, - 0x413a9adfe7b4b000, 0x413aeb3745e7935a, 0x413aa7257f6ac000, 0x413af7a1ec8bbd97, 0x413ab36b1720d000, 0x413b040c932fe7d5, 0x413abfb0aed6e000, 0x413b107739d41212, - 0x413acbf6468cf000, 0x413b1ce1e0783c50, 0x413ad83bde430000, 0x413b294c871c668d, 0x413ae48175f91000, 0x413b35b72dc090cb, 0x413af0c70daf2000, 0x413b4221d464bb09, - 0x413afd0ca5653000, 0x413b4e8c7b08e546, 0x413b09523d1b4000, 0x413b5af721ad0f84, 0x413b1597d4d15000, 0x413b6761c85139c1, 0x413b21dd6c876000, 0x413b73cc6ef563ff, - 0x413b2e23043d7000, 0x413b803715998e3c, 0x413b3a689bf38000, 0x413b8ca1bc3db87a, 0x413b46ae33a99000, 0x413b990c62e1e2b7, 0x413b52f3cb5fa000, 0x413ba57709860cf5, - 0x413b5f396315b000, 0x413bb1e1b02a3732, 0x413b6b7efacbc000, 0x413bbe4c56ce6170, 0x413b77c49281d000, 0x413bcab6fd728bad, 0x413b840a2a37e000, 0x413bd721a416b5eb, - 0x413b904fc1edf000, 0x413be38c4abae028, 0x413b9c9559a40000, 0x413beff6f15f0a66, 0x413ba8daf15a1000, 0x413bfc61980334a3, 0x413bb52089102000, 0x413c08cc3ea75ee1, - 0x413bc16620c63000, 0x413c1536e54b891e, 0x413bcdabb87c4000, 0x413c21a18befb35c, 0x413bd9f150325000, 0x413c2e0c3293dd99, 0x413be636e7e86000, 0x413c3a76d93807d7, - 0x413bf27c7f9e7000, 0x413c46e17fdc3214, 0x413bfec217548000, 0x413c534c26805c52, 0x413c0b07af0a9000, 0x413c5fb6cd24868f, 0x413c174d46c0a000, 0x413c6c2173c8b0cd, - 0x413c2392de76b000, 0x413c788c1a6cdb0a, 0x413c2fd8762cc000, 0x413c84f6c1110548, 0x413c3c1e0de2d000, 0x413c916167b52f85, 0x413c4863a598e000, 0x413c9dcc0e5959c3, - 0x413c54a93d4ef000, 0x413caa36b4fd8400, 0x413c60eed5050000, 0x413cb6a15ba1ae3e, 0x413c6d346cbb1000, 0x413cc30c0245d87b, 0x413c797a04712000, 0x413ccf76a8ea02b9, - 0x413c85bf9c273000, 0x413cdbe14f8e2cf6, 0x413c920533dd4000, 0x413ce84bf6325734, 0x413c9e4acb935000, 0x413cf4b69cd68171, 0x413caa9063496000, 0x413d0121437aabaf, - 0x413cb6d5faff7000, 0x413d0d8bea1ed5ec, 0x413cc31b92b58000, 0x413d19f690c3002a, 0x413ccf612a6b9000, 0x413d266137672a67, 0x413cdba6c221a000, 0x413d32cbde0b54a5, - 0x413ce7ec59d7b000, 0x413d3f3684af7ee2, 0x413cf431f18dc000, 0x413d4ba12b53a920, 0x413d00778943d000, 0x413d580bd1f7d35d, 0x413d0cbd20f9e000, 0x413d6476789bfd9b, - 0x413d1902b8aff000, 0x413d70e11f4027d8, 0x413d254850660000, 0x413d7d4bc5e45216, 0x413d318de81c1000, 0x413d89b66c887c53, 0x413d3dd37fd22000, 0x413d9621132ca691, - 0x413d4a1917883000, 0x413da28bb9d0d0ce, 0x413d565eaf3e4000, 0x413daef66074fb0c, 0x413d62a446f45000, 0x413dbb610719254a, 0x413d6ee9deaa6000, 0x413dc7cbadbd4f87, - 0x413d7b2f76607000, 0x413dd436546179c5, 0x413d87750e168000, 0x413de0a0fb05a402, 0x413d93baa5cc9000, 0x413ded0ba1a9ce40, 0x413da0003d82a000, 0x413df976484df87d, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbf8ff652b0130e00, 0xbfddd3ac2bae96a0, 0xbf90037e3d783f19, 0xbfece1a090193bc8, 0xbf900bd322a17934, 0xbfef63afa7c96d06, 0xbf9014280785112a, 0xbfe5713fd19b3fb3, - 0xbf901c7cec22e2d3, 0xbfb7e5c757be87cc, 0xbf9024d1d07aca07, 0x3fe0a73d84e8aa10, 0xbf902d26b48ca29e, 0x3fedaf95593c5d3b, 0xbf90357b98584871, 0x3feef0790541b0f6, - 0xbf903dd07bdd9757, 0x3fe3ea94ff69a7a1, 0xbf9046255f1c6b29, 0x3f9fb3ace4510ee8, 0xbf904e7a42149fc0, 0xbfe253fc124d761d, 0xbf9056cf24c610f2, 0xbfee5fd79fd39926, - 0xbf905f2407309a9a, 0xbfee5e4edce3dc44, 0xbf906778e954188d, 0xbfe24ffda1b6109a, 0xbf906fcdcb3066a6, 0x3fa027bd33a05207, 0xbf907822acc560bc, 0x3fe3ee64d4ff1136, - 0xbf9080778e12e2a8, 0x3feef1b7104e4210, 0xbf9088cc6f18c841, 0x3fedadc3675320a1, 0xbf9091214fd6ed60, 0x3fe0a3147824a779, 0xbf909976304d2dde, 0xbfb80c93c142bd2c, - 0xbf90a1cb107b6591, 0xbfe574dd3be12532, 0xbf90aa1ff0617054, 0xbfef64a1bcc8705b, 0xbf90b274cfff29fd, 0xbfecdf8741641ea2, 0xbf90bac9af546e66, 0xbfddcb0d2cb8df7a, - 0xbf90c31e8e611966, 0x3fc3f69cfb073b1e, 0xbf90cb736d2506d6, 0x3fe6e5dea8255ed1, 0xbf90d3c84ba0128e, 0x3fefb824af4bba8d, 0xbf90dc1d29d21867, 0x3febf468bb81aec1, - 0xbf90e47207baf438, 0x3fda32236c21a853, 0xbf90ecc6e55a81da, 0xbfcbd2f781250d24, 0xbf90f51bc2b09d25, 0xbfe83ff7f3d143b5, 0xbf90fd709fbd21f2, 0xbfefebec5cac61a1, - 0xbf9105c57c7fec19, 0xbfeaed530b7c78b0, 0xbf910e1a58f8d772, 0xbfd67f04f2d03b84, 0xbf91166f3527bfd5, 0x3fd1c9be288d15b2, 0xbf911ec4110c811c, 0x3fe981cee3a62bc3, - 0xbf912718eca6f71d, 0x3fefffc4f81bd8ad, 0xbf912f6dc7f6fdb2, 0x3fe9cb4d60d2e6ba, 0xbf9137c2a2fc70b3, 0x3fd2b5653d117249, 0xbf9140177db72bf8, 0xbfd5983511b66841, - 0xbf91486c58270b5a, 0xbfeaaa2180d2346f, 0xbf9150c1324beab1, 0xbfeff39aa70c53ab, 0xbf9159160c25a5d5, 0xbfe88f79ddeac6ed, 0xbf91616ae5b4189f, 0xbfcdb21c936f1690, - 0xbf9169bfbef71ee6, 0x3fd95111a49c4da9, 0xbf91721497ee9484, 0x3febb7c75ba72690, 0xbf917a69709a5551, 0x3fefc77995036722, 0xbf9182be48fa3d26, 0x3fe73b147541ce9b, - 0xbf918b13210e27d9, 0x3fc5dbb9a33d933e, 0xbf919367f8d5f145, 0xbfdcf09aa7344c19, 0xbf919bbcd0517541, 0xbfeca9b2b393bcf5, 0xbf91a411a7808fa6, 0xbfef7b8de7673fef, - 0xbf91ac667e631c4c, 0xbfe5cf71adf94f4d, 0xbf91b4bb54f8f70c, 0xbfbbdef1a29af8f1, 0xbf91bd102b41fbbe, 0x3fe039981a4c762a, 0xbf91c565013e063a, 0x3fed7ef185852388, - 0xbf91cdb9d6ecf259, 0x3fef1023916adf29, 0xbf91d60eac4e9bf4, 0x3fe44dfd4e83ee68, 0xbf91de638162dee2, 0x3fa7d51c9d7a1c2c, 0xbf91e6b8562996fd, 0xbfe1eaa7af8c17d0, - 0xbf91ef0d2aa2a01c, 0xbfee36ae7d895f94, 0xbf91f761fecdd619, 0xbfee85a607ed97b1, 0xbf91ffb6d2ab14cb, 0xbfe2b838f1707fc3, 0xbf92080ba63a380b, 0x3f905703049a0be3, - 0xbf921060797b1bb2, 0x3fe389cad8dd19a2, 0xbf9218b54c6d9b98, 0x3feed031cca2863a, 0xbf92210a1f119395, 0x3feddc9fd6311aa8, 0xbf92295ef166df83, 0x3fe10fba82e96b93, - 0xbf9231b3c36d5b38, 0xbfb411f9a832e328, 0xbf923a089524e28f, 0xbfe515624a5d88f4, 0xbf92425d668d5160, 0xbfef4ae1e04c4f4d, 0xbf924ab237a68383, 0xbfed15ba1308e6c8, - 0xbf925307087054d0, 0xbfdeac5556d54dee, 0xbf925b5bd8eaa120, 0x3fc1fd0f4d8d4e5f, 0xbf9263b0a915444c, 0x3fe68be2456b7245, 0xbf926c0578f01a2c, 0x3fefa643fc657eb3, - 0xbf92745a487afe98, 0x3fec31bbb7c45375, 0xbf927caf17b5cd6a, 0x3fdb1a864c71ba96, 0xbf928503e6a0627a, 0xbfc9df22f23d05b7, 0xbf928d58b53a99a0, 0xbfe7ebd4253a59ef, - 0xbf9295ad83844eb5, 0xbfefe1fcb5d298e0, 0xbf929e02517d5d91, 0xbfeb3188d954b488, 0xbf92a6571f25a20d, 0xbfd76d9a0f8b8ebb, 0xbf92aeabec7cf802, 0x3fd0d3aa734c1c0d, - 0xbf92b700b9833b48, 0x3fe933d7d54c9541, 0xbf92bf55863847b8, 0x3feffdd04def9d1e, 0xbf92c7aa529bf92b, 0x3fea1621c3b9f40e, 0xbf92cfff1eae2b78, 0x3fd3a93de996146a, - 0xbf92d853ea6eba78, 0xbfd4a6ee1a9ffb6e, 0xbf92e0a8b5dd8205, 0xbfea62a531736b89, 0xbf92e8fd80fa5df7, 0xbfeff9a2ee69abd2, 0xbf92f1524bc52a26, 0xbfe8e0a1fa1cf19b, - 0xbf92f9a7163dc26b, 0xbfcfa26d2a9f23ec, 0xbf9301fbe064029f, 0x3fd86588ca700c2c, 0xbf930a50aa37c69a, 0x3feb770d4e9ef592, 0xbf9312a573b8ea35, 0x3fefd578c50a3ae6, - 0xbf931afa3ce74948, 0x3fe7923f1aa3360a, 0xbf93234f05c2bfad, 0x3fc7d2b8f70fc528, 0xbf932ba3ce4b293c, 0xbfdc0bbb8a04b5dd, 0xbf9333f8968061cd, 0xbfec6ffba9502f1e, - 0xbf933c4d5e624539, 0xbfef9175ff86ce1c, 0xbf9344a225f0af59, 0xbfe62c47a94c796e, 0xbf934cf6ed2b7c06, 0xbfbfd65f61b17ae5, 0xbf93554bb4128718, 0x3fdf95dfca128a03, - 0xbf935da07aa5ac68, 0x3fed4c773ac16c70, 0xbf9365f540e4c7cf, 0x3fef2ddea761b4ed, 0xbf936e4a06cfb525, 0x3fe4b021c0a71282, 0xbf93769ecc665042, 0x3fafcee6a6d9a1ab, - 0xbf937ef391a87501, 0xbfe1803586bb8cf9, 0xbf9387485695ff39, 0xbfee0ba37189a822, 0xbf938f9d1b2ecac4, 0xbfeeab165db7f140, 0xbf9397f1df72b379, 0xbfe31f49ac4471a2, - 0xbf93a046a3619532, 0x3f3761c0853787fc, 0xbf93a89b66fb4bc7, 0x3fe323f9392602d5, 0xbf93b0f02a3fb311, 0x3feeacc10eb18267, 0xbf93b944ed2ea6ea, 0x3fee099ff7c7e5dd, - 0xbf93c199afc80328, 0x3fe17b506b8aaede, 0xbf93c9ee720ba3a7, 0xbfb0161f6f692a92, 0xbf93d24333f9643d, 0xbfe4b4970f696942, 0xbf93da97f59120c5, 0xbfef2f2ee4a5d4db, - 0xbf93e2ecb6d2b516, 0xbfed4a1cfbce0a95, 0xbf93eb4177bdfd09, 0xbfdf8bb442aa9e76, 0xbf93f3963852d478, 0x3fc00262b474f9f7, 0xbf93fbeaf891173c, 0x3fe6307e43ff9a06, - 0xbf94043fb878a12b, 0x3fef926a78c0361d, 0xbf940c9478094e21, 0x3fec6d4cffbf3437, 0xbf9414e93742f9f5, 0x3fdc0138dde91424, 0xbf941d3df6258081, 0xbfc7e9b1bafcfd7d, -] )) ), - -################ chunk 20992 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x413dac45d538b000, 0x413e05e0eef222bb, 0x413db88b6ceec000, 0x413e124b95964cf8, 0x413dc4d104a4d000, 0x413e1eb63c3a7736, 0x413dd1169c5ae000, 0x413e2b20e2dea173, - 0x413ddd5c3410f000, 0x413e378b8982cbb1, 0x413de9a1cbc70000, 0x413e43f63026f5ee, 0x413df5e7637d1000, 0x413e5060d6cb202c, 0x413e022cfb332000, 0x413e5ccb7d6f4a69, - 0x413e0e7292e93000, 0x413e6936241374a7, 0x413e1ab82a9f4000, 0x413e75a0cab79ee4, 0x413e26fdc2555000, 0x413e820b715bc922, 0x413e33435a0b6000, 0x413e8e7617fff35f, - 0x413e3f88f1c17000, 0x413e9ae0bea41d9d, 0x413e4bce89778000, 0x413ea74b654847da, 0x413e5814212d9000, 0x413eb3b60bec7218, 0x413e6459b8e3a000, 0x413ec020b2909c55, - 0x413e709f5099b000, 0x413ecc8b5934c693, 0x413e7ce4e84fc000, 0x413ed8f5ffd8f0d0, 0x413e892a8005d000, 0x413ee560a67d1b0e, 0x413e957017bbe000, 0x413ef1cb4d21454b, - 0x413ea1b5af71f000, 0x413efe35f3c56f89, 0x413eadfb47280000, 0x413f0aa09a6999c6, 0x413eba40dede1000, 0x413f170b410dc404, 0x413ec68676942000, 0x413f2375e7b1ee41, - 0x413ed2cc0e4a3000, 0x413f2fe08e56187f, 0x413edf11a6004000, 0x413f3c4b34fa42bc, 0x413eeb573db65000, 0x413f48b5db9e6cfa, 0x413ef79cd56c6000, 0x413f552082429737, - 0x413f03e26d227000, 0x413f618b28e6c175, 0x413f102804d88000, 0x413f6df5cf8aebb2, 0x413f1c6d9c8e9000, 0x413f7a60762f15f0, 0x413f28b33444a000, 0x413f86cb1cd3402d, - 0x413f34f8cbfab000, 0x413f9335c3776a6b, 0x413f413e63b0c000, 0x413f9fa06a1b94a8, 0x413f4d83fb66d000, 0x413fac0b10bfbee6, 0x413f59c9931ce000, 0x413fb875b763e923, - 0x413f660f2ad2f000, 0x413fc4e05e081361, 0x413f7254c2890000, 0x413fd14b04ac3d9e, 0x413f7e9a5a3f1000, 0x413fddb5ab5067dc, 0x413f8adff1f52000, 0x413fea2051f49219, - 0x413f972589ab3000, 0x413ff68af898bc57, 0x413fa36b21614000, 0x4140017acf9e734a, 0x413fafb0b9175000, 0x414007b022f08869, 0x413fbbf650cd6000, 0x41400de576429d88, - 0x413fc83be8837000, 0x4140141ac994b2a7, 0x413fd48180398000, 0x41401a501ce6c7c5, 0x413fe0c717ef9000, 0x414020857038dce4, 0x413fed0cafa5a000, 0x414026bac38af203, - 0x413ff952475bb000, 0x41402cf016dd0722, 0x414002cbef88e000, 0x414033256a2f1c40, 0x414008eebb63e800, 0x4140395abd81315f, 0x41400f11873ef000, 0x41403f9010d3467e, - 0x414015345319f800, 0x414045c564255b9d, 0x41401b571ef50000, 0x41404bfab77770bb, 0x41402179ead00800, 0x414052300ac985da, 0x4140279cb6ab1000, 0x414058655e1b9af9, - 0x41402dbf82861800, 0x41405e9ab16db018, 0x414033e24e612000, 0x414064d004bfc536, 0x41403a051a3c2800, 0x41406b055811da55, 0x41404027e6173000, 0x4140713aab63ef74, - 0x4140464ab1f23800, 0x4140776ffeb60493, 0x41404c6d7dcd4000, 0x41407da5520819b1, 0x4140529049a84800, 0x414083daa55a2ed0, 0x414058b315835000, 0x41408a0ff8ac43ef, - 0x41405ed5e15e5800, 0x414090454bfe590e, 0x414064f8ad396000, 0x4140967a9f506e2c, 0x41406b1b79146800, 0x41409caff2a2834b, 0x4140713e44ef7000, 0x4140a2e545f4986a, - 0x4140776110ca7800, 0x4140a91a9946ad89, 0x41407d83dca58000, 0x4140af4fec98c2a7, 0x414083a6a8808800, 0x4140b5853fead7c6, 0x414089c9745b9000, 0x4140bbba933cece5, - 0x41408fec40369800, 0x4140c1efe68f0204, 0x4140960f0c11a000, 0x4140c82539e11722, 0x41409c31d7eca800, 0x4140ce5a8d332c41, 0x4140a254a3c7b000, 0x4140d48fe0854160, - 0x4140a8776fa2b800, 0x4140dac533d7567f, 0x4140ae9a3b7dc000, 0x4140e0fa87296b9d, 0x4140b4bd0758c800, 0x4140e72fda7b80bc, 0x4140badfd333d000, 0x4140ed652dcd95db, - 0x4140c1029f0ed800, 0x4140f39a811faafa, 0x4140c7256ae9e000, 0x4140f9cfd471c018, 0x4140cd4836c4e800, 0x4141000527c3d537, 0x4140d36b029ff000, 0x4141063a7b15ea56, - 0x4140d98dce7af800, 0x41410c6fce67ff75, 0x4140dfb09a560000, 0x414112a521ba1493, 0x4140e5d366310800, 0x414118da750c29b2, 0x4140ebf6320c1000, 0x41411f0fc85e3ed1, - 0x4140f218fde71800, 0x414125451bb053f0, 0x4140f83bc9c22000, 0x41412b7a6f02690e, 0x4140fe5e959d2800, 0x414131afc2547e2d, 0x4141048161783000, 0x414137e515a6934c, - 0x41410aa42d533800, 0x41413e1a68f8a86b, 0x414110c6f92e4000, 0x4141444fbc4abd89, 0x414116e9c5094800, 0x41414a850f9cd2a8, 0x41411d0c90e45000, 0x414150ba62eee7c7, - 0x4141232f5cbf5800, 0x414156efb640fce6, 0x41412952289a6000, 0x41415d2509931205, 0x41412f74f4756800, 0x4141635a5ce52723, 0x41413597c0507000, 0x4141698fb0373c42, - 0x41413bba8c2b7800, 0x41416fc503895161, 0x414141dd58068000, 0x414175fa56db6680, 0x4141480023e18800, 0x41417c2faa2d7b9e, 0x41414e22efbc9000, 0x41418264fd7f90bd, - 0x41415445bb979800, 0x4141889a50d1a5dc, 0x41415a688772a000, 0x41418ecfa423bafb, 0x4141608b534da800, 0x41419504f775d019, 0x414166ae1f28b000, 0x41419b3a4ac7e538, - 0x41416cd0eb03b800, 0x4141a16f9e19fa57, 0x414172f3b6dec000, 0x4141a7a4f16c0f76, 0x4141791682b9c800, 0x4141adda44be2494, 0x41417f394e94d000, 0x4141b40f981039b3, - 0x4141855c1a6fd800, 0x4141ba44eb624ed2, 0x41418b7ee64ae000, 0x4141c07a3eb463f1, 0x414191a1b225e800, 0x4141c6af9206790f, 0x414197c47e00f000, 0x4141cce4e5588e2e, - 0x41419de749dbf800, 0x4141d31a38aaa34d, 0x4141a40a15b70000, 0x4141d94f8bfcb86c, 0x4141aa2ce1920800, 0x4141df84df4ecd8a, 0x4141b04fad6d1000, 0x4141e5ba32a0e2a9, - 0x4141b67279481800, 0x4141ebef85f2f7c8, 0x4141bc9545232000, 0x4141f224d9450ce7, 0x4141c2b810fe2800, 0x4141f85a2c972205, 0x4141c8dadcd93000, 0x4141fe8f7fe93724, - 0x4141cefda8b43800, 0x414204c4d33b4c43, 0x4141d520748f4000, 0x41420afa268d6162, 0x4141db43406a4800, 0x4142112f79df7680, 0x4141e1660c455000, 0x41421764cd318b9f, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbf942592b4b0bd9d, 0xbfe79632ca5a83cb, 0xbf942de772e48d21, 0xbfefd61085a79249, 0xbf94363c30c0cae8, 0xbfeb740ce950c4cb, 0xbf943e90ee4552c9, 0xbfd85ab97d56087c, - 0xbf9446e5ab72009e, 0x3fcfb914b3d5b87c, 0xbf944f3a6846b03f, 0x3fe8e44ecac4f60b, 0xbf94578f24c33d85, 0x3feff9dd5e9b6570, 0xbf945fe3e0e7844a, 0x3fea5f5611190d45, - 0xbf9468389cb36065, 0x3fd49bdcfce57fb9, 0xbf94708d5826adb1, 0xbfd3b45dbbf39437, 0xbf9478e213414805, 0xbfea198408254d55, 0xbf948136ce030b3b, 0xbfeffdad333fbeaa, - 0xbf94898b886bd32b, 0xbfe9303d4959eab7, 0xbf9491e0427b7baf, 0xbfd0c8629726276f, 0xbf949a34fc31e09f, 0x3fd7787acec02ea6, 0xbf94a289b58eddd4, 0x3feb349d2ee98d77, - 0xbf94aade6e924f27, 0x3fefe17c335f4df1, 0xbf94b333273c1072, 0x3fe7e7f1c896428b, 0xbf94bb87df8bfd8c, 0x3fc9c83c4f0bd87f, 0xbf94c3dc9781f250, 0xbfdb251d16abbdf9, - 0xbf94cc314f1dca95, 0xbfec347f09df65c9, 0xbf94d486065f6236, 0xbfefa56692bddfd5, 0xbf94dcdabd46950a, 0xbfe687bbfad49c27, 0xbf94e52f73d33eeb, 0xbfc1e5e8a85bf6e3, - 0xbf94ed842a053bb1, 0x3fdeb697943f4659, 0xbf94f5d8dfdc6737, 0x3fed18299e125861, 0xbf94fe2d95589d54, 0x3fef49a86cefdd72, 0xbf9506824a79b9e1, 0x3fe510fc386f2c36, - 0xbf950ed6ff3f98b9, 0x3fb3e35aabaac1fb, 0xbf95172bb3aa15b3, 0xbfe114ac39b14b2e, 0xbf951f8067b90ca9, 0xbfeddeb92a606fae, 0xbf9527d51b6c5973, 0xbfeece9d891adc18, - 0xbf953029cec3d7eb, 0xbfe38529664836f4, 0xbf95387e81bf63ea, 0xbf8f37f5a8701980, 0xbf9540d3345ed948, 0x3fe2bcf64de1ae97, 0xbf954927e6a213e0, 0x3fee87670bc34033, - 0xbf95517c9888ef89, 0x3fee34c0fe532050, 0xbf9559d14a13481d, 0x3fe1e5cf7e058644, 0xbf956225fb40f975, 0xbfa83289437dd0e4, 0xbf956a7aac11df6a, 0xbfe4528192fe29ae, - 0xbf9572cf5c85d5d4, 0xbfef118a83a397ab, 0xbf957b240c9cb88e, 0xbfed7cacb83b1aab, 0xbf958378bc566371, 0xbfe0348e02b4edb9, 0xbf958bcd6bb2b254, 0x3fbc0d6d829852e0, - 0xbf9594221ab18112, 0x3fe5d3b8557d5fe9, 0xbf959c76c952ab83, 0x3fef7c9960fcbfac, 0xbf95a4cb77960d81, 0x3feca718dd554034, 0xbf95ad20257b82e4, 0x3fdce62cc0dbce13, - 0xbf95b574d302e786, 0xbfc5f2c319015bbf, 0xbf95bdc9802c1741, 0xbfe73f193919b70d, 0xbf95c61e2cf6edec, 0xbfefc8288a564fd9, 0xbf95ce72d9634761, 0xbfebb4db167fae76, - 0xbf95d6c78570ff79, 0xbfd946547642b371, 0xbf95df1c311ff20e, 0x3fcdc8da84b51287, 0xbf95e770dc6ffaf9, 0x3fe89338b8a9f554, 0xbf95efc58760f612, 0x3feff3ec691bce60, - 0xbf95f81a31f2bf33, 0x3feaa6e5b9625cb1, 0xbf96006edc253236, 0x3fd58d3358e77174, 0xbf9608c385f82af2, 0xbfd2c09312a2a38d, 0xbf9611182f6b8542, 0xbfe9cec293561873, - 0xbf96196cd87f1cff, 0xbfefffb9351e0425, 0xbf9621c18132ce01, 0xbfe97e46d5d05137, 0xbf962a1629867422, 0xbfd1be82e8ca6772, 0xbf96326ad179eb3c, 0x3fd689f6769e336f, - 0xbf963abf790d0f27, 0x3feaf07b20289dcb, 0xbf964314203fbbbd, 0x3fefeb832062a0f7, 0xbf964b68c711ccd6, 0x3fe83c272834a7b4, 0xbf9653bd6d831e4d, 0x3fcbbc246bf626ab, - 0xbf965c1213938bfa, 0xbfda3ccdab5a0a08, 0xbf966466b942f1b7, 0xbfebf7408a247e3b, 0xbf966cbb5e912b5c, 0xbfefb75e6301787a, 0xbf967510037e14c4, 0xbfe6e1c8efda9552, - 0xbf967d64a80989c7, 0xbfc3df84260266ea, 0xbf9685b94c33663e, 0x3fddd5657cbc7765, 0xbf968e0deffb8604, 0x3fece20bf1b6e094, 0xbf9696629361c4f1, 0x3fef637f26db4624, - 0xbf969eb73665fede, 0x3fe57086ad1f4c16, 0xbf96a70bd9080fa5, 0x3fb7de04cacd59fc, 0xbf96af607b47d320, 0xbfe0a8127ba724d3, 0xbf96b7b51d252526, 0xbfedaff2747587ea, - 0xbf96c009be9fe193, 0xbfeef0395370c201, 0xbf96c85e5fb7e43e, 0xbfe3e9d1c679f05f, 0xbf96d0b3006d0902, 0xbf9f9483b1d8ea10, 0xbf96d907a0bf2bb8, 0x3fe254c8821d8343, - 0xbf96e15c40ae2839, 0x3fee60261791aa6f, 0xbf96e9b0e039da5e, 0x3fee5e0039de2543, 0xbf96f2057f621e01, 0x3fe24f3117b6862b, 0xbf96fa5a1e26cefb, 0xbfa03751b413f151, - 0xbf9702aebc87c925, 0xbfe3ef27f1780cd8, 0xbf970b035a84e85a, 0xbfeef1f69619e4bd, 0xbf971357f81e0872, 0xbfedad6621cb9547, 0xbf971bac95530546, 0xbfe0a23f69cec8e4, - 0xbf9724013223bab0, 0x3fb814562b1363b1, 0xbf972c55ce90048a, 0x3fe575964202d478, 0xbf9734aa6a97bead, 0x3fef64d2110b85c8, 0xbf973cff063ac4f2, 0x3fecdf1bb6a97840, - 0xbf974553a178f333, 0x3fddc953b172aaf8, 0xbf974da83c522549, 0xbfc3fa7663242936, 0xbf9755fcd6c6370e, 0xbfe6e68cde8ef7a6, 0xbf975e5170d5045a, 0xbfefb845a1ad3c07, - 0xbf9766a60a7e6909, 0xbfebf3ef5738d4b2, 0xbf976efaa3c240f2, 0xbfda305c4be7c7c9, 0xbf97774f3ca067ef, 0x3fcbd6c5432a4476, 0xbf977fa3d518b9da, 0x3fe8409aac52edbc, - 0xbf9787f86d2b128d, 0x3fefebfdcc347107, 0xbf97904d04d74de0, 0x3feaeccc4707df57, 0xbf9798a19c1d47ae, 0x3fd67d31f4b3da63, 0xbf97a0f632fcdbd0, 0xbfd1cb9d4f339dba, - 0xbf97a94ac975e61f, 0xbfe982657b64082e, 0xbf97b19f5f884274, 0xbfefffc6d35d7098, 0xbf97b9f3f533ccaa, 0xbfe9cab9c2f159d7, 0xbf97c2488a78609a, 0xbfd2b38834791c1f, - 0xbf97ca9d1f55da1e, 0x3fd59a0a9e6ebb3c, 0xbf97d2f1b3cc150e, 0x3feaaaab613a8e29, 0xbf97db4647daed45, 0x3feff38cec2a3f39, 0xbf97e39adb823e9b, 0x3fe88ed9fa5a0113, - 0xbf97ebef6ec1e4ec, 0x3fcdae5228323f5b, 0xbf97f4440199bc0f, 0xbfd952dbc1e8e44c, 0xbf97fc9894099fe0, 0xbfebb843fadbf9e5, 0xbf9804ed26116c36, 0xbfefc75c51b9a761, - 0xbf980d41b7b0fced, 0xbfe73a68ec0b2564, 0xbf98159648e82ddd, 0xbfc5d7e2a8450e82, 0xbf981dead9b6dae0, 0x3fdcf2578b03c47b, 0xbf98263f6a1cdfcf, 0x3fecaa2194d7dcaa, - 0xbf982e93fa1a1886, 0x3fef7b613901bc35, 0xbf9836e889ae60dc, 0x3fe5cebb2aa25ee3, 0xbf983f3d18d994ab, 0x3fbbd7323aebd5bc, 0xbf984791a79b8fce, 0xbfe03a6f10d06ae4, -] )) ), - -################ chunk 21504 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4141e788d8205800, 0x41421d9a2083a0be, 0x4141edaba3fb6000, 0x414223cf73d5b5dd, 0x4141f3ce6fd66800, 0x41422a04c727cafb, 0x4141f9f13bb17000, 0x4142303a1a79e01a, - 0x41420014078c7800, 0x4142366f6dcbf539, 0x41420636d3678000, 0x41423ca4c11e0a58, 0x41420c599f428800, 0x414242da14701f76, 0x4142127c6b1d9000, 0x4142490f67c23495, - 0x4142189f36f89800, 0x41424f44bb1449b4, 0x41421ec202d3a000, 0x4142557a0e665ed3, 0x414224e4ceaea800, 0x41425baf61b873f1, 0x41422b079a89b000, 0x414261e4b50a8910, - 0x4142312a6664b800, 0x4142681a085c9e2f, 0x4142374d323fc000, 0x41426e4f5baeb34e, 0x41423d6ffe1ac800, 0x41427484af00c86c, 0x41424392c9f5d000, 0x41427aba0252dd8b, - 0x414249b595d0d800, 0x414280ef55a4f2aa, 0x41424fd861abe000, 0x41428724a8f707c9, 0x414255fb2d86e800, 0x41428d59fc491ce8, 0x41425c1df961f000, 0x4142938f4f9b3206, - 0x41426240c53cf800, 0x414299c4a2ed4725, 0x4142686391180000, 0x41429ff9f63f5c44, 0x41426e865cf30800, 0x4142a62f49917163, 0x414274a928ce1000, 0x4142ac649ce38681, - 0x41427acbf4a91800, 0x4142b299f0359ba0, 0x414280eec0842000, 0x4142b8cf4387b0bf, 0x414287118c5f2800, 0x4142bf0496d9c5de, 0x41428d34583a3000, 0x4142c539ea2bdafc, - 0x4142935724153800, 0x4142cb6f3d7df01b, 0x41429979eff04000, 0x4142d1a490d0053a, 0x41429f9cbbcb4800, 0x4142d7d9e4221a59, 0x4142a5bf87a65000, 0x4142de0f37742f77, - 0x4142abe253815800, 0x4142e4448ac64496, 0x4142b2051f5c6000, 0x4142ea79de1859b5, 0x4142b827eb376800, 0x4142f0af316a6ed4, 0x4142be4ab7127000, 0x4142f6e484bc83f2, - 0x4142c46d82ed7800, 0x4142fd19d80e9911, 0x4142ca904ec88000, 0x4143034f2b60ae30, 0x4142d0b31aa38800, 0x414309847eb2c34f, 0x4142d6d5e67e9000, 0x41430fb9d204d86d, - 0x4142dcf8b2599800, 0x414315ef2556ed8c, 0x4142e31b7e34a000, 0x41431c2478a902ab, 0x4142e93e4a0fa800, 0x41432259cbfb17ca, 0x4142ef6115eab000, 0x4143288f1f4d2ce8, - 0x4142f583e1c5b800, 0x41432ec4729f4207, 0x4142fba6ada0c000, 0x414334f9c5f15726, 0x414301c9797bc800, 0x41433b2f19436c45, 0x414307ec4556d000, 0x414341646c958163, - 0x41430e0f1131d800, 0x41434799bfe79682, 0x41431431dd0ce000, 0x41434dcf1339aba1, 0x41431a54a8e7e800, 0x41435404668bc0c0, 0x4143207774c2f000, 0x41435a39b9ddd5de, - 0x4143269a409df800, 0x4143606f0d2feafd, 0x41432cbd0c790000, 0x414366a46082001c, 0x414332dfd8540800, 0x41436cd9b3d4153b, 0x41433902a42f1000, 0x4143730f07262a59, - 0x41433f25700a1800, 0x414379445a783f78, 0x414345483be52000, 0x41437f79adca5497, 0x41434b6b07c02800, 0x414385af011c69b6, 0x4143518dd39b3000, 0x41438be4546e7ed4, - 0x414357b09f763800, 0x41439219a7c093f3, 0x41435dd36b514000, 0x4143984efb12a912, 0x414363f6372c4800, 0x41439e844e64be31, 0x41436a1903075000, 0x4143a4b9a1b6d34f, - 0x4143703bcee25800, 0x4143aaeef508e86e, 0x4143765e9abd6000, 0x4143b124485afd8d, 0x41437c8166986800, 0x4143b7599bad12ac, 0x414382a432737000, 0x4143bd8eeeff27ca, - 0x414388c6fe4e7800, 0x4143c3c442513ce9, 0x41438ee9ca298000, 0x4143c9f995a35208, 0x4143950c96048800, 0x4143d02ee8f56727, 0x41439b2f61df9000, 0x4143d6643c477c46, - 0x4143a1522dba9800, 0x4143dc998f999164, 0x4143a774f995a000, 0x4143e2cee2eba683, 0x4143ad97c570a800, 0x4143e904363dbba2, 0x4143b3ba914bb000, 0x4143ef39898fd0c1, - 0x4143b9dd5d26b800, 0x4143f56edce1e5df, 0x4143c0002901c000, 0x4143fba43033fafe, 0x4143c622f4dcc800, 0x414401d98386101d, 0x4143cc45c0b7d000, 0x4144080ed6d8253c, - 0x4143d2688c92d800, 0x41440e442a2a3a5a, 0x4143d88b586de000, 0x414414797d7c4f79, 0x4143deae2448e800, 0x41441aaed0ce6498, 0x4143e4d0f023f000, 0x414420e4242079b7, - 0x4143eaf3bbfef800, 0x4144271977728ed5, 0x4143f11687da0000, 0x41442d4ecac4a3f4, 0x4143f73953b50800, 0x414433841e16b913, 0x4143fd5c1f901000, 0x414439b97168ce32, - 0x4144037eeb6b1800, 0x41443feec4bae350, 0x414409a1b7462000, 0x41444624180cf86f, 0x41440fc483212800, 0x41444c596b5f0d8e, 0x414415e74efc3000, 0x4144528ebeb122ad, - 0x41441c0a1ad73800, 0x414458c4120337cb, 0x4144222ce6b24000, 0x41445ef965554cea, 0x4144284fb28d4800, 0x4144652eb8a76209, 0x41442e727e685000, 0x41446b640bf97728, - 0x414434954a435800, 0x414471995f4b8c46, 0x41443ab8161e6000, 0x414477ceb29da165, 0x414440dae1f96800, 0x41447e0405efb684, 0x414446fdadd47000, 0x414484395941cba3, - 0x41444d2079af7800, 0x41448a6eac93e0c1, 0x41445343458a8000, 0x414490a3ffe5f5e0, 0x4144596611658800, 0x414496d953380aff, 0x41445f88dd409000, 0x41449d0ea68a201e, - 0x414465aba91b9800, 0x4144a343f9dc353c, 0x41446bce74f6a000, 0x4144a9794d2e4a5b, 0x414471f140d1a800, 0x4144afaea0805f7a, 0x414478140cacb000, 0x4144b5e3f3d27499, - 0x41447e36d887b800, 0x4144bc19472489b7, 0x41448459a462c000, 0x4144c24e9a769ed6, 0x41448a7c703dc800, 0x4144c883edc8b3f5, 0x4144909f3c18d000, 0x4144ceb9411ac914, - 0x414496c207f3d800, 0x4144d4ee946cde32, 0x41449ce4d3cee000, 0x4144db23e7bef351, 0x4144a3079fa9e800, 0x4144e1593b110870, 0x4144a92a6b84f000, 0x4144e78e8e631d8f, - 0x4144af4d375ff800, 0x4144edc3e1b532ad, 0x4144b570033b0000, 0x4144f3f9350747cc, 0x4144bb92cf160800, 0x4144fa2e88595ceb, 0x4144c1b59af11000, 0x41450063dbab720a, - 0x4144c7d866cc1800, 0x414506992efd8729, 0x4144cdfb32a72000, 0x41450cce824f9c47, 0x4144d41dfe822800, 0x41451303d5a1b166, 0x4144da40ca5d3000, 0x4145193928f3c685, - 0x4144e06396383800, 0x41451f6e7c45dba4, 0x4144e68662134000, 0x414525a3cf97f0c2, 0x4144eca92dee4800, 0x41452bd922ea05e1, 0x4144f2cbf9c95000, 0x4145320e763c1b00, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbf984fe635f42e1d, 0xbfed7f5239dff48c, 0xbf98583ac3e34b73, 0xbfef0fe7a498a3dc, 0xbf98608f5168c3aa, 0xbfe44d3c87894eb2, 0xbf9868e3de84729a, 0xbfa7c58a6cee89dd, - 0xbf9871386b36341d, 0x3fe1eb7653860cc8, 0xbf98798cf77de40e, 0x3fee3700a44b3913, 0xbf9881e1835b5e45, 0x3fee855b1897c098, 0xbf988a360ece7e9d, 0x3fe2b76ea7c39812, - 0xbf98928a99d720ef, 0xbf90762efc98ede2, 0xbf989adf24752115, 0xbfe38a905bb04b15, 0xbf98a333aea85ae9, 0xbfeed07513a52d97, 0xbf98ab883870aa44, 0xbfeddc462f56125c, - 0xbf98b3dcc1cdeb00, 0xbfe10ee78102ec30, 0xbf98bc314abff8f7, 0x3fb419bec1299b33, 0xbf98c485d346b003, 0x3fe5161de68bbca2, 0xbf98ccda5b61ebfd, 0x3fef4b160437971d, - 0xbf98d52ee31188be, 0x3fed15520e585ebe, 0xbf98dd836a556222, 0x3fdeaa9f888e9e7c, 0xbf98e5d7f12d5401, 0xbfc200eb0495a4a9, 0xbf98ee2c77993a36, 0xbfe68c933f2ca4f0, - 0xbf98f680fd98f09a, 0xbfefa668c91057e3, 0xbf98fed5832c5306, 0xbfec3145bd5c5fe0, 0xbf99072a08533d56, 0xbfdb18c269aac97f, 0xbf990f7e8d0d8b62, 0x3fc9e2f3f8374a59, - 0xbf9917d3115b1904, 0x3fe7ec79cb83584a, 0xbf992027953bc216, 0x3fefe2120669fb55, 0xbf99287c18af6273, 0x3feb31055f2e0679, 0xbf9930d09bb5d5f3, 0x3fd76bc9dc181e66, - 0xbf9939251e4ef871, 0xbfd0d58bb4cfb39e, 0xbf994179a07aa5c6, 0xbfe93471825309fe, 0xbf9949ce2238b9cd, 0xbfeffdd60d2590c4, 0xbf995222a389105f, 0xbfea15914d491de9, - 0xbf995a77246b8556, 0xbfd3a7633611569d, 0xbf9962cba4dff48c, 0x3fd4a8c638fc8047, 0xbf996b2024e639db, 0x3fea63324b906b5d, 0xbf997374a47e311d, 0x3feff999167d24e6, - 0xbf997bc923a7b62b, 0x3fe8e00517f78194, 0xbf99841da262a4e0, 0x3fcf9ea679b3b536, 0xbf998c7220aed915, 0xbfd86755ed96571c, 0xbf9994c69e8c2ea5, 0xbfeb778d48bae4f4, - 0xbf999d1b1bfa8169, 0xbfefd55f5fd3630b, 0xbf99a56f98f9ad3b, 0xbfe7919669d06d18, 0xbf99adc415898df6, 0xbfc7cee4c2d8ca73, 0xbf99b61891a9ff72, 0x3fdc0d7be4ddb0d8, - 0xbf99be6d0d5add8b, 0x3fec706e03523b19, 0xbf99c6c1889c0419, 0x3fef914d26729a3f, 0xbf99cf16036d4ef8, 0x3fe62b93d279aac5, 0xbf99d76a7dce9a01, 0x3fbfcea39ad81696, - 0xbf99dfbef7bfc10e, 0xbfdf97919bdc0015, 0xbf99e81371409ff8, 0xbfed4cdb82376f01, 0xbf99f067ea51129b, 0xbfef2da68349fe6d, 0xbf99f8bc62f0f4d0, 0xbfe4af6377a46043, - 0xbf9a0110db202271, 0xbfafbf57d75b13cd, 0xbf9a096552de7758, 0x3fe1810651ff74a0, 0xbf9a11b9ca2bcf5e, 0x3fee0bf94230f515, 0xbf9a1a0e4108065f, 0x3feeaacf26bd3412, - 0xbf9a2262b772f835, 0x3fe31e81af84b47f, 0xbf9a2ab72d6c80b8, 0xbf3f2cfffe5349b9, 0xbf9a330ba2f47bc4, 0xbfe324c1160512fd, 0xbf9a3b60180ac532, 0xbfeead0812ba1803, - 0xbf9a43b48caf38dc, 0xbfee0949f52f5755, 0xbf9a4c0900e1b29d, 0xbfe17a7f83392aeb, 0xbf9a545d74a20e4f, 0x3fb01de6bb9773f4, 0xbf9a5cb1e7f027cb, 0x3fe4b555360b73ec, - 0xbf9a65065acbdaec, 0x3fef2f66d4f9a919, 0xbf9a6d5acd35038c, 0x3fed49b883afa15a, 0xbf9a75af3f2b7d85, 0x3fdf8a023caa8adb, 0xbf9a7e03b0af24b1, 0xbfc006407ddc74d4, - 0xbf9a865821bfd4ea, 0xbfe63131f6119abc, 0xbf9a8eac925d6a0b, 0xbfef92931d69717f, 0xbf9a97010287bfee, 0xbfec6cda7691ed7b, 0xbf9a9f55723eb26c, 0xbfdbff7854bcbdcb, - 0xbf9aa7a9e1821d60, 0x3fc7ed85c80c97fc, 0xbf9aaffe5051dca5, 0x3fe796db5418b1cc, 0xbf9ab852beadcc13, 0x3fefd629b5fa4e16, 0xbf9ac0a72c95c786, 0x3feb738cc1a91839, - 0xbf9ac8fb9a09aad8, 0x3fd858ec3177a202, 0xbf9ad150070951e3, 0xbfcfbcdb309ec569, 0xbf9ad9a473949880, 0xbfe8e4eb8380d9ed, 0xbf9ae1f8dfab5a8c, 0xbfeff9e7016a0ab7, - 0xbf9aea4d4b4d73de, 0xbfea5ec8cb192326, 0xbf9af2a1b67ac053, 0xbfd49a04bc07ee90, 0xbf9afaf621331bc3, 0x3fd3b6384e89e83e, 0xbf9b034a8b76620a, 0x3fea1a14532c5860, - 0xbf9b0b9ef5446f01, 0x3feffda73ee5c68e, 0xbf9b13f35e9d1e83, 0x3fe92fa3726622bb, 0xbf9b1c47c7804c6a, 0x3fd0c68139f69974, 0xbf9b249c2fedd491, 0xbfd77a4adb04f296, - 0xbf9b2cf097e592d1, 0xbfeb35207bf356c0, 0xbf9b3544ff676305, 0xbfefe166add06da5, 0xbf9b3d9966732107, 0xbfe7e74bfaaa0062, 0xbf9b45edcd08a8b2, 0xbfc9c46b1ea8da85, - 0xbf9b4e423327d5e0, 0x3fdb26e0cc9ee21e, 0xbf9b569698d0846c, 0x3fec34f4d57f6fcb, 0xbf9b5eeafe02902e, 0x3fefa54191868450, 0xbf9b673f62bdd503, 0x3fe6870adbba67a1, - 0xbf9b6f93c7022ec4, 0x3fc1e20cd3070ec5, 0xbf9b77e82acf794b, 0xbfdeb84d2fc2c741, 0xbf9b803c8e259074, 0xbfed189172641397, 0xbf9b8890f1045018, 0xbfef49741512217c, - 0xbf9b90e5536b9411, 0xbfe51040793f7da2, 0xbf9b9939b55b383b, 0xbfb3db9570854c91, 0xbf9ba18e16d31870, 0x3fe1157f1f3cd737, 0xbf9ba9e277d31089, 0x3feddf129f946bb1, - 0xbf9bb236d85afc62, 0x3feece5a0eeb1c95, 0xbf9bba8b386ab7d4, 0x3fe38463c2eb7ab2, 0xbf9bc2df98021ebb, 0x3f8ef99d8360f0c1, 0xbf9bcb33f7210cf1, 0xbfe2bdc07858c396, - 0xbf9bd38855c75e4f, 0xbfee87b1c8650ce9, 0xbf9bdbdcb3f4eeb1, 0xbfee346ea558ec88, 0xbf9be43111a999f2, 0xbfe1e500bc4d1b78, 0xbf9bec856ee53beb, 0x3fa8421b4a26571e, - 0xbf9bf4d9cba7b076, 0x3fe45342383b1975, 0xbf9bfd2e27f0d370, 0x3fef11c63ce3bc43, 0xbf9c058283c080b1, 0x3fed7c4bd2e3f91d, 0xbf9c0dd6df169415, 0x3fe033b6f15d9322, - 0xbf9c162b39f2e976, 0xbfbc152cbcd4119f, 0xbf9c1e7f94555cae, 0xbfe5d46eb4c56702, 0xbf9c26d3ee3dc998, 0xbfef7cc5db166378, 0xbf9c2f2847ac0c0f, 0xbfeca6a9cc8584eb, - 0xbf9c377ca09fffee, 0xbfdce46fad3c4ecd, 0xbf9c3fd0f919810e, 0x3fc5f699f0946496, 0xbf9c482551186b4a, 0x3fe73fc49bb6dfdb, 0xbf9c5079a89c9a7d, 0x3fefc84598d2a0f5, - 0xbf9c58cdffa5ea81, 0x3febb45e49531c00, 0xbf9c612256343731, 0x3fd9448a2e7c4f59, 0xbf9c6976ac475c68, 0xbfcdcca4be8bd603, 0xbf9c71cb01df3601, 0xbfe893d873578aac, -] )) ), - -################ chunk 22016 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4144f8eec5a45800, 0x41453843c98e301f, 0x4144ff11917f6000, 0x41453e791ce0453d, 0x414505345d5a6800, 0x414544ae70325a5c, 0x41450b5729357000, 0x41454ae3c3846f7b, - 0x41451179f5107800, 0x4145511916d6849a, 0x4145179cc0eb8000, 0x4145574e6a2899b8, 0x41451dbf8cc68800, 0x41455d83bd7aaed7, 0x414523e258a19000, 0x414563b910ccc3f6, - 0x41452a05247c9800, 0x414569ee641ed915, 0x41453027f057a000, 0x41457023b770ee33, 0x4145364abc32a800, 0x414576590ac30352, 0x41453c6d880db000, 0x41457c8e5e151871, - 0x4145429053e8b800, 0x414582c3b1672d90, 0x414548b31fc3c000, 0x414588f904b942ae, 0x41454ed5eb9ec800, 0x41458f2e580b57cd, 0x414554f8b779d000, 0x41459563ab5d6cec, - 0x41455b1b8354d800, 0x41459b98feaf820b, 0x4145613e4f2fe000, 0x4145a1ce52019729, 0x414567611b0ae800, 0x4145a803a553ac48, 0x41456d83e6e5f000, 0x4145ae38f8a5c167, - 0x414573a6b2c0f800, 0x4145b46e4bf7d686, 0x414579c97e9c0000, 0x4145baa39f49eba4, 0x41457fec4a770800, 0x4145c0d8f29c00c3, 0x4145860f16521000, 0x4145c70e45ee15e2, - 0x41458c31e22d1800, 0x4145cd4399402b01, 0x41459254ae082000, 0x4145d378ec92401f, 0x4145987779e32800, 0x4145d9ae3fe4553e, 0x41459e9a45be3000, 0x4145dfe393366a5d, - 0x4145a4bd11993800, 0x4145e618e6887f7c, 0x4145aadfdd744000, 0x4145ec4e39da949a, 0x4145b102a94f4800, 0x4145f2838d2ca9b9, 0x4145b725752a5000, 0x4145f8b8e07ebed8, - 0x4145bd4841055800, 0x4145feee33d0d3f7, 0x4145c36b0ce06000, 0x414605238722e915, 0x4145c98dd8bb6800, 0x41460b58da74fe34, 0x4145cfb0a4967000, 0x4146118e2dc71353, - 0x4145d5d370717800, 0x414617c381192872, 0x4145dbf63c4c8000, 0x41461df8d46b3d90, 0x4145e21908278800, 0x4146242e27bd52af, 0x4145e83bd4029000, 0x41462a637b0f67ce, - 0x4145ee5e9fdd9800, 0x41463098ce617ced, 0x4145f4816bb8a000, 0x414636ce21b3920b, 0x4145faa43793a800, 0x41463d037505a72a, 0x414600c7036eb000, 0x41464338c857bc49, - 0x414606e9cf49b800, 0x4146496e1ba9d168, 0x41460d0c9b24c000, 0x41464fa36efbe687, 0x4146132f66ffc800, 0x414655d8c24dfba5, 0x4146195232dad000, 0x41465c0e15a010c4, - 0x41461f74feb5d800, 0x4146624368f225e3, 0x41462597ca90e000, 0x41466878bc443b02, 0x41462bba966be800, 0x41466eae0f965020, 0x414631dd6246f000, 0x414674e362e8653f, - 0x414638002e21f800, 0x41467b18b63a7a5e, 0x41463e22f9fd0000, 0x4146814e098c8f7d, 0x41464445c5d80800, 0x414687835cdea49b, 0x41464a6891b31000, 0x41468db8b030b9ba, - 0x4146508b5d8e1800, 0x414693ee0382ced9, 0x414656ae29692000, 0x41469a2356d4e3f8, 0x41465cd0f5442800, 0x4146a058aa26f916, 0x414662f3c11f3000, 0x4146a68dfd790e35, - 0x414669168cfa3800, 0x4146acc350cb2354, 0x41466f3958d54000, 0x4146b2f8a41d3873, 0x4146755c24b04800, 0x4146b92df76f4d91, 0x41467b7ef08b5000, 0x4146bf634ac162b0, - 0x414681a1bc665800, 0x4146c5989e1377cf, 0x414687c488416000, 0x4146cbcdf1658cee, 0x41468de7541c6800, 0x4146d20344b7a20c, 0x4146940a1ff77000, 0x4146d8389809b72b, - 0x41469a2cebd27800, 0x4146de6deb5bcc4a, 0x4146a04fb7ad8000, 0x4146e4a33eade169, 0x4146a67283888800, 0x4146ead891fff687, 0x4146ac954f639000, 0x4146f10de5520ba6, - 0x4146b2b81b3e9800, 0x4146f74338a420c5, 0x4146b8dae719a000, 0x4146fd788bf635e4, 0x4146befdb2f4a800, 0x414703addf484b02, 0x4146c5207ecfb000, 0x414709e3329a6021, - 0x4146cb434aaab800, 0x4147101885ec7540, 0x4146d1661685c000, 0x4147164dd93e8a5f, 0x4146d788e260c800, 0x41471c832c909f7d, 0x4146ddabae3bd000, 0x414722b87fe2b49c, - 0x4146e3ce7a16d800, 0x414728edd334c9bb, 0x4146e9f145f1e000, 0x41472f232686deda, 0x4146f01411cce800, 0x4147355879d8f3f8, 0x4146f636dda7f000, 0x41473b8dcd2b0917, - 0x4146fc59a982f800, 0x414741c3207d1e36, 0x4147027c755e0000, 0x414747f873cf3355, 0x4147089f41390800, 0x41474e2dc7214873, 0x41470ec20d141000, 0x414754631a735d92, - 0x414714e4d8ef1800, 0x41475a986dc572b1, 0x41471b07a4ca2000, 0x414760cdc11787d0, 0x4147212a70a52800, 0x4147670314699cee, 0x4147274d3c803000, 0x41476d3867bbb20d, - 0x41472d70085b3800, 0x4147736dbb0dc72c, 0x41473392d4364000, 0x414779a30e5fdc4b, 0x414739b5a0114800, 0x41477fd861b1f16a, 0x41473fd86bec5000, 0x4147860db5040688, - 0x414745fb37c75800, 0x41478c4308561ba7, 0x41474c1e03a26000, 0x414792785ba830c6, 0x41475240cf7d6800, 0x414798adaefa45e5, 0x414758639b587000, 0x41479ee3024c5b03, - 0x41475e8667337800, 0x4147a518559e7022, 0x414764a9330e8000, 0x4147ab4da8f08541, 0x41476acbfee98800, 0x4147b182fc429a60, 0x414770eecac49000, 0x4147b7b84f94af7e, - 0x41477711969f9800, 0x4147bdeda2e6c49d, 0x41477d34627aa000, 0x4147c422f638d9bc, 0x414783572e55a800, 0x4147ca58498aeedb, 0x41478979fa30b000, 0x4147d08d9cdd03f9, - 0x41478f9cc60bb800, 0x4147d6c2f02f1918, 0x414795bf91e6c000, 0x4147dcf843812e37, 0x41479be25dc1c800, 0x4147e32d96d34356, 0x4147a205299cd000, 0x4147e962ea255874, - 0x4147a827f577d800, 0x4147ef983d776d93, 0x4147ae4ac152e000, 0x4147f5cd90c982b2, 0x4147b46d8d2de800, 0x4147fc02e41b97d1, 0x4147ba905908f000, 0x41480238376dacef, - 0x4147c0b324e3f800, 0x4148086d8abfc20e, 0x4147c6d5f0bf0000, 0x41480ea2de11d72d, 0x4147ccf8bc9a0800, 0x414814d83163ec4c, 0x4147d31b88751000, 0x41481b0d84b6016a, - 0x4147d93e54501800, 0x41482142d8081689, 0x4147df61202b2000, 0x414827782b5a2ba8, 0x4147e583ec062800, 0x41482dad7eac40c7, 0x4147eba6b7e13000, 0x414833e2d1fe55e5, - 0x4147f1c983bc3800, 0x41483a1825506b04, 0x4147f7ec4f974000, 0x4148404d78a28023, 0x4137f7ec53a8d491, 0x4137f7ec53a8d492, 0x4137f7ec53a8d490, 0x40fe240c9fbe76c9, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbf9c7a1f56fb9fd4, 0xbfeff3f9eee97337, 0xbf9c8273ab9c75bf, 0xbfeaa65bac8eff80, 0xbf9c8ac7ffc1939a, 0xbfd58b5da859d917, 0xbf9c931c536ad541, 0x3fd2c26ffbe13fbe, - 0xbf9c9b70a698168f, 0x3fe9cf560649ade0, 0xbf9ca3c4f949335d, 0x3fefffb724b5513f, 0xbf9cac194b7e0787, 0x3fe97db013b74e9c, 0xbf9cb46d9d366ee8, 0x3fd1bca3a4dedcdb, - 0xbf9cbcc1ee724559, 0xbfd68bc94f17c847, 0xbf9cc5163f3166b6, 0xbfeaf101b8033f96, 0xbf9ccd6a8f73aed9, 0xbfefeb717bd541c8, 0xbf9cd5bedf38f99e, 0xbfe83b844783893b, - 0xbf9cde132e8122de, 0xbfcbb8567c49814f, 0xbf9ce6677d4c0675, 0x3fda3e94a07cd6f4, 0xbf9ceebbcb99803d, 0x3febf7b9bffc1c59, 0xbf9cf71019696c10, 0x3fefb73d3bf530fc, - 0xbf9cff6466bba5cb, 0x3fe6e11a93821a6f, 0xbf9d07b8b3900947, 0x3fc3dbaa9bd2f97e, 0xbf9d100cffe6725f, 0xbfddd71ec67d7702, 0xbf9d18614bbebcee, 0xbfece2774c6c3b10, - 0xbf9d20b59718c4cf, 0xbfef634e9e7a673f, 0xbf9d2909e1f465dc, 0xbfe56fcd835d7907, 0xbf9d315e2c517bf1, 0xbfb7d64239313a0c, 0xbf9d39b2762fe2e8, 0x3fe0a8e76e567d43, - 0xbf9d4206bf8f769c, 0x3fedb04f88a35440, 0xbf9d4a5b087012e7, 0x3feeeff99a381a48, 0xbf9d52af50d193a5, 0x3fe3e90e88e99fa6, 0xbf9d5b0398b3d4b1, 0x3f9f755a7be1edf2, - 0xbf9d6357e016b1e5, 0xbfe25594ed940717, 0xbf9d6bac26fa071b, 0xbfee6074882eadd9, 0xbf9d74006d5db030, 0xbfee5db18fadd95f, 0xbf9d7c54b34188fe, 0xbfe24e6489790415, - 0xbf9d84a8f8a56d5f, 0x3fa046e630ae82c8, 0xbf9d8cfd3d89392f, 0x3fe3efeb09682e50, 0xbf9d955181ecc848, 0x3feef2361485991c, 0xbf9d9da5c5cff686, 0x3fedad08d5453d82, - 0xbf9da5fa09329fc3, 0x3fe0a16a57867d0e, 0xbf9dae4e4c149fda, 0xbfb81c18912b0c1e, 0xbf9db6a28e75d2a7, 0xbfe5764f42dd7a04, 0xbf9dbef6d0561403, 0xbfef65025dd55ee1, - 0xbf9dc74b11b53fcb, 0xbfecdeb02522cd69, 0xbf9dcf9f529331d8, 0xbfddc79a2ea9c5d8, 0xbf9dd7f392efc607, 0x3fc3fe4fc7805a7b, 0xbf9de047d2cad831, 0x3fe6e73b0f731a97, - 0xbf9de89c12244432, 0x3fefb8668c83ad1e, 0xbf9df0f050fbe5e5, 0x3febf375ec4df805, 0xbf9df9448f519925, 0x3fda2e9525023f2a, 0xbf9e0198cd2539cd, 0xbfcbda92fe177450, - 0xbf9e09ed0a76a3b8, 0xbfe8413d5efe7e1a, 0xbf9e12414745b2c1, 0xbfefec0f342964fb, 0xbf9e1a95839242c2, 0xbfeaec457c0d1c23, 0xbf9e22e9bf5c2f98, 0xbfd67b5ef17d483a, - 0xbf9e2b3dfaa3551c, 0x3fd1cd7c7163ae5e, 0xbf9e339235678f2b, 0x3fe982fc0d14509c, 0xbf9e3be66fa8b99f, 0x3fefffc8a707b23b, 0xbf9e443aa966b053, 0x3fe9ca261f03ff84, - 0xbf9e4c8ee2a14f22, 0x3fd2b1ab27adf56c, 0xbf9e54e31b5871e8, 0xbfd59be02606d940, 0xbf9e5d37538bf47f, 0xbfeaab353b72659e, 0xbf9e658b8b3bb2c3, 0xbfeff37f29b506a4, - 0xbf9e6ddfc267888f, 0xbfe88e3a1109f4d0, 0xbf9e7633f90f51bd, 0xbfcdaa87b5ea6c94, 0xbf9e7e882f32ea29, 0x3fd954a5d9a8bad6, 0xbf9e86dc64d22daf, 0x3febb8c0936cf580, - 0xbf9e8f3099ecf829, 0x3fefc73f06e93e03, 0xbf9e9784ce832572, 0x3fe739bd5d517aba, 0xbf9e9fd902949166, 0x3fc5d40ba721680f, 0xbf9ea82d362117e0, 0xbfdcf41467bbc6e2, - 0xbf9eb081692894ba, 0xbfecaa906f4083c2, 0xbf9eb8d59baae3d1, 0xbfef7b348323d5ae, 0xbf9ec129cda7e0ff, 0xbfe5ce04a1efe134, 0xbf9ec97dff1f6820, 0xbfbbcf72cd9ffc1b, - 0xbf9ed1d23011550f, 0x3fe03b46035effac, 0xbf9eda26607d83a6, 0x3fed7fb2e73af104, 0xbf9ee27a9063cfc2, 0x3fef0fabb05822ef, 0xbf9eeacebfc4153e, 0x3fe44c7bbbd62e10, - 0xbf9ef322ee9e2ff4, 0x3fa7b5f838be6475, 0xbf9efb771cf1fbc0, 0xbfe1ec44f33f7635, 0xbf9f03cb4abf547e, 0xbfee3752c3f6ba27, 0xbf9f0c1f78061608, 0xbfee8510220d8462, - 0xbf9f1473a4c61c3a, 0xbfe2b6a459bfb2a3, 0xbf9f1cc7d0ff42f0, 0x3f90955af0afd752, 0xbf9f251bfcb16604, 0x3fe38b55da131e91, 0xbf9f2d7027dc6152, 0x3feed0b8534f5ea7, - 0xbf9f35c4528010b5, 0x3feddbec8170a74b, 0xbf9f3e187c9c5008, 0x3fe10e147b103725, 0xbf9f466ca630fb28, 0xbfb42183d759b8a8, 0xbf9f4ec0cf3dedee, 0xbfe516d97da0f69e, - 0xbf9f5714f7c30437, 0xbfef4b4a20af40ad, 0xbf9f5f691fc019df, 0xbfed14ea02ce815c, 0xbf9f67bd47350abf, 0xbfdea8e9b290ba14, 0xbf9f70116e21b2b4, 0x3fc204c6b855cb78, - 0xbf9f78659485ed9a, 0x3fe68d44337d608b, 0xbf9f80b9ba61974b, 0x3fefa68d8e33df3a, 0xbf9f890ddfb48ba3, 0x3fec30cfbc43dbb1, 0xbf9f9162047ea67d, 0x3fdb16fe8001dfe9, - 0xbf9f99b628bfc3b5, 0xbfc9e6c4f78fb5f0, 0xbf9fa20a4c77bf27, 0xbfe7ed1f6c09d335, 0xbf9faa5e6fa674ad, 0xbfefe2274f709d00, 0xbf9fb2b2924bc023, 0xbfeb3081de71d670, - 0xbf9fbb06b4677d65, 0xbfd769f9a35183db, 0xbf9fc35ad5f9884f, 0x3fd0d76cf216f23b, 0xbf9fcbaef701bcba, 0x3fe9350b295e6a07, 0xbf9fd403177ff685, 0x3feffddbc4c5a395, - 0xbf9fdc5737741188, 0x3fea1500d0ba506a, 0xbf9fe4ab56dde9a1, 0x3fd3a5887e1f9e8b, 0xbf9fecff75bd5aab, 0xbfd4aa9e5272100d, 0xbf9ff55394124081, 0xbfea63bf5f8eb27d, - 0xbf9ffda7b1dc76fe, 0xbfeff98f36fb8ad3, 0xbfa002fde78ded00, 0xbfe8df682fff25ce, 0xbfa00727f5e822b0, 0xbfcf9adfc147852d, 0xbfa00b5203fcca7d, 0x3fd869230b688b8d, - 0xbfa00f7c11cbd255, 0x3feb780d3c41e97a, 0xbfa013a61f552826, 0x3fefd545f3120f62, 0xbfa017d02c98b9de, 0x3fe790edb365f30b, 0xbfa01bfa3996756a, 0x3fc7cb10880008c3, - 0xbfa02024464e48b9, 0xbfdc0f3c38d51222, 0xbfa0244e52c021b7, 0xbfec70e056860d8a, 0xbfa028785eebee54, 0xbfef912445e0cff0, 0xbfa02ca26ad19c7c, 0xbfe62adff635f677, - 0xbfa030cc76711a1e, 0xbfbfc6e7cd709110, 0xbfa034f681ca5527, 0x3fdf994365eeb94a, 0xbfa039208cdd3b85, 0x3fed4d3fc2b99678, 0xbfa03d4a97a9bb26, 0x3fef2d6e57bdebf8, - 0xbfa04174a22fc1f9, 0x3fe4aea529d190f2, 0xbfa0459eac6f3dea, 0x3fafafc90253057c, 0xbddeacd7c60e9693, 0x3de0a9941cf8b4b6, 0xbdf7ab35f183a5a5, 0xbfeff50e60ab53f9, -] )) ), - -################ chunk 22528 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x412e240ca45a1cac, 0x41132cbd0f5c28f6, 0x41109750ba5e353f, 0x41219d7f53f7ced9, 0x412a6dd2ce560419, 0x412594458fdf3b64, 0x4132d687e3d70a3d, 0x4162d687e6b851ec, - 0x4147f7ec53333333, 0x4144bd24e8f5c28f, 0x415604df28f5c28f, 0x416084a3c0f5c28f, 0x415af956f3d70a3d, 0x41678c29dccccccd, 0x41978c29e0666666, 0x417df5e768000000, - 0x4179ec6e23333333, 0x418b8616f3333333, 0x4194a5ccb1333333, 0x4190dbd658666666, 0x419d6f3454000000, 0x41cd6f3458800000, 0x41b2b9b0a1000000, 0x41b033c4d6000000, - 0x41c133ce58000000, 0x41c9cf3fdd800000, 0x41c512cbee800000, 0x41d26580b4800000, 0x42026580b7500000, 0x41e7681cc9400000, 0x41e440b60b800000, 0x41f580c1ee000000, - 0x42002187ea700000, 0x41fa577eea200000, 0x4206fee0e1a00000, 0x4236fee0e5240000, 0x421d4223fb900000, 0x421950e38e600000, 0x422ae0f269800000, 0x423429e9e50c0000, - 0x423076af52540000, 0x423cbe991a080000, 0x426cbe991e6d0000, 0x425249567d3a0000, 0x424fa51c71f80000, 0x4260cc9781f00000, 0x426934645e4f0000, 0x4264945b26e90000, - 0x4271f71fb0450000, 0x42a1f71fb3042000, 0x4286dbac1c888000, 0x4283c731c73b0000, 0x4294ffbd626c0000, 0x429f817d75e2c000, 0x4299b971f0a34000, 0x42a674e79c564000, - 0x42d674e79fc52800, 0x42bc929723aaa000, 0x42b8b8fe3909c000, 0x42ca3facbb070000, 0x42d3b0ee69adb800, 0x42d013e736660800, 0x42dc1221836bd000, 0x430c122187b67200, - 0x42f1db9e764aa400, 0x42eee73dc74c3000, 0x430067cbf4e46000, 0x43089d2a04192600, 0x430418e103ff8a00, 0x43118b54f2236200, 0x43418b54f4d20740, 0x4326528613dd4d00, - 0x432350869c8f9e00, 0x433481bef21d7800, 0x433ec474851f6f80, 0x43391f1944ff6c80, 0x4345ee2a2eac3a80, 0x4375ee2a32068910, 0x435be72798d4a040, 0x435824a843b38580, - 0x4369a22eaea4d600, 0x43733ac8d333a5b0, 0x436f66df963f47a0, 0xc073a28c59d5433b, 0xc073a28c59d5433b, 0xc073a28c59d5433b, 0xc073a28c59d5434d, 0xc073a28c59d54329, - 0xc083a28c59d5433b, 0xc083a28c59d5433b, 0xc083a28c59d5433b, 0xc083a28c59d54344, 0xc083a28c59d54332, 0xc08d73d286bfe4d8, 0xc08d73d286bfe4d8, 0xc08d73d286bfe4d8, - 0xc08d73d286bfe4e1, 0xc08d73d286bfe4d0, 0xc093a28c59d5433b, 0xc093a28c59d5433b, 0xc093a28c59d5433b, 0xc093a28c59d5433f, 0xc093a28c59d54337, 0xc0988b2f704a940a, - 0xc0988b2f704a940a, 0xc0988b2f704a940a, 0xc0988b2f704a940e, 0xc0988b2f704a9405, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4dd, - 0xc09d73d286bfe4d4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad6, 0xc0a12e3ace9a9ad1, 0xc0a3a28c59d5433b, 0xc0a3a28c59d5433b, - 0xc0a3a28c59d5433b, 0xc0a3a28c59d5433d, 0xc0a3a28c59d54339, 0xc0a616dde50feba2, 0xc0a616dde50feba2, 0xc0a616dde50feba2, 0xc0a616dde50feba5, 0xc0a616dde50feba0, - 0xc0a88b2f704a940a, 0xc0a88b2f704a940a, 0xc0a88b2f704a940a, 0xc0a88b2f704a940c, 0xc0a88b2f704a9408, 0xc0aaff80fb853c71, 0xc0aaff80fb853c71, 0xc0aaff80fb853c71, - 0xc0aaff80fb853c73, 0xc0aaff80fb853c6f, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4db, 0xc0ad73d286bfe4d6, 0xc0afe82411fa8d40, - 0xc0afe82411fa8d40, 0xc0afe82411fa8d40, 0xc0afe82411fa8d42, 0xc0afe82411fa8d3e, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad5, - 0xc0b12e3ace9a9ad2, 0xc0b268639437ef07, 0xc0b268639437ef07, 0xc0b268639437ef07, 0xc0b268639437ef08, 0xc0b268639437ef06, 0xc0b3a28c59d5433b, 0xc0b3a28c59d5433b, - 0xc0b3a28c59d5433b, 0xc0b3a28c59d5433c, 0xc0b3a28c59d5433a, 0xc0b4dcb51f72976f, 0xc0b4dcb51f72976f, 0xc0b4dcb51f72976f, 0xc0b4dcb51f729770, 0xc0b4dcb51f72976e, - 0xc0b616dde50feba2, 0xc0b616dde50feba2, 0xc0b616dde50feba2, 0xc0b616dde50feba3, 0xc0b616dde50feba1, 0xc0b75106aaad3fd6, 0xc0b75106aaad3fd6, 0xc0b75106aaad3fd6, - 0xc0b75106aaad3fd7, 0xc0b75106aaad3fd5, 0xc0b88b2f704a940a, 0xc0b88b2f704a940a, 0xc0b88b2f704a940a, 0xc0b88b2f704a940b, 0xc0b88b2f704a9409, 0xc0b9c55835e7e83d, - 0xc0b9c55835e7e83d, 0xc0b9c55835e7e83d, 0xc0b9c55835e7e83e, 0xc0b9c55835e7e83c, 0xc0baff80fb853c71, 0xc0baff80fb853c71, 0xc0baff80fb853c71, 0xc0baff80fb853c72, - 0xc0baff80fb853c70, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a6, 0xc0bc39a9c12290a4, 0xc0bd73d286bfe4d8, 0xc0bd73d286bfe4d8, - 0xc0bd73d286bfe4d8, 0xc0bd73d286bfe4da, 0xc0bd73d286bfe4d7, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390d, 0xc0beadfb4c5d390b, - 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d41, 0xc0bfe82411fa8d3f, 0xc0c091266bcbf0ba, 0xc0c091266bcbf0ba, 0xc0c091266bcbf0ba, - 0xc0c091266bcbf0ba, 0xc0c091266bcbf0b9, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad3, 0xc0c1cb4f316944ed, - 0xc0c1cb4f316944ed, 0xc0c1cb4f316944ed, 0xc0c1cb4f316944ee, 0xc0c1cb4f316944ed, 0xc0c268639437ef07, 0xc0c268639437ef07, 0xc0c268639437ef07, 0xc0c268639437ef08, - 0xc0c268639437ef07, 0xc0c30577f7069921, 0xc0c30577f7069921, 0xc0c30577f7069921, 0xc0c30577f7069922, 0xc0c30577f7069921, 0xc0c3a28c59d5433b, 0xc0c3a28c59d5433b, - 0xc0c3a28c59d5433b, 0xc0c3a28c59d5433c, 0xc0c3a28c59d5433a, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed54, - 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976e, 0xc0c579c982414188, 0xc0c579c982414188, 0xc0c579c982414188, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3fda3f16e3d46852, 0xbf3786ac5cdce39d, 0xbfee81586a1953c0, 0xbfefa43c23fc85dc, 0x3fef90aa1ace3d07, 0xbfcf6f508364a0ba, 0xbfdfa18f39db7dc7, 0xbfec489554f09fb9, - 0xbf6d68537b03d0c3, 0xbfb2b0bfb20e497b, 0x3fefea69ab25e742, 0x3fefe5f511ddc5c9, 0x3fe3a1058d3e2c00, 0xbfecb6bcc6c2b873, 0xbfef9db7fb3caf63, 0xbfa260340aa29cc1, - 0xbfe55b8ab126a549, 0xbfe53f5384ae6858, 0x3fe6e6cae22d27b5, 0xbfd4293e8f4955dc, 0x3fefaf0521c8dc5c, 0x3feffe52edc52dfb, 0xbfd67c01dbaaccb6, 0xbfeb56af891ce586, - 0x3fea8ac8e2eb956e, 0xbfefc33898dc74e2, 0x3fb028496cc842e4, 0x3fef92ab48541c23, 0xbfc9b77d05d14d37, 0x3fdbbbeaca65664f, 0x3fe759916769c83c, 0xbfd652c786c6b0ff, - 0x3fee09fab282caf0, 0xbfe2e4a40f3ea385, 0xbfefeeceb9eee7f9, 0x3fecc8fd0a789c79, 0x3fef278f19e5c94a, 0xbfee542d027c7474, 0xbfda2cbf9926e774, 0x3fd796489c4331d2, - 0xbfa0a1298d92710f, 0xbfe35089e6beee20, 0x3fef6a50570b98df, 0xbfe7c7dc48450a96, 0xbfbab42850333fbf, 0xbfec1905372ab2a7, 0xbfe2ed3e4f383f6e, 0xbfd46d45303a1ba2, - 0x3fc902f93fb80e7e, 0x3fee20a4c6e3370c, 0xbfebb6585845277d, 0xbfebad86e5cef3c9, 0xbfeec602659332f1, 0x3fa74a081eb69e6e, 0x3fbb52cb11da3e90, 0x3fed86614c0b38b6, - 0xbfd2af94d06d0b55, 0xbfebb52130de48e8, 0x3feb5b6f9b3ed0cb, 0x3fd6c84791de947b, 0x3fdc2080ad546045, 0xbfec0f7fa0f9dbac, 0x3fe75676552aa1ec, 0xbfc6c2bbc507d601, - 0xbfeba8f0de21ea58, 0x3fe797bfb3567eaf, 0xbfde91b316619947, 0xbfef948aa152ef10, 0x3fee8d43aa98892a, 0x3fee6289d2949922, 0x3fef40137f2dab4a, 0xbfeb2ba4e38e6616, - 0xbfed00a49add331b, 0xbfeedd1091ff8e13, 0x3feff5791cd2ceee, 0xbfbf0e7a4ed36de4, 0x3fa91d9ba309ead0, 0xbfea71fd289919ff, 0xbfe50ad2e9fd00b0, 0xbfee1096a32e9c10, - 0xbfdce65a270047d4, 0x3fdf1383125ae3a8, 0xbfee022f391f8f2c, 0xbce1b19140c0c0d5, 0xbce1b19140c0c0d5, 0xbce1b19140c0c0d5, 0xbd7208d8c8a06060, 0x3d71f727375f9fa0, - 0xbcf1b19140c0c0d5, 0xbcf1b19140c0c0d5, 0xbcf1b19140c0c0d5, 0xbd7211b19140c0c1, 0x3d71ee4e6ebf3f3f, 0x3d2caeb4c3dbdbd8, 0x3d2caeb4c3dbdbd8, 0x3d2caeb4c3dbdbd8, - 0xbd711a8a59e12121, 0x3d70e575a61ededf, 0xbd01b19140c0c0d5, 0xbd01b19140c0c0d5, 0xbd01b19140c0c0d5, 0xbd70236322818182, 0x3d6fb939bafcfcfd, 0xbd32c3beb21e1e21, - 0xbd32c3beb21e1e21, 0xbd32c3beb21e1e21, 0xbd712c3beb21e1e2, 0x3d72d3c414de1e1e, 0x3d3caeb4c3dbdbd8, 0x3d3caeb4c3dbdbd8, 0x3d3caeb4c3dbdbd8, 0xbd723514b3c24242, - 0x3d71caeb4c3dbdbe, 0xbd49ef6be3151517, 0xbd49ef6be3151517, 0xbd49ef6be3151517, 0xbd733ded7c62a2a3, 0x3d74c212839d5d5d, 0xbd11b19140c0c0d5, 0xbd11b19140c0c0d5, - 0xbd11b19140c0c0d5, 0xbd7046c645030303, 0x3d6f727375f9f9f9, 0x3d45830792e4e4e2, 0x3d45830792e4e4e2, 0x3d45830792e4e4e2, 0xbd754f9f0da36364, 0x3d72b060f25c9c9c, - 0xbd42c3beb21e1e21, 0xbd42c3beb21e1e21, 0xbd42c3beb21e1e21, 0xbd725877d643c3c4, 0x3d6b4f1053787878, 0x3d23d5ec237b7b6e, 0x3d23d5ec237b7b6e, 0x3d23d5ec237b7b6e, - 0xbd6ec2a13dc84849, 0x3d709eaf611bdbdb, 0x3d4caeb4c3dbdbd8, 0x3d4caeb4c3dbdbd8, 0x3d4caeb4c3dbdbd8, 0xbd746a2967848485, 0x3d7395d6987b7b7b, 0xbd373023024e4e57, - 0xbd373023024e4e57, 0xbd373023024e4e57, 0xbd7173023024e4e5, 0x3d6d19fb9fb63635, 0xbd59ef6be3151517, 0xbd59ef6be3151517, 0xbd59ef6be3151517, 0xbd767bdaf8c54546, - 0x3d798425073ababa, 0x3d51ed30fa696967, 0x3d51ed30fa696967, 0x3d51ed30fa696967, 0xbd67096782cb4b4c, 0x3d747b4c3e9a5a5a, 0xbd21b19140c0c0d5, 0xbd21b19140c0c0d5, - 0xbd21b19140c0c0d5, 0xbd708d8c8a060607, 0x3d6ee4e6ebf3f3f3, 0xbd5659954a99999c, 0xbd5659954a99999c, 0xbd5659954a99999c, 0xbd75966552a66667, 0x3d64d3355ab33332, - 0x3d55830792e4e4e2, 0x3d55830792e4e4e2, 0x3d55830792e4e4e2, 0xbd653e7c368d8d8f, 0x3d7560c1e4b93939, 0x3d15fa4706363606, 0x3d15fa4706363606, 0x3d15fa4706363606, - 0xbd6f502dc7ce4e50, 0x3d7057e91c18d8d8, 0xbd52c3beb21e1e21, 0xbd52c3beb21e1e21, 0xbd52c3beb21e1e21, 0xbd74b0efac878788, 0x3d669e20a6f0f0ef, 0x3d5918de2b60605d, - 0x3d5918de2b60605d, 0x3d5918de2b60605d, 0xbd637390ea4fcfd1, 0x3d7646378ad81817, 0x3d33d5ec237b7b6e, 0x3d33d5ec237b7b6e, 0x3d33d5ec237b7b6e, 0xbd6d85427b909092, - 0x3d713d5ec237b7b7, 0xbd4e5bd03345454d, 0xbd4e5bd03345454d, 0xbd4e5bd03345454d, 0xbd73cb7a0668a8aa, 0x3d68690bf32eaead, 0x3d5caeb4c3dbdbd8, 0x3d5caeb4c3dbdbd8, - 0x3d5caeb4c3dbdbd8, 0xbd78d452cf09090a, 0x3d772bad30f6f6f6, 0x3d4116a342b4b4ad, 0x3d4116a342b4b4ad, 0x3d4116a342b4b4ad, 0xbd6bba572f52d2d5, 0x3d7222d468569696, - 0xbd473023024e4e57, 0xbd473023024e4e57, 0xbd473023024e4e57, 0xbd72e6046049c9cb, 0x3d6a33f73f6c6c6a, 0xbd5fbb74a3a8a8ad, 0xbd5fbb74a3a8a8ad, 0xbd5fbb74a3a8a8ad, - 0xbd5fbb74a3a8a8ad, 0x3d781122d715d5d5, 0xbd69ef6be3151517, 0xbd69ef6be3151517, 0xbd69ef6be3151517, 0xbd69ef6be3151517, 0x3d73084a0e757574, 0x3d6bfee28baa2a28, - 0x3d6bfee28baa2a28, 0x3d6bfee28baa2a28, 0xbd72008eba2aeaec, 0x3d6bfee28baa2a28, 0x3d61ed30fa696967, 0x3d61ed30fa696967, 0x3d61ed30fa696967, 0xbd77096782cb4b4c, - 0x3d61ed30fa696967, 0x3d4f6dfda4a2a299, 0x3d4f6dfda4a2a299, 0x3d4f6dfda4a2a299, 0xbd7c12404b6babad, 0x3d4f6dfda4a2a299, 0xbd31b19140c0c0d5, 0xbd31b19140c0c0d5, - 0xbd31b19140c0c0d5, 0xbd808d8c8a060607, 0x3d7ee4e6ebf3f3f3, 0xbd588fc772b1b1b7, 0xbd588fc772b1b1b7, 0xbd588fc772b1b1b7, 0xbd588fc772b1b1b7, 0x3d79dc0e23539392, - 0xbd6659954a99999c, 0xbd6659954a99999c, 0xbd6659954a99999c, 0xbd6659954a99999c, 0x3d74d3355ab33332, 0x3d6f94b92425a5a3, 0x3d6f94b92425a5a3, 0x3d6f94b92425a5a3, -] )) ), - -################ chunk 23040 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0xc0c579c982414189, 0xc0c579c982414188, 0xc0c616dde50feba2, 0xc0c616dde50feba2, 0xc0c616dde50feba2, 0xc0c616dde50feba3, 0xc0c616dde50feba2, 0xc0c6b3f247de95bc, - 0xc0c6b3f247de95bc, 0xc0c6b3f247de95bc, 0xc0c6b3f247de95bd, 0xc0c6b3f247de95bc, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd7, - 0xc0c75106aaad3fd5, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9ef, 0xc0c88b2f704a940a, 0xc0c88b2f704a940a, - 0xc0c88b2f704a940a, 0xc0c88b2f704a940a, 0xc0c88b2f704a9409, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e23, - 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83e, 0xc0c9c55835e7e83d, 0xc0ca626c98b69257, 0xc0ca626c98b69257, 0xc0ca626c98b69257, - 0xc0ca626c98b69258, 0xc0ca626c98b69257, 0xc0caff80fb853c71, 0xc0caff80fb853c71, 0xc0caff80fb853c71, 0xc0caff80fb853c72, 0xc0caff80fb853c71, 0xc0cb9c955e53e68b, - 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68a, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, - 0xc0cc39a9c12290a4, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abe, 0xc0cd73d286bfe4d8, 0xc0cd73d286bfe4d8, - 0xc0cd73d286bfe4d8, 0xc0cd73d286bfe4d9, 0xc0cd73d286bfe4d8, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef3, 0xc0ce10e6e98e8ef2, - 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390d, 0xc0ceadfb4c5d390c, 0xc0cf4b0faf2be326, 0xc0cf4b0faf2be326, 0xc0cf4b0faf2be326, - 0xc0cf4b0faf2be327, 0xc0cf4b0faf2be325, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d3f, 0xc0d0429c3a649bad, - 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, - 0xc0d091266bcbf0b9, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c6, 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad4, - 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad3, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe0, - 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ee, 0xc0d1cb4f316944ed, 0xc0d219d962d099fa, 0xc0d219d962d099fa, 0xc0d219d962d099fa, - 0xc0d219d962d099fb, 0xc0d219d962d099fa, 0xc0d268639437ef07, 0xc0d268639437ef07, 0xc0d268639437ef07, 0xc0d268639437ef08, 0xc0d268639437ef07, 0xc0d2b6edc59f4414, - 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d30577f7069921, 0xc0d30577f7069921, 0xc0d30577f7069921, 0xc0d30577f7069921, - 0xc0d30577f7069921, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, - 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, - 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4262, - 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4261, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976e, 0xc0d52b3f50d9ec7c, - 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7b, 0xc0d579c982414188, 0xc0d579c982414188, 0xc0d579c982414188, 0xc0d579c982414189, - 0xc0d579c982414188, 0xc0d5c853b3a89695, 0xc0d5c853b3a89695, 0xc0d5c853b3a89695, 0xc0d5c853b3a89696, 0xc0d5c853b3a89695, 0xc0d616dde50feba2, 0xc0d616dde50feba2, - 0xc0d616dde50feba2, 0xc0d616dde50feba3, 0xc0d616dde50feba2, 0xc0d66568167740af, 0xc0d66568167740af, 0xc0d66568167740af, 0xc0d66568167740b0, 0xc0d66568167740af, - 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, - 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d79f90dc1494e3, - 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, - 0xc0d7ee1b0d7be9f0, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d88b2f704a940a, 0xc0d88b2f704a940a, - 0xc0d88b2f704a940a, 0xc0d88b2f704a940a, 0xc0d88b2f704a9409, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e916, - 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e23, 0xc0d976ce04809330, 0xc0d976ce04809330, 0xc0d976ce04809330, - 0xc0d976ce04809331, 0xc0d976ce04809330, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83e, 0xc0d9c55835e7e83d, 0xc0da13e2674f3d4a, - 0xc0da13e2674f3d4a, 0xc0da13e2674f3d4a, 0xc0da13e2674f3d4b, 0xc0da13e2674f3d4a, 0xc0da626c98b69257, 0xc0da626c98b69257, 0xc0da626c98b69257, 0xc0da626c98b69258, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbd7035a36ded2d2f, 0x3d6f94b92425a5a3, 0x3d65830792e4e4e2, 0x3d65830792e4e4e2, 0x3d65830792e4e4e2, 0xbd753e7c368d8d8f, 0x3d65830792e4e4e2, 0x3d56e2ac03484842, - 0x3d56e2ac03484842, 0x3d56e2ac03484842, 0xbd7a4754ff2dedef, 0x3d56e2ac03484842, 0x3d25fa4706363606, 0x3d25fa4706363606, 0x3d25fa4706363606, 0xbd7f502dc7ce4e50, - 0x3d8057e91c18d8d8, 0xbd51641a41babac1, 0xbd51641a41babac1, 0xbd51641a41babac1, 0xbd51641a41babac1, 0x3d7ba6f96f915150, 0xbd62c3beb21e1e21, 0xbd62c3beb21e1e21, - 0xbd62c3beb21e1e21, 0xbd62c3beb21e1e21, 0x3d769e20a6f0f0ef, 0xbd6cd570435edee2, 0xbd6cd570435edee2, 0xbd6cd570435edee2, 0xbd6cd570435edee2, 0x3d719547de50908f, - 0x3d6918de2b60605d, 0x3d6918de2b60605d, 0x3d6918de2b60605d, 0xbd737390ea4fcfd1, 0x3d6918de2b60605d, 0x3d5e0e59343f3f38, 0x3d5e0e59343f3f38, 0x3d5e0e59343f3f38, - 0xbd787c69b2f03032, 0x3d5e0e59343f3f38, 0x3d43d5ec237b7b6e, 0x3d43d5ec237b7b6e, 0x3d43d5ec237b7b6e, 0xbd7d85427b909092, 0x3d43d5ec237b7b6e, 0xbd4470da21878796, - 0xbd4470da21878796, 0xbd4470da21878796, 0xbd4470da21878796, 0x3d7d71e4bbcf0f0d, 0xbd5e5bd03345454d, 0xbd5e5bd03345454d, 0xbd5e5bd03345454d, 0xbd5e5bd03345454d, - 0x3d78690bf32eaead, 0xbd693f99aae36367, 0xbd693f99aae36367, 0xbd693f99aae36367, 0xbd693f99aae36367, 0x3d7360332a8e4e4c, 0x3d6caeb4c3dbdbd8, 0x3d6caeb4c3dbdbd8, - 0x3d6caeb4c3dbdbd8, 0xbd71a8a59e121214, 0x3d6caeb4c3dbdbd8, 0x3d629d03329b1b17, 0x3d629d03329b1b17, 0x3d629d03329b1b17, 0xbd76b17e66b27274, 0x3d629d03329b1b17, - 0x3d5116a342b4b4ad, 0x3d5116a342b4b4ad, 0x3d5116a342b4b4ad, 0xbd7bba572f52d2d5, 0x3d5116a342b4b4ad, 0xbd2865fefe6666a7, 0xbd2865fefe6666a7, 0xbd2865fefe6666a7, - 0xbd806197fbf9999b, 0x3d7f3cd0080ccccb, 0xbd573023024e4e57, 0xbd573023024e4e57, 0xbd573023024e4e57, 0xbd573023024e4e57, 0x3d7a33f73f6c6c6a, 0xbd65a9c31267e7ec, - 0xbd65a9c31267e7ec, 0xbd65a9c31267e7ec, 0xbd65a9c31267e7ec, 0xbd65a9c31267e7ec, 0xbd6fbb74a3a8a8ad, 0xbd6fbb74a3a8a8ad, 0xbd6fbb74a3a8a8ad, 0xbd6fbb74a3a8a8ad, - 0x3d881122d715d5d5, 0xbd74e6931a74b4b7, 0xbd74e6931a74b4b7, 0xbd74e6931a74b4b7, 0xbd74e6931a74b4b7, 0x3d858cb672c5a5a5, 0xbd79ef6be3151517, 0xbd79ef6be3151517, - 0xbd79ef6be3151517, 0xbd79ef6be3151517, 0x3d83084a0e757574, 0xbd7ef844abb57578, 0xbd7ef844abb57578, 0xbd7ef844abb57578, 0xbd7ef844abb57578, 0x3d8083ddaa254544, - 0x3d7bfee28baa2a28, 0x3d7bfee28baa2a28, 0x3d7bfee28baa2a28, 0xbd82008eba2aeaec, 0x3d7bfee28baa2a28, 0x3d76f609c309c9c7, 0x3d76f609c309c9c7, 0x3d76f609c309c9c7, - 0xbd8484fb1e7b1b1c, 0x3d76f609c309c9c7, 0x3d71ed30fa696967, 0x3d71ed30fa696967, 0x3d71ed30fa696967, 0xbd87096782cb4b4c, 0x3d71ed30fa696967, 0x3d69c8b06392120d, - 0x3d69c8b06392120d, 0x3d69c8b06392120d, 0x3d69c8b06392120d, 0x3d69c8b06392120d, 0x3d5f6dfda4a2a299, 0x3d5f6dfda4a2a299, 0x3d5f6dfda4a2a299, 0x3d5f6dfda4a2a299, - 0x3d5f6dfda4a2a299, 0x3d4695350442422e, 0x3d4695350442422e, 0x3d4695350442422e, 0x3d4695350442422e, 0x3d4695350442422e, 0xbd41b19140c0c0d5, 0xbd41b19140c0c0d5, - 0xbd41b19140c0c0d5, 0xbd41b19140c0c0d5, 0xbd41b19140c0c0d5, 0xbd5cfc2bc2e1e1ec, 0xbd5cfc2bc2e1e1ec, 0xbd5cfc2bc2e1e1ec, 0xbd5cfc2bc2e1e1ec, 0xbd5cfc2bc2e1e1ec, - 0xbd688fc772b1b1b7, 0xbd688fc772b1b1b7, 0xbd688fc772b1b1b7, 0xbd688fc772b1b1b7, 0xbd688fc772b1b1b7, 0xbd7150bc81f9393c, 0xbd7150bc81f9393c, 0xbd7150bc81f9393c, - 0xbd7150bc81f9393c, 0x3d8757a1bf036362, 0xbd7659954a99999c, 0xbd7659954a99999c, 0xbd7659954a99999c, 0xbd7659954a99999c, 0x3d84d3355ab33332, 0xbd7b626e1339f9fd, - 0xbd7b626e1339f9fd, 0xbd7b626e1339f9fd, 0xbd7b626e1339f9fd, 0x3d824ec8f6630302, 0x3d7f94b92425a5a3, 0x3d7f94b92425a5a3, 0x3d7f94b92425a5a3, 0xbd8035a36ded2d2f, - 0x3d7f94b92425a5a3, 0x3d7a8be05b854542, 0x3d7a8be05b854542, 0x3d7a8be05b854542, 0xbd82ba0fd23d5d5f, 0x3d7a8be05b854542, 0x3d75830792e4e4e2, 0x3d75830792e4e4e2, - 0x3d75830792e4e4e2, 0xbd853e7c368d8d8f, 0x3d75830792e4e4e2, 0x3d707a2eca448482, 0x3d707a2eca448482, 0x3d707a2eca448482, 0xbd87c2e89addbdbf, 0x3d707a2eca448482, - 0x3d66e2ac03484842, 0x3d66e2ac03484842, 0x3d66e2ac03484842, 0x3d66e2ac03484842, 0x3d66e2ac03484842, 0x3d59a1f4e40f0f03, 0x3d59a1f4e40f0f03, 0x3d59a1f4e40f0f03, - 0x3d59a1f4e40f0f03, 0x3d59a1f4e40f0f03, 0x3d35fa4706363606, 0x3d35fa4706363606, 0x3d35fa4706363606, 0x3d35fa4706363606, 0x3d35fa4706363606, 0xbd4d49a2c1e7e800, - 0xbd4d49a2c1e7e800, 0xbd4d49a2c1e7e800, 0xbd4d49a2c1e7e800, 0xbd4d49a2c1e7e800, 0xbd61641a41babac1, 0xbd61641a41babac1, 0xbd61641a41babac1, 0xbd61641a41babac1, - 0xbd61641a41babac1, 0xbd6b75cbd2fb7b82, 0xbd6b75cbd2fb7b82, 0xbd6b75cbd2fb7b82, 0xbd6b75cbd2fb7b82, 0xbd6b75cbd2fb7b82, 0xbd72c3beb21e1e21, 0xbd72c3beb21e1e21, - 0xbd72c3beb21e1e21, 0xbd72c3beb21e1e21, 0x3d869e20a6f0f0ef, 0xbd77cc977abe7e82, 0xbd77cc977abe7e82, 0xbd77cc977abe7e82, 0xbd77cc977abe7e82, 0x3d8419b442a0c0bf, - 0xbd7cd570435edee2, 0xbd7cd570435edee2, 0xbd7cd570435edee2, 0xbd7cd570435edee2, 0x3d819547de50908f, 0x3d7e21b6f400c0bd, 0x3d7e21b6f400c0bd, 0x3d7e21b6f400c0bd, - 0xbd80ef2485ff9fa1, 0x3d7e21b6f400c0bd, 0x3d7918de2b60605d, 0x3d7918de2b60605d, 0x3d7918de2b60605d, 0xbd837390ea4fcfd1, 0x3d7918de2b60605d, 0x3d74100562bffffd, - 0x3d74100562bffffd, 0x3d74100562bffffd, 0xbd85f7fd4ea00002, 0x3d74100562bffffd, 0x3d6e0e59343f3f38, 0x3d6e0e59343f3f38, 0x3d6e0e59343f3f38, 0xbd887c69b2f03032, -] )) ), - -################ chunk 23552 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0xc0da626c98b69257, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0daff80fb853c71, 0xc0daff80fb853c71, - 0xc0daff80fb853c71, 0xc0daff80fb853c71, 0xc0daff80fb853c71, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, - 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, - 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a4, 0xc0dc8833f289e5b2, - 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b1, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, - 0xc0dcd6be23f13abe, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcb, 0xc0dd73d286bfe4d8, 0xc0dd73d286bfe4d8, - 0xc0dd73d286bfe4d8, 0xc0dd73d286bfe4d9, 0xc0dd73d286bfe4d8, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e6, 0xc0ddc25cb82739e5, - 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef3, 0xc0de10e6e98e8ef2, 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, - 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0defc857dc48e19, - 0x4330000000000000, 0x4330000000000001, 0x432ffffffffffffe, 0x4340000000000000, 0x433fffffffffffff, 0x43265286144ada42, 0x432350869d91c44a, 0x431418e104164f9c, - 0x401921fb54442d18, 0x402921fb54442d18, 0x403921fb54442d18, 0x4127f7eac1891f4d, 0x415df5e7364f130d, 0x5fe7dddf6b095ff1, 0x601dd55745cbb7ed, 0x6052a5568b9f52f4, - 0x7fefffffffffffff, 0x7fdfffffffffffff, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5434d, 0x4073a28c59d54329, 0x4083a28c59d5433b, - 0x4083a28c59d5433b, 0x4083a28c59d5433b, 0x4083a28c59d54344, 0x4083a28c59d54332, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4e1, - 0x408d73d286bfe4d0, 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433f, 0x4093a28c59d54337, 0x40988b2f704a940a, 0x40988b2f704a940a, - 0x40988b2f704a940a, 0x40988b2f704a940e, 0x40988b2f704a9405, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4dd, 0x409d73d286bfe4d4, - 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad6, 0x40a12e3ace9a9ad1, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, - 0x40a3a28c59d5433d, 0x40a3a28c59d54339, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba5, 0x40a616dde50feba0, 0x40a88b2f704a940a, - 0x40a88b2f704a940a, 0x40a88b2f704a940a, 0x40a88b2f704a940c, 0x40a88b2f704a9408, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c73, - 0x40aaff80fb853c6f, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4db, 0x40ad73d286bfe4d6, 0x40afe82411fa8d40, 0x40afe82411fa8d40, - 0x40afe82411fa8d40, 0x40afe82411fa8d42, 0x40afe82411fa8d3e, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad5, 0x40b12e3ace9a9ad2, - 0x40b268639437ef07, 0x40b268639437ef07, 0x40b268639437ef07, 0x40b268639437ef08, 0x40b268639437ef06, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, - 0x40b3a28c59d5433c, 0x40b3a28c59d5433a, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f729770, 0x40b4dcb51f72976e, 0x40b616dde50feba2, - 0x40b616dde50feba2, 0x40b616dde50feba2, 0x40b616dde50feba3, 0x40b616dde50feba1, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd7, - 0x40b75106aaad3fd5, 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940b, 0x40b88b2f704a9409, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, - 0x40b9c55835e7e83d, 0x40b9c55835e7e83e, 0x40b9c55835e7e83c, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c72, 0x40baff80fb853c70, - 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, 0x40bc39a9c12290a6, 0x40bc39a9c12290a4, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, - 0x40bd73d286bfe4da, 0x40bd73d286bfe4d7, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390d, 0x40beadfb4c5d390b, 0x40bfe82411fa8d40, - 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, 0x40bfe82411fa8d41, 0x40bfe82411fa8d3f, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, - 0x40c091266bcbf0b9, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad3, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, - 0x40c1cb4f316944ed, 0x40c1cb4f316944ee, 0x40c1cb4f316944ed, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef08, 0x40c268639437ef07, - 0x40c30577f7069921, 0x40c30577f7069921, 0x40c30577f7069921, 0x40c30577f7069922, 0x40c30577f7069921, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, - 0x40c3a28c59d5433c, 0x40c3a28c59d5433a, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed54, 0x40c4dcb51f72976f, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d6e0e59343f3f38, 0x3d63fca7a2fe7e78, 0x3d63fca7a2fe7e78, 0x3d63fca7a2fe7e78, 0x3d63fca7a2fe7e78, 0x3d63fca7a2fe7e78, 0x3d53d5ec237b7b6e, 0x3d53d5ec237b7b6e, - 0x3d53d5ec237b7b6e, 0x3d53d5ec237b7b6e, 0x3d53d5ec237b7b6e, 0xbcf35dbfc1818507, 0xbcf35dbfc1818507, 0xbcf35dbfc1818507, 0xbcf35dbfc1818507, 0xbcf35dbfc1818507, - 0xbd5470da21878796, 0xbd5470da21878796, 0xbd5470da21878796, 0xbd5470da21878796, 0xbd5470da21878796, 0xbd644a1ea204848c, 0xbd644a1ea204848c, 0xbd644a1ea204848c, - 0xbd644a1ea204848c, 0xbd644a1ea204848c, 0xbd6e5bd03345454d, 0xbd6e5bd03345454d, 0xbd6e5bd03345454d, 0xbd6e5bd03345454d, 0x3d88690bf32eaead, 0xbd7436c0e2430307, - 0xbd7436c0e2430307, 0xbd7436c0e2430307, 0xbd7436c0e2430307, 0x3d85e49f8ede7e7d, 0xbd793f99aae36367, 0xbd793f99aae36367, 0xbd793f99aae36367, 0xbd793f99aae36367, - 0x3d8360332a8e4e4c, 0xbd7e48727383c3c8, 0xbd7e48727383c3c8, 0xbd7e48727383c3c8, 0xbd7e48727383c3c8, 0x3d80dbc6c63e1e1c, 0x3d7caeb4c3dbdbd8, 0x3d7caeb4c3dbdbd8, - 0x3d7caeb4c3dbdbd8, 0xbd81a8a59e121214, 0x3d7caeb4c3dbdbd8, 0x3d77a5dbfb3b7b78, 0x3d77a5dbfb3b7b78, 0x3d77a5dbfb3b7b78, 0xbd842d1202624244, 0x3d77a5dbfb3b7b78, - 0x3d729d03329b1b17, 0x3d729d03329b1b17, 0x3d729d03329b1b17, 0xbd86b17e66b27274, 0x3d729d03329b1b17, 0x3d6b2854d3f5756e, 0x3d6b2854d3f5756e, 0x3d6b2854d3f5756e, - 0x3d6b2854d3f5756e, 0x3d6b2854d3f5756e, 0x3d6116a342b4b4ad, 0x3d6116a342b4b4ad, 0x3d6116a342b4b4ad, 0x3d6116a342b4b4ad, 0x3d6116a342b4b4ad, 0x3d4c13c6c5cfcfb0, - 0x3febf996908bb506, 0x3fb053c35068e10d, 0x3fec305ff352c3c8, 0xbfeb2a66c8f35586, 0xbf8c9176a7414f8f, 0xbfce3c19275e1ff0, 0xbfa3c7ae38d5f2e3, 0xbfaeef2de8eeb189, - 0xbcb1a62633145c07, 0xbcc1a62633145c07, 0xbcd1a62633145c07, 0xbfe6a09e6681b409, 0xbfe6a09e669be136, 0xbfd23d1bb04074f8, 0xbfa1c2f8985056fe, 0xbfef79889b7413b3, - 0x3f7452fc98b34e97, 0x3feffff98bb3443c, 0x3ce1b19140c0c0d5, 0x3ce1b19140c0c0d5, 0x3ce1b19140c0c0d5, 0x3d7208d8c8a06060, 0xbd71f727375f9fa0, 0x3cf1b19140c0c0d5, - 0x3cf1b19140c0c0d5, 0x3cf1b19140c0c0d5, 0x3d7211b19140c0c1, 0xbd71ee4e6ebf3f3f, 0xbd2caeb4c3dbdbd8, 0xbd2caeb4c3dbdbd8, 0xbd2caeb4c3dbdbd8, 0x3d711a8a59e12121, - 0xbd70e575a61ededf, 0x3d01b19140c0c0d5, 0x3d01b19140c0c0d5, 0x3d01b19140c0c0d5, 0x3d70236322818182, 0xbd6fb939bafcfcfd, 0x3d32c3beb21e1e21, 0x3d32c3beb21e1e21, - 0x3d32c3beb21e1e21, 0x3d712c3beb21e1e2, 0xbd72d3c414de1e1e, 0xbd3caeb4c3dbdbd8, 0xbd3caeb4c3dbdbd8, 0xbd3caeb4c3dbdbd8, 0x3d723514b3c24242, 0xbd71caeb4c3dbdbe, - 0x3d49ef6be3151517, 0x3d49ef6be3151517, 0x3d49ef6be3151517, 0x3d733ded7c62a2a3, 0xbd74c212839d5d5d, 0x3d11b19140c0c0d5, 0x3d11b19140c0c0d5, 0x3d11b19140c0c0d5, - 0x3d7046c645030303, 0xbd6f727375f9f9f9, 0xbd45830792e4e4e2, 0xbd45830792e4e4e2, 0xbd45830792e4e4e2, 0x3d754f9f0da36364, 0xbd72b060f25c9c9c, 0x3d42c3beb21e1e21, - 0x3d42c3beb21e1e21, 0x3d42c3beb21e1e21, 0x3d725877d643c3c4, 0xbd6b4f1053787878, 0xbd23d5ec237b7b6e, 0xbd23d5ec237b7b6e, 0xbd23d5ec237b7b6e, 0x3d6ec2a13dc84849, - 0xbd709eaf611bdbdb, 0xbd4caeb4c3dbdbd8, 0xbd4caeb4c3dbdbd8, 0xbd4caeb4c3dbdbd8, 0x3d746a2967848485, 0xbd7395d6987b7b7b, 0x3d373023024e4e57, 0x3d373023024e4e57, - 0x3d373023024e4e57, 0x3d7173023024e4e5, 0xbd6d19fb9fb63635, 0x3d59ef6be3151517, 0x3d59ef6be3151517, 0x3d59ef6be3151517, 0x3d767bdaf8c54546, 0xbd798425073ababa, - 0xbd51ed30fa696967, 0xbd51ed30fa696967, 0xbd51ed30fa696967, 0x3d67096782cb4b4c, 0xbd747b4c3e9a5a5a, 0x3d21b19140c0c0d5, 0x3d21b19140c0c0d5, 0x3d21b19140c0c0d5, - 0x3d708d8c8a060607, 0xbd6ee4e6ebf3f3f3, 0x3d5659954a99999c, 0x3d5659954a99999c, 0x3d5659954a99999c, 0x3d75966552a66667, 0xbd64d3355ab33332, 0xbd55830792e4e4e2, - 0xbd55830792e4e4e2, 0xbd55830792e4e4e2, 0x3d653e7c368d8d8f, 0xbd7560c1e4b93939, 0xbd15fa4706363606, 0xbd15fa4706363606, 0xbd15fa4706363606, 0x3d6f502dc7ce4e50, - 0xbd7057e91c18d8d8, 0x3d52c3beb21e1e21, 0x3d52c3beb21e1e21, 0x3d52c3beb21e1e21, 0x3d74b0efac878788, 0xbd669e20a6f0f0ef, 0xbd5918de2b60605d, 0xbd5918de2b60605d, - 0xbd5918de2b60605d, 0x3d637390ea4fcfd1, 0xbd7646378ad81817, 0xbd33d5ec237b7b6e, 0xbd33d5ec237b7b6e, 0xbd33d5ec237b7b6e, 0x3d6d85427b909092, 0xbd713d5ec237b7b7, - 0x3d4e5bd03345454d, 0x3d4e5bd03345454d, 0x3d4e5bd03345454d, 0x3d73cb7a0668a8aa, 0xbd68690bf32eaead, 0xbd5caeb4c3dbdbd8, 0xbd5caeb4c3dbdbd8, 0xbd5caeb4c3dbdbd8, - 0x3d78d452cf09090a, 0xbd772bad30f6f6f6, 0xbd4116a342b4b4ad, 0xbd4116a342b4b4ad, 0xbd4116a342b4b4ad, 0x3d6bba572f52d2d5, 0xbd7222d468569696, 0x3d473023024e4e57, - 0x3d473023024e4e57, 0x3d473023024e4e57, 0x3d72e6046049c9cb, 0xbd6a33f73f6c6c6a, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, 0x3d5fbb74a3a8a8ad, - 0xbd781122d715d5d5, 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0x3d69ef6be3151517, 0xbd73084a0e757574, 0xbd6bfee28baa2a28, 0xbd6bfee28baa2a28, - 0xbd6bfee28baa2a28, 0x3d72008eba2aeaec, 0xbd6bfee28baa2a28, 0xbd61ed30fa696967, 0xbd61ed30fa696967, 0xbd61ed30fa696967, 0x3d77096782cb4b4c, 0xbd61ed30fa696967, - 0xbd4f6dfda4a2a299, 0xbd4f6dfda4a2a299, 0xbd4f6dfda4a2a299, 0x3d7c12404b6babad, 0xbd4f6dfda4a2a299, 0x3d31b19140c0c0d5, 0x3d31b19140c0c0d5, 0x3d31b19140c0c0d5, - 0x3d808d8c8a060607, 0xbd7ee4e6ebf3f3f3, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0x3d588fc772b1b1b7, 0xbd79dc0e23539392, 0x3d6659954a99999c, -] )) ), -] -sin_float32_t = [ - -################ chunk 0 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x441d1463, 0x441d1463, 0x441d1463, - 0x441d1463, 0x441d1463, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x449d1463, - 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x44c4597c, 0x44c4597c, 0x44c4597c, 0x44c4597c, - 0x44c4597c, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x450971d6, 0x450971d6, - 0x450971d6, 0x450971d6, 0x450971d6, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, - 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4544597c, 0x4544597c, 0x4544597c, - 0x4544597c, 0x4544597c, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x456b9e94, - 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x457f4121, 0x457f4121, 0x457f4121, 0x457f4121, - 0x457f4121, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x4593431d, 0x4593431d, - 0x4593431d, 0x4593431d, 0x4593431d, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, - 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45b0b6ef, 0x45b0b6ef, 0x45b0b6ef, - 0x45b0b6ef, 0x45b0b6ef, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45c4597c, - 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, - 0x45ce2ac2, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45e1cd4e, 0x45e1cd4e, - 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, - 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45ff4121, 0x45ff4121, 0x45ff4121, - 0x45ff4121, 0x45ff4121, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x460971d6, - 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, - 0x460e5a7a, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x46182bc0, 0x46182bc0, - 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, - 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4626e5a9, 0x4626e5a9, 0x4626e5a9, - 0x4626e5a9, 0x4626e5a9, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x4630b6ef, - 0x4630b6ef, 0x4630b6ef, 0x4630b6ef, 0x4630b6ef, 0x46359f92, 0x46359f92, 0x46359f92, 0x46359f92, - 0x46359f92, 0x463a8835, 0x463a8835, 0x463a8835, 0x463a8835, 0x463a8835, 0x463f70d8, 0x463f70d8, - 0x463f70d8, 0x463f70d8, 0x463f70d8, 0x4644597c, 0x4644597c, 0x4644597c, 0x4644597c, 0x4644597c, - 0x4649421f, 0x4649421f, 0x4649421f, 0x4649421f, 0x4649421f, 0x464e2ac2, 0x464e2ac2, 0x464e2ac2, - 0x464e2ac2, 0x464e2ac2, 0x46531365, 0x46531365, 0x46531365, 0x46531365, 0x46531365, 0x4657fc08, - 0x4657fc08, 0x4657fc08, 0x4657fc08, 0x4657fc08, 0x465ce4ab, 0x465ce4ab, 0x465ce4ab, 0x465ce4ab, - 0x465ce4ab, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4666b5f1, 0x4666b5f1, - 0x4666b5f1, 0x4666b5f1, 0x4666b5f1, 0x466b9e94, 0x466b9e94, 0x466b9e94, 0x466b9e94, 0x466b9e94, - 0x46708737, 0x46708737, 0x46708737, 0x46708737, 0x46708737, 0x46756fda, 0x46756fda, 0x46756fda, - 0x46756fda, 0x46756fda, 0x467a587d, 0x467a587d, 0x467a587d, 0x467a587d, 0x467a587d, 0x467f4121, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x36c55799, 0x36c55799, 0x36c55799, 0x36c55799, 0x36c55799, 0x37455799, 0x37455799, 0x37455799, - 0x37455799, 0x37455799, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0x37c55799, - 0x37c55799, 0x37c55799, 0x37c55799, 0x37c55799, 0x387b56bf, 0x387b56bf, 0x387b56bf, 0x387b56bf, - 0x387b56bf, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb8e9a9ad, 0xb8e9a9ad, - 0xb8e9a9ad, 0xb8e9a9ad, 0xb8e9a9ad, 0x38455799, 0x38455799, 0x38455799, 0x38455799, 0x38455799, - 0xb821fd74, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0x38fb56bf, 0x38fb56bf, 0x38fb56bf, - 0x38fb56bf, 0x38fb56bf, 0x380f5872, 0x380f5872, 0x380f5872, 0x380f5872, 0x380f5872, 0xb857fc9b, - 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0x38e0572c, 0x38e0572c, 0x38e0572c, 0x38e0572c, - 0x38e0572c, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0x393c810f, 0x393c810f, - 0x393c810f, 0x393c810f, 0x393c810f, 0x38c55799, 0x38c55799, 0x38c55799, 0x38c55799, 0x38c55799, - 0x370d6891, 0x370d6891, 0x370d6891, 0x370d6891, 0x370d6891, 0xb8a1fd74, 0xb8a1fd74, 0xb8a1fd74, - 0xb8a1fd74, 0xb8a1fd74, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0x397b56bf, - 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x3921817c, 0x3921817c, 0x3921817c, 0x3921817c, - 0x3921817c, 0x388f5872, 0x388f5872, 0x388f5872, 0x388f5872, 0x388f5872, 0xb7914852, 0xb7914852, - 0xb7914852, 0xb7914852, 0xb7914852, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, - 0xb945d391, 0xb945d391, 0xb945d391, 0xb945d391, 0xb945d391, 0x3960572c, 0x3960572c, 0x3960572c, - 0x3960572c, 0x3960572c, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9e9a9ad, - 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0x39e96bb1, 0x39e96bb1, 0x39e96bb1, 0x39e96bb1, - 0x39e96bb1, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x398f966e, 0x398f966e, - 0x398f966e, 0x398f966e, 0x398f966e, 0x39455799, 0x39455799, 0x39455799, 0x39455799, 0x39455799, - 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x378d6891, 0x378d6891, 0x378d6891, - 0x378d6891, 0x378d6891, 0xb8905062, 0xb8905062, 0xb8905062, 0xb8905062, 0xb8905062, 0xb921fd74, - 0xb921fd74, 0xb921fd74, 0xb921fd74, 0xb921fd74, 0xb97bd2b7, 0xb97bd2b7, 0xb97bd2b7, 0xb97bd2b7, - 0xb97bd2b7, 0xb9aad3fd, 0xb9aad3fd, 0xb9aad3fd, 0xb9aad3fd, 0xb9aad3fd, 0xb9d7be9f, 0xb9d7be9f, - 0xb9d7be9f, 0xb9d7be9f, 0xb9d7be9f, 0x39fb56bf, 0x39fb56bf, 0x39fb56bf, 0x39fb56bf, 0x39fb56bf, - 0x39ce6c1d, 0x39ce6c1d, 0x39ce6c1d, 0x39ce6c1d, 0x39ce6c1d, 0x39a1817c, 0x39a1817c, 0x39a1817c, - 0x39a1817c, 0x39a1817c, 0x39692db5, 0x39692db5, 0x39692db5, 0x39692db5, 0x39692db5, 0x390f5872, - 0x390f5872, 0x390f5872, 0x390f5872, 0x390f5872, 0x38560cbb, 0x38560cbb, 0x38560cbb, 0x38560cbb, - 0x38560cbb, 0xb8114852, 0xb8114852, 0xb8114852, 0xb8114852, 0xb8114852, 0xb8fc4eb0, 0xb8fc4eb0, - 0xb8fc4eb0, 0xb8fc4eb0, 0xb8fc4eb0, 0xb957fc9b, 0xb957fc9b, 0xb957fc9b, 0xb957fc9b, 0xb957fc9b, - 0xb998e8ef, 0xb998e8ef, 0xb998e8ef, 0xb998e8ef, 0xb998e8ef, 0xb9c5d390, 0xb9c5d390, 0xb9c5d390, - 0xb9c5d390, 0xb9c5d390, 0xb9f2be32, 0xb9f2be32, 0xb9f2be32, 0xb9f2be32, 0xb9f2be32, 0x39e0572c, -] )) ), - -################ chunk 512 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x467f4121, 0x467f4121, 0x467f4121, 0x467f4121, 0x468214e2, 0x468214e2, 0x468214e2, 0x468214e2, - 0x468214e2, 0x46848933, 0x46848933, 0x46848933, 0x46848933, 0x46848933, 0x4686fd85, 0x4686fd85, - 0x4686fd85, 0x4686fd85, 0x4686fd85, 0x468971d6, 0x468971d6, 0x468971d6, 0x468971d6, 0x468971d6, - 0x468be628, 0x468be628, 0x468be628, 0x468be628, 0x468be628, 0x468e5a7a, 0x468e5a7a, 0x468e5a7a, - 0x468e5a7a, 0x468e5a7a, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4693431d, - 0x4693431d, 0x4693431d, 0x4693431d, 0x4693431d, 0x4695b76e, 0x4695b76e, 0x4695b76e, 0x4695b76e, - 0x4695b76e, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x469aa011, 0x469aa011, - 0x469aa011, 0x469aa011, 0x469aa011, 0x469d1463, 0x469d1463, 0x469d1463, 0x469d1463, 0x469d1463, - 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x46a1fd06, 0x46a1fd06, 0x46a1fd06, - 0x46a1fd06, 0x46a1fd06, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a6e5a9, - 0x46a6e5a9, 0x46a6e5a9, 0x46a6e5a9, 0x46a6e5a9, 0x46a959fb, 0x46a959fb, 0x46a959fb, 0x46a959fb, - 0x46a959fb, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46ae429e, 0x46ae429e, - 0x46ae429e, 0x46ae429e, 0x46ae429e, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, - 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b59f92, 0x46b59f92, 0x46b59f92, - 0x46b59f92, 0x46b59f92, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46ba8835, - 0x46ba8835, 0x46ba8835, 0x46ba8835, 0x46ba8835, 0x46bcfc87, 0x46bcfc87, 0x46bcfc87, 0x46bcfc87, - 0x46bcfc87, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46c1e52a, 0x46c1e52a, - 0x46c1e52a, 0x46c1e52a, 0x46c1e52a, 0x46c4597c, 0x46c4597c, 0x46c4597c, 0x46c4597c, 0x46c4597c, - 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c9421f, 0x46c9421f, 0x46c9421f, - 0x46c9421f, 0x46c9421f, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46ce2ac2, - 0x46ce2ac2, 0x46ce2ac2, 0x46ce2ac2, 0x46ce2ac2, 0x46d09f13, 0x46d09f13, 0x46d09f13, 0x46d09f13, - 0x46d09f13, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d587b6, 0x46d587b6, - 0x46d587b6, 0x46d587b6, 0x46d587b6, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, - 0x46da7059, 0x46da7059, 0x46da7059, 0x46da7059, 0x46da7059, 0x46dce4ab, 0x46dce4ab, 0x46dce4ab, - 0x46dce4ab, 0x46dce4ab, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46e1cd4e, - 0x46e1cd4e, 0x46e1cd4e, 0x46e1cd4e, 0x46e1cd4e, 0x46e441a0, 0x46e441a0, 0x46e441a0, 0x46e441a0, - 0x46e441a0, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e92a43, 0x46e92a43, - 0x46e92a43, 0x46e92a43, 0x46e92a43, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, - 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46f08737, 0x46f08737, 0x46f08737, - 0x46f08737, 0x46f08737, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f56fda, - 0x46f56fda, 0x46f56fda, 0x46f56fda, 0x46f56fda, 0x46f7e42c, 0x46f7e42c, 0x46f7e42c, 0x46f7e42c, - 0x46f7e42c, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fccccf, 0x46fccccf, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x39e0572c, 0x39e0572c, 0x39e0572c, 0x39e0572c, 0x39b36c8a, 0x39b36c8a, 0x39b36c8a, 0x39b36c8a, - 0x39b36c8a, 0xba3cbf0b, 0xba3cbf0b, 0xba3cbf0b, 0xba3cbf0b, 0xba3cbf0b, 0x39332e8e, 0x39332e8e, - 0x39332e8e, 0x39332e8e, 0x39332e8e, 0xba69a9ab, 0xba69a9ab, 0xba69a9ab, 0xba69a9ab, 0xba69a9ab, - 0xb4f7f042, 0xb4f7f042, 0xb4f7f042, 0xb4f7f042, 0xb4f7f042, 0x3a696baf, 0x3a696baf, 0x3a696baf, - 0x3a696baf, 0x3a696baf, 0xb934267f, 0xb934267f, 0xb934267f, 0xb934267f, 0xb934267f, 0x3a3c810e, - 0x3a3c810e, 0x3a3c810e, 0x3a3c810e, 0x3a3c810e, 0xb9b3e882, 0xb9b3e882, 0xb9b3e882, 0xb9b3e882, - 0xb9b3e882, 0x3a0f966d, 0x3a0f966d, 0x3a0f966d, 0x3a0f966d, 0x3a0f966d, 0xba06dee2, 0xba06dee2, - 0xba06dee2, 0xba06dee2, 0xba06dee2, 0x39c55798, 0x39c55798, 0x39c55798, 0x39c55798, 0x39c55798, - 0xba33c984, 0xba33c984, 0xba33c984, 0xba33c984, 0xba33c984, 0x395704ab, 0x395704ab, 0x395704ab, - 0x395704ab, 0x395704ab, 0xba60b424, 0xba60b424, 0xba60b424, 0xba60b424, 0xba60b424, 0x380d6891, - 0x380d6891, 0x380d6891, 0x380d6891, 0x380d6891, 0x3a726136, 0x3a726136, 0x3a726136, 0x3a726136, - 0x3a726136, 0xb9105062, 0xb9105062, 0xb9105062, 0xb9105062, 0xb9105062, 0x3a457695, 0x3a457695, - 0x3a457695, 0x3a457695, 0x3a457695, 0xb9a1fd74, 0xb9a1fd74, 0xb9a1fd74, 0xb9a1fd74, 0xb9a1fd74, - 0x3a188bf4, 0x3a188bf4, 0x3a188bf4, 0x3a188bf4, 0x3a188bf4, 0xb9fbd2b7, 0xb9fbd2b7, 0xb9fbd2b7, - 0xb9fbd2b7, 0xb9fbd2b7, 0x39d742a6, 0x39d742a6, 0x39d742a6, 0x39d742a6, 0x39d742a6, 0xba2ad3fd, - 0xba2ad3fd, 0xba2ad3fd, 0xba2ad3fd, 0xba2ad3fd, 0x397adac7, 0x397adac7, 0x397adac7, 0x397adac7, - 0x397adac7, 0xba57be9d, 0xba57be9d, 0xba57be9d, 0xba57be9d, 0xba57be9d, 0x388e6082, 0x388e6082, - 0x388e6082, 0x388e6082, 0x388e6082, 0x3a7b56bd, 0x3a7b56bd, 0x3a7b56bd, 0x3a7b56bd, 0x3a7b56bd, - 0xb8d8f48b, 0xb8d8f48b, 0xb8d8f48b, 0xb8d8f48b, 0xb8d8f48b, 0x3a4e6c1c, 0x3a4e6c1c, 0x3a4e6c1c, - 0x3a4e6c1c, 0x3a4e6c1c, 0xb9901266, 0xb9901266, 0xb9901266, 0xb9901266, 0xb9901266, 0x3a21817b, - 0x3a21817b, 0x3a21817b, 0x3a21817b, 0x3a21817b, 0xb9e9e7a9, 0xb9e9e7a9, 0xb9e9e7a9, 0xb9e9e7a9, - 0xb9e9e7a9, 0x39e92db5, 0x39e92db5, 0x39e92db5, 0x39e92db5, 0x39e92db5, 0xba21de76, 0xba21de76, - 0xba21de76, 0xba21de76, 0xba21de76, 0x398f5872, 0x398f5872, 0x398f5872, 0x398f5872, 0x398f5872, - 0xba4ec916, 0xba4ec916, 0xba4ec916, 0xba4ec916, 0xba4ec916, 0x38d60cbb, 0x38d60cbb, 0x38d60cbb, - 0x38d60cbb, 0x38d60cbb, 0xba7bb3b7, 0xba7bb3b7, 0xba7bb3b7, 0xba7bb3b7, 0xba7bb3b7, 0xb8914852, - 0xb8914852, 0xb8914852, 0xb8914852, 0xb8914852, 0x3a5761a3, 0x3a5761a3, 0x3a5761a3, 0x3a5761a3, - 0x3a5761a3, 0xb97c4eaf, 0xb97c4eaf, 0xb97c4eaf, 0xb97c4eaf, 0xb97c4eaf, 0x3a2a7702, 0x3a2a7702, - 0x3a2a7702, 0x3a2a7702, 0x3a2a7702, 0xb9d7fc9b, 0xb9d7fc9b, 0xb9d7fc9b, 0xb9d7fc9b, 0xb9d7fc9b, - 0x39fb18c3, 0x39fb18c3, 0x39fb18c3, 0x39fb18c3, 0x39fb18c3, 0xba18e8ef, 0xba18e8ef, 0xba18e8ef, - 0xba18e8ef, 0xba18e8ef, 0x39a14380, 0x39a14380, 0x39a14380, 0x39a14380, 0x39a14380, 0xba45d390, - 0xba45d390, 0xba45d390, 0xba45d390, 0xba45d390, 0x390edc7a, 0x390edc7a, 0x390edc7a, 0x390edc7a, - 0x390edc7a, 0xba72be30, 0xba72be30, 0xba72be30, 0xba72be30, 0xba72be30, 0xb8133833, 0xb8133833, -] )) ), - -################ chunk 1024 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x46fccccf, 0x46fccccf, 0x46fccccf, 0x46ff4121, 0x46ff4121, 0x46ff4121, 0x46ff4121, 0x46ff4121, - 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x470214e2, 0x470214e2, 0x470214e2, - 0x470214e2, 0x470214e2, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47048933, - 0x47048933, 0x47048933, 0x47048933, 0x47048933, 0x4705c35c, 0x4705c35c, 0x4705c35c, 0x4705c35c, - 0x4705c35c, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x470837ae, 0x470837ae, - 0x470837ae, 0x470837ae, 0x470837ae, 0x470971d6, 0x470971d6, 0x470971d6, 0x470971d6, 0x470971d6, - 0x470aabff, 0x470aabff, 0x470aabff, 0x470aabff, 0x470aabff, 0x470be628, 0x470be628, 0x470be628, - 0x470be628, 0x470be628, 0x470d2051, 0x470d2051, 0x470d2051, 0x470d2051, 0x470d2051, 0x470e5a7a, - 0x470e5a7a, 0x470e5a7a, 0x470e5a7a, 0x470e5a7a, 0x470f94a2, 0x470f94a2, 0x470f94a2, 0x470f94a2, - 0x470f94a2, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x471208f4, 0x471208f4, - 0x471208f4, 0x471208f4, 0x471208f4, 0x4713431d, 0x4713431d, 0x4713431d, 0x4713431d, 0x4713431d, - 0x47147d45, 0x47147d45, 0x47147d45, 0x47147d45, 0x47147d45, 0x4715b76e, 0x4715b76e, 0x4715b76e, - 0x4715b76e, 0x4715b76e, 0x4716f197, 0x4716f197, 0x4716f197, 0x4716f197, 0x4716f197, 0x47182bc0, - 0x47182bc0, 0x47182bc0, 0x47182bc0, 0x47182bc0, 0x471965e8, 0x471965e8, 0x471965e8, 0x471965e8, - 0x471965e8, 0x471aa011, 0x471aa011, 0x471aa011, 0x471aa011, 0x471aa011, 0x471bda3a, 0x471bda3a, - 0x471bda3a, 0x471bda3a, 0x471bda3a, 0x471d1463, 0x471d1463, 0x471d1463, 0x471d1463, 0x471d1463, - 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471f88b4, 0x471f88b4, 0x471f88b4, - 0x471f88b4, 0x471f88b4, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4721fd06, - 0x4721fd06, 0x4721fd06, 0x4721fd06, 0x4721fd06, 0x4723372f, 0x4723372f, 0x4723372f, 0x4723372f, - 0x4723372f, 0x47247157, 0x47247157, 0x47247157, 0x47247157, 0x47247157, 0x4725ab80, 0x4725ab80, - 0x4725ab80, 0x4725ab80, 0x4725ab80, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, - 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x472959fb, 0x472959fb, 0x472959fb, - 0x472959fb, 0x472959fb, 0x472a9423, 0x472a9423, 0x472a9423, 0x472a9423, 0x472a9423, 0x472bce4c, - 0x472bce4c, 0x472bce4c, 0x472bce4c, 0x472bce4c, 0x472d0875, 0x472d0875, 0x472d0875, 0x472d0875, - 0x472d0875, 0x472e429e, 0x472e429e, 0x472e429e, 0x472e429e, 0x472e429e, 0x472f7cc6, 0x472f7cc6, - 0x472f7cc6, 0x472f7cc6, 0x472f7cc6, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, - 0x4731f118, 0x4731f118, 0x4731f118, 0x4731f118, 0x4731f118, 0x47332b41, 0x47332b41, 0x47332b41, - 0x47332b41, 0x47332b41, 0x47346569, 0x47346569, 0x47346569, 0x47346569, 0x47346569, 0x47359f92, - 0x47359f92, 0x47359f92, 0x47359f92, 0x47359f92, 0x4736d9bb, 0x4736d9bb, 0x4736d9bb, 0x4736d9bb, - 0x4736d9bb, 0x473813e4, 0x473813e4, 0x473813e4, 0x473813e4, 0x473813e4, 0x47394e0d, 0x47394e0d, - 0x47394e0d, 0x47394e0d, 0x47394e0d, 0x473a8835, 0x473a8835, 0x473a8835, 0x473a8835, 0x473a8835, - 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473cfc87, 0x473cfc87, 0x473cfc87, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xb8133833, 0xb8133833, 0xb8133833, 0x3a60572a, 0x3a60572a, 0x3a60572a, 0x3a60572a, 0x3a60572a, - 0xb9587893, 0xb9587893, 0xb9587893, 0xb9587893, 0xb9587893, 0x3a336c89, 0x3a336c89, 0x3a336c89, - 0x3a336c89, 0x3a336c89, 0x3ace7b97, 0x3ace7b97, 0x3ace7b97, 0x3ace7b97, 0x3ace7b97, 0xbabcbf07, - 0xbabcbf07, 0xbabcbf07, 0xbabcbf07, 0xbabcbf07, 0xba0ff368, 0xba0ff368, 0xba0ff368, 0xba0ff368, - 0xba0ff368, 0x39b32e8e, 0x39b32e8e, 0x39b32e8e, 0x39b32e8e, 0x39b32e8e, 0x3aa190f8, 0x3aa190f8, - 0x3aa190f8, 0x3aa190f8, 0x3aa190f8, 0xbae9a9a5, 0xbae9a9a5, 0xbae9a9a5, 0xbae9a9a5, 0xbae9a9a5, - 0xba69c8a9, 0xba69c8a9, 0xba69c8a9, 0xba69c8a9, 0xba69c8a9, 0xb577f042, 0xb577f042, 0xb577f042, - 0xb577f042, 0xb577f042, 0x3a694cb1, 0x3a694cb1, 0x3a694cb1, 0x3a694cb1, 0x3a694cb1, 0x3ae96ba9, - 0x3ae96ba9, 0x3ae96ba9, 0x3ae96ba9, 0x3ae96ba9, 0xbaa1cef5, 0xbaa1cef5, 0xbaa1cef5, 0xbaa1cef5, - 0xbaa1cef5, 0xb9b4267e, 0xb9b4267e, 0xb9b4267e, 0xb9b4267e, 0xb9b4267e, 0x3a0f776f, 0x3a0f776f, - 0x3a0f776f, 0x3a0f776f, 0x3a0f776f, 0x3abc810b, 0x3abc810b, 0x3abc810b, 0x3abc810b, 0x3abc810b, - 0xbaceb993, 0xbaceb993, 0xbaceb993, 0xbaceb993, 0xbaceb993, 0xba33e882, 0xba33e882, 0xba33e882, - 0xba33e882, 0xba33e882, 0x395688b3, 0x395688b3, 0x395688b3, 0x395688b3, 0x395688b3, 0x3a8f966c, - 0x3a8f966c, 0x3a8f966c, 0x3a8f966c, 0x3a8f966c, 0xbafba430, 0xbafba430, 0xbafba430, 0xbafba430, - 0xbafba430, 0xba86dee1, 0xba86dee1, 0xba86dee1, 0xba86dee1, 0xba86dee1, 0xb910cc5a, 0xb910cc5a, - 0xb910cc5a, 0xb910cc5a, 0xb910cc5a, 0x3a455797, 0x3a455797, 0x3a455797, 0x3a455797, 0x3a455797, - 0x3ad7711e, 0x3ad7711e, 0x3ad7711e, 0x3ad7711e, 0x3ad7711e, 0xbab3c981, 0xbab3c981, 0xbab3c981, - 0xbab3c981, 0xbab3c981, 0xb9fc10b3, 0xb9fc10b3, 0xb9fc10b3, 0xb9fc10b3, 0xb9fc10b3, 0x39d704aa, - 0x39d704aa, 0x39d704aa, 0x39d704aa, 0x39d704aa, 0x3aaa867f, 0x3aaa867f, 0x3aaa867f, 0x3aaa867f, - 0x3aaa867f, 0xbae0b41f, 0xbae0b41f, 0xbae0b41f, 0xbae0b41f, 0xbae0b41f, 0xba57dd9b, 0xba57dd9b, - 0xba57dd9b, 0xba57dd9b, 0xba57dd9b, 0x388d6891, 0x388d6891, 0x388d6891, 0x388d6891, 0x388d6891, - 0x3a7b37bf, 0x3a7b37bf, 0x3a7b37bf, 0x3a7b37bf, 0x3a7b37bf, 0x3af2612f, 0x3af2612f, 0x3af2612f, - 0x3af2612f, 0x3af2612f, 0xba98d96e, 0xba98d96e, 0xba98d96e, 0xba98d96e, 0xba98d96e, 0xb9905062, - 0xb9905062, 0xb9905062, 0xb9905062, 0xb9905062, 0x3a21627d, 0x3a21627d, 0x3a21627d, 0x3a21627d, - 0x3a21627d, 0x3ac57692, 0x3ac57692, 0x3ac57692, 0x3ac57692, 0x3ac57692, 0xbac5c40d, 0xbac5c40d, - 0xbac5c40d, 0xbac5c40d, 0xbac5c40d, 0xba21fd74, 0xba21fd74, 0xba21fd74, 0xba21fd74, 0xba21fd74, - 0x398f1a76, 0x398f1a76, 0x398f1a76, 0x398f1a76, 0x398f1a76, 0x3a988bf3, 0x3a988bf3, 0x3a988bf3, - 0x3a988bf3, 0x3a988bf3, 0xbaf2aeaa, 0xbaf2aeaa, 0xbaf2aeaa, 0xbaf2aeaa, 0xbaf2aeaa, 0xba7bd2b5, - 0xba7bd2b5, 0xba7bd2b5, 0xba7bd2b5, 0xba7bd2b5, 0xb8924043, 0xb8924043, 0xb8924043, 0xb8924043, - 0xb8924043, 0x3a5742a5, 0x3a5742a5, 0x3a5742a5, 0x3a5742a5, 0x3a5742a5, 0x3ae066a4, 0x3ae066a4, - 0x3ae066a4, 0x3ae066a4, 0x3ae066a4, 0xbaaad3fa, 0xbaaad3fa, 0xbaaad3fa, 0xbaaad3fa, 0xbaaad3fa, - 0xb9d83a97, 0xb9d83a97, 0xb9d83a97, 0xb9d83a97, 0xb9d83a97, 0x39fadac7, 0x39fadac7, 0x39fadac7, -] )) ), - -################ chunk 1536 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x473cfc87, 0x473cfc87, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473f70d8, - 0x473f70d8, 0x473f70d8, 0x473f70d8, 0x473f70d8, 0x4740ab01, 0x4740ab01, 0x4740ab01, 0x4740ab01, - 0x4740ab01, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x47431f53, 0x47431f53, - 0x47431f53, 0x47431f53, 0x47431f53, 0x4744597c, 0x4744597c, 0x4744597c, 0x4744597c, 0x4744597c, - 0x474593a4, 0x474593a4, 0x474593a4, 0x474593a4, 0x474593a4, 0x4746cdcd, 0x4746cdcd, 0x4746cdcd, - 0x4746cdcd, 0x4746cdcd, 0x474807f6, 0x474807f6, 0x474807f6, 0x474807f6, 0x474807f6, 0x4749421f, - 0x4749421f, 0x4749421f, 0x4749421f, 0x4749421f, 0x474a7c47, 0x474a7c47, 0x474a7c47, 0x474a7c47, - 0x474a7c47, 0x474bb670, 0x474bb670, 0x474bb670, 0x474bb670, 0x474bb670, 0x474cf099, 0x474cf099, - 0x474cf099, 0x474cf099, 0x474cf099, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, - 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x47509f13, 0x47509f13, 0x47509f13, - 0x47509f13, 0x47509f13, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x47531365, - 0x47531365, 0x47531365, 0x47531365, 0x47531365, 0x47544d8e, 0x47544d8e, 0x47544d8e, 0x47544d8e, - 0x47544d8e, 0x475587b6, 0x475587b6, 0x475587b6, 0x475587b6, 0x475587b6, 0x4756c1df, 0x4756c1df, - 0x4756c1df, 0x4756c1df, 0x4756c1df, 0x4757fc08, 0x4757fc08, 0x4757fc08, 0x4757fc08, 0x4757fc08, - 0x47593631, 0x47593631, 0x47593631, 0x47593631, 0x47593631, 0x475a7059, 0x475a7059, 0x475a7059, - 0x475a7059, 0x475a7059, 0x475baa82, 0x475baa82, 0x475baa82, 0x475baa82, 0x475baa82, 0x475ce4ab, - 0x475ce4ab, 0x475ce4ab, 0x475ce4ab, 0x475ce4ab, 0x475e1ed4, 0x475e1ed4, 0x475e1ed4, 0x475e1ed4, - 0x475e1ed4, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x47609325, 0x47609325, - 0x47609325, 0x47609325, 0x47609325, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, - 0x47630777, 0x47630777, 0x47630777, 0x47630777, 0x47630777, 0x476441a0, 0x476441a0, 0x476441a0, - 0x476441a0, 0x476441a0, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x4766b5f1, - 0x4766b5f1, 0x4766b5f1, 0x4766b5f1, 0x4766b5f1, 0x4767f01a, 0x4767f01a, 0x4767f01a, 0x4767f01a, - 0x4767f01a, 0x47692a43, 0x47692a43, 0x47692a43, 0x47692a43, 0x47692a43, 0x476a646b, 0x476a646b, - 0x476a646b, 0x476a646b, 0x476a646b, 0x476b9e94, 0x476b9e94, 0x476b9e94, 0x476b9e94, 0x476b9e94, - 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476e12e6, 0x476e12e6, 0x476e12e6, - 0x476e12e6, 0x476e12e6, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x47708737, - 0x47708737, 0x47708737, 0x47708737, 0x47708737, 0x4771c160, 0x4771c160, 0x4771c160, 0x4771c160, - 0x4771c160, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x477435b2, 0x477435b2, - 0x477435b2, 0x477435b2, 0x477435b2, 0x47756fda, 0x47756fda, 0x47756fda, 0x47756fda, 0x47756fda, - 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4777e42c, 0x4777e42c, 0x4777e42c, - 0x4777e42c, 0x4777e42c, 0x47791e55, 0x47791e55, 0x47791e55, 0x47791e55, 0x47791e55, 0x477a587d, - 0x477a587d, 0x477a587d, 0x477a587d, 0x477a587d, 0x477b92a6, 0x477b92a6, 0x477b92a6, 0x477b92a6, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x39fadac7, 0x39fadac7, 0x3ab37c06, 0x3ab37c06, 0x3ab37c06, 0x3ab37c06, 0x3ab37c06, 0xbad7be99, - 0xbad7be99, 0xbad7be99, 0xbad7be99, 0xbad7be99, 0xba45f28e, 0xba45f28e, 0xba45f28e, 0xba45f28e, - 0xba45f28e, 0x390e6082, 0x390e6082, 0x390e6082, 0x390e6082, 0x390e6082, 0x3a869166, 0x3a869166, - 0x3a869166, 0x3a869166, 0x3a869166, 0x3afb56b5, 0x3afb56b5, 0x3afb56b5, 0x3afb56b5, 0x3afb56b5, - 0xba8fe3e7, 0xba8fe3e7, 0xba8fe3e7, 0xba8fe3e7, 0xba8fe3e7, 0xb958f48b, 0xb958f48b, 0xb958f48b, - 0xb958f48b, 0xb958f48b, 0x3a334d8b, 0x3a334d8b, 0x3a334d8b, 0x3a334d8b, 0x3a334d8b, 0x3ace6c18, - 0x3ace6c18, 0x3ace6c18, 0x3ace6c18, 0x3ace6c18, 0xbabcce86, 0xbabcce86, 0xbabcce86, 0xbabcce86, - 0xbabcce86, 0xba101266, 0xba101266, 0xba101266, 0xba101266, 0xba101266, 0x39b2f092, 0x39b2f092, - 0x39b2f092, 0x39b2f092, 0x39b2f092, 0x3aa18179, 0x3aa18179, 0x3aa18179, 0x3aa18179, 0x3aa18179, - 0xbae9b924, 0xbae9b924, 0xbae9b924, 0xbae9b924, 0xbae9b924, 0xba69e7a7, 0xba69e7a7, 0xba69e7a7, - 0xba69e7a7, 0xba69e7a7, 0xb5b9f432, 0xb5b9f432, 0xb5b9f432, 0xb5b9f432, 0xb5b9f432, 0x3a692db3, - 0x3a692db3, 0x3a692db3, 0x3a692db3, 0x3a692db3, 0x3ae95c2a, 0x3ae95c2a, 0x3ae95c2a, 0x3ae95c2a, - 0x3ae95c2a, 0xbaa1de74, 0xbaa1de74, 0xbaa1de74, 0xbaa1de74, 0xbaa1de74, 0xb9b4647a, 0xb9b4647a, - 0xb9b4647a, 0xb9b4647a, 0xb9b4647a, 0x3a0f5871, 0x3a0f5871, 0x3a0f5871, 0x3a0f5871, 0x3a0f5871, - 0x3abc718c, 0x3abc718c, 0x3abc718c, 0x3abc718c, 0x3abc718c, 0xbacec912, 0xbacec912, 0xbacec912, - 0xbacec912, 0xbacec912, 0xba340780, 0xba340780, 0xba340780, 0xba340780, 0xba340780, 0x39560cba, - 0x39560cba, 0x39560cba, 0x39560cba, 0x39560cba, 0x3a8f86ed, 0x3a8f86ed, 0x3a8f86ed, 0x3a8f86ed, - 0x3a8f86ed, 0xbafbb3af, 0xbafbb3af, 0xbafbb3af, 0xbafbb3af, 0xbafbb3af, 0xba86ee60, 0xba86ee60, - 0xba86ee60, 0xba86ee60, 0xba86ee60, 0xb9114852, 0xb9114852, 0xb9114852, 0xb9114852, 0xb9114852, - 0x3a453899, 0x3a453899, 0x3a453899, 0x3a453899, 0x3a453899, 0x3ad7619f, 0x3ad7619f, 0x3ad7619f, - 0x3ad7619f, 0x3ad7619f, 0xbab3d900, 0xbab3d900, 0xbab3d900, 0xbab3d900, 0xbab3d900, 0xb9fc4eaf, - 0xb9fc4eaf, 0xb9fc4eaf, 0xb9fc4eaf, 0xb9fc4eaf, 0x39d6c6ae, 0x39d6c6ae, 0x39d6c6ae, 0x39d6c6ae, - 0x39d6c6ae, 0x3aaa7700, 0x3aaa7700, 0x3aaa7700, 0x3aaa7700, 0x3aaa7700, 0xbae0c39e, 0xbae0c39e, - 0xbae0c39e, 0xbae0c39e, 0xbae0c39e, 0xba57fc99, 0xba57fc99, 0xba57fc99, 0xba57fc99, 0xba57fc99, - 0x388c70a1, 0x388c70a1, 0x388c70a1, 0x388c70a1, 0x388c70a1, 0x3a7b18c1, 0x3a7b18c1, 0x3a7b18c1, - 0x3a7b18c1, 0x3a7b18c1, 0x3af251b0, 0x3af251b0, 0x3af251b0, 0x3af251b0, 0x3af251b0, 0xba98e8ed, - 0xba98e8ed, 0xba98e8ed, 0xba98e8ed, 0xba98e8ed, 0xb9908e5e, 0xb9908e5e, 0xb9908e5e, 0xb9908e5e, - 0xb9908e5e, 0x3a21437f, 0x3a21437f, 0x3a21437f, 0x3a21437f, 0x3a21437f, 0x3ac56713, 0x3ac56713, - 0x3ac56713, 0x3ac56713, 0x3ac56713, 0xbac5d38c, 0xbac5d38c, 0xbac5d38c, 0xbac5d38c, 0xbac5d38c, - 0xba221c72, 0xba221c72, 0xba221c72, 0xba221c72, 0xba221c72, 0x398edc7a, 0x398edc7a, 0x398edc7a, - 0x398edc7a, 0x398edc7a, 0x3a987c74, 0x3a987c74, 0x3a987c74, 0x3a987c74, 0x3a987c74, 0xbaf2be29, - 0xbaf2be29, 0xbaf2be29, 0xbaf2be29, 0xbaf2be29, 0xba7bf1b3, 0xba7bf1b3, 0xba7bf1b3, 0xba7bf1b3, -] )) ), - -################ chunk 2048 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x477b92a6, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477e06f8, 0x477e06f8, - 0x477e06f8, 0x477e06f8, 0x477e06f8, 0x477f4121, 0x477f4121, 0x477f4121, 0x477f4121, 0x477f4121, - 0x47803da5, 0x47803da5, 0x47803da5, 0x47803da5, 0x47803da5, 0x4780dab9, 0x4780dab9, 0x4780dab9, - 0x4780dab9, 0x4780dab9, 0x478177cd, 0x478177cd, 0x478177cd, 0x478177cd, 0x478177cd, 0x478214e2, - 0x478214e2, 0x478214e2, 0x478214e2, 0x478214e2, 0x4782b1f6, 0x4782b1f6, 0x4782b1f6, 0x4782b1f6, - 0x4782b1f6, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x4783ec1f, 0x4783ec1f, - 0x4783ec1f, 0x4783ec1f, 0x4783ec1f, 0x47848933, 0x47848933, 0x47848933, 0x47848933, 0x47848933, - 0x47852648, 0x47852648, 0x47852648, 0x47852648, 0x47852648, 0x4785c35c, 0x4785c35c, 0x4785c35c, - 0x4785c35c, 0x4785c35c, 0x47866071, 0x47866071, 0x47866071, 0x47866071, 0x47866071, 0x4786fd85, - 0x4786fd85, 0x4786fd85, 0x4786fd85, 0x4786fd85, 0x47879a99, 0x47879a99, 0x47879a99, 0x47879a99, - 0x47879a99, 0x478837ae, 0x478837ae, 0x478837ae, 0x478837ae, 0x478837ae, 0x4788d4c2, 0x4788d4c2, - 0x4788d4c2, 0x4788d4c2, 0x4788d4c2, 0x478971d6, 0x478971d6, 0x478971d6, 0x478971d6, 0x478971d6, - 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478aabff, 0x478aabff, 0x478aabff, - 0x478aabff, 0x478aabff, 0x478b4914, 0x478b4914, 0x478b4914, 0x478b4914, 0x478b4914, 0x478be628, - 0x478be628, 0x478be628, 0x478be628, 0x478be628, 0x478c833c, 0x478c833c, 0x478c833c, 0x478c833c, - 0x478c833c, 0x478d2051, 0x478d2051, 0x478d2051, 0x478d2051, 0x478d2051, 0x478dbd65, 0x478dbd65, - 0x478dbd65, 0x478dbd65, 0x478dbd65, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, - 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478f94a2, 0x478f94a2, 0x478f94a2, - 0x478f94a2, 0x478f94a2, 0x479031b7, 0x479031b7, 0x479031b7, 0x479031b7, 0x479031b7, 0x4790cecb, - 0x4790cecb, 0x4790cecb, 0x4790cecb, 0x4790cecb, 0x47916bdf, 0x47916bdf, 0x47916bdf, 0x47916bdf, - 0x47916bdf, 0x479208f4, 0x479208f4, 0x479208f4, 0x479208f4, 0x479208f4, 0x4792a608, 0x4792a608, - 0x4792a608, 0x4792a608, 0x4792a608, 0x4793431d, 0x4793431d, 0x4793431d, 0x4793431d, 0x4793431d, - 0x4793e031, 0x4793e031, 0x4793e031, 0x4793e031, 0x4793e031, 0x47947d45, 0x47947d45, 0x47947d45, - 0x47947d45, 0x47947d45, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x4795b76e, - 0x4795b76e, 0x4795b76e, 0x4795b76e, 0x4795b76e, 0x47965483, 0x47965483, 0x47965483, 0x47965483, - 0x47965483, 0x4796f197, 0x4796f197, 0x4796f197, 0x4796f197, 0x4796f197, 0x47978eab, 0x47978eab, - 0x47978eab, 0x47978eab, 0x47978eab, 0x47982bc0, 0x47982bc0, 0x47982bc0, 0x47982bc0, 0x47982bc0, - 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x479965e8, 0x479965e8, 0x479965e8, - 0x479965e8, 0x479965e8, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479aa011, - 0x479aa011, 0x479aa011, 0x479aa011, 0x479aa011, 0x479b3d26, 0x479b3d26, 0x479b3d26, 0x479b3d26, - 0x479b3d26, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479c774e, 0x479c774e, - 0x479c774e, 0x479c774e, 0x479c774e, 0x479d1463, 0x479d1463, 0x479d1463, 0x479d1463, 0x479d1463, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xba7bf1b3, 0xb8933833, 0xb8933833, 0xb8933833, 0xb8933833, 0xb8933833, 0x3a5723a7, 0x3a5723a7, - 0x3a5723a7, 0x3a5723a7, 0x3a5723a7, 0x3ae05725, 0x3ae05725, 0x3ae05725, 0x3ae05725, 0x3ae05725, - 0x3b2a8e35, 0x3b2a8e35, 0x3b2a8e35, 0x3b2a8e35, 0x3b2a8e35, 0xb9d87893, 0xb9d87893, 0xb9d87893, - 0xb9d87893, 0xb9d87893, 0xbb60ac4a, 0xbb60ac4a, 0xbb60ac4a, 0xbb60ac4a, 0xbb60ac4a, 0x3ab36c87, - 0x3ab36c87, 0x3ab36c87, 0x3ab36c87, 0x3ab36c87, 0xbad7ce18, 0xbad7ce18, 0xbad7ce18, 0xbad7ce18, - 0xbad7ce18, 0x3b4e7b86, 0x3b4e7b86, 0x3b4e7b86, 0x3b4e7b86, 0x3b4e7b86, 0x390de489, 0x390de489, - 0x390de489, 0x390de489, 0x390de489, 0xbb3cbefb, 0xbb3cbefb, 0xbb3cbefb, 0xbb3cbefb, 0xbb3cbefb, - 0x3afb4736, 0x3afb4736, 0x3afb4736, 0x3afb4736, 0x3afb4736, 0xba8ff366, 0xba8ff366, 0xba8ff366, - 0xba8ff366, 0xba8ff366, 0x3b7268d4, 0x3b7268d4, 0x3b7268d4, 0x3b7268d4, 0x3b7268d4, 0x3a332e8d, - 0x3a332e8d, 0x3a332e8d, 0x3a332e8d, 0x3a332e8d, 0xbb18d1a8, 0xbb18d1a8, 0xbb18d1a8, 0xbb18d1a8, - 0xbb18d1a8, 0x3b2190f0, 0x3b2190f0, 0x3b2190f0, 0x3b2190f0, 0x3b2190f0, 0xba103164, 0xba103164, - 0xba103164, 0xba103164, 0xba103164, 0xbb69a98d, 0xbb69a98d, 0xbb69a98d, 0xbb69a98d, 0xbb69a98d, - 0x3aa171fa, 0x3aa171fa, 0x3aa171fa, 0x3aa171fa, 0x3aa171fa, 0xbae9c8a3, 0xbae9c8a3, 0xbae9c8a3, - 0xbae9c8a3, 0xbae9c8a3, 0x3b457e43, 0x3b457e43, 0x3b457e43, 0x3b457e43, 0x3b457e43, 0xb5f7f042, - 0xb5f7f042, 0xb5f7f042, 0xb5f7f042, 0xb5f7f042, 0xbb45bc3f, 0xbb45bc3f, 0xbb45bc3f, 0xbb45bc3f, - 0xbb45bc3f, 0x3ae94cab, 0x3ae94cab, 0x3ae94cab, 0x3ae94cab, 0x3ae94cab, 0xbaa1edf3, 0xbaa1edf3, - 0xbaa1edf3, 0xbaa1edf3, 0xbaa1edf3, 0x3b696b91, 0x3b696b91, 0x3b696b91, 0x3b696b91, 0x3b696b91, - 0x3a0f3973, 0x3a0f3973, 0x3a0f3973, 0x3a0f3973, 0x3a0f3973, 0xbb21ceec, 0xbb21ceec, 0xbb21ceec, - 0xbb21ceec, 0xbb21ceec, 0x3b1893ac, 0x3b1893ac, 0x3b1893ac, 0x3b1893ac, 0x3b1893ac, 0xba34267e, - 0xba34267e, 0xba34267e, 0xba34267e, 0xba34267e, 0xbb72a6d0, 0xbb72a6d0, 0xbb72a6d0, 0xbb72a6d0, - 0xbb72a6d0, 0x3a8f776e, 0x3a8f776e, 0x3a8f776e, 0x3a8f776e, 0x3a8f776e, 0xbafbc32e, 0xbafbc32e, - 0xbafbc32e, 0xbafbc32e, 0xbafbc32e, 0x3b3c80ff, 0x3b3c80ff, 0x3b3c80ff, 0x3b3c80ff, 0x3b3c80ff, - 0xb911c44a, 0xb911c44a, 0xb911c44a, 0xb911c44a, 0xb911c44a, 0xbb4eb982, 0xbb4eb982, 0xbb4eb982, - 0xbb4eb982, 0xbb4eb982, 0x3ad75220, 0x3ad75220, 0x3ad75220, 0x3ad75220, 0x3ad75220, 0xbab3e87f, - 0xbab3e87f, 0xbab3e87f, 0xbab3e87f, 0xbab3e87f, 0x3b606e4e, 0x3b606e4e, 0x3b606e4e, 0x3b606e4e, - 0x3b606e4e, 0x39d688b2, 0x39d688b2, 0x39d688b2, 0x39d688b2, 0x39d688b2, 0xbb2acc31, 0xbb2acc31, - 0xbb2acc31, 0xbb2acc31, 0xbb2acc31, 0x3b0f9666, 0x3b0f9666, 0x3b0f9666, 0x3b0f9666, 0x3b0f9666, - 0xba581b97, 0xba581b97, 0xba581b97, 0xba581b97, 0xba581b97, 0xbb7ba412, 0xbb7ba412, 0xbb7ba412, - 0xbb7ba412, 0xbb7ba412, 0x3a7af9c3, 0x3a7af9c3, 0x3a7af9c3, 0x3a7af9c3, 0x3a7af9c3, 0xbb06dedd, - 0xbb06dedd, 0xbb06dedd, 0xbb06dedd, 0xbb06dedd, 0x3b3383ba, 0x3b3383ba, 0x3b3383ba, 0x3b3383ba, - 0x3b3383ba, 0xb990cc5a, 0xb990cc5a, 0xb990cc5a, 0xb990cc5a, 0xb990cc5a, 0xbb57b6c6, 0xbb57b6c6, - 0xbb57b6c6, 0xbb57b6c6, 0xbb57b6c6, 0x3ac55794, 0x3ac55794, 0x3ac55794, 0x3ac55794, 0x3ac55794, -] )) ), - -################ chunk 2560 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x479db177, 0x479db177, 0x479db177, 0x479db177, 0x479db177, 0x479e4e8c, 0x479e4e8c, 0x479e4e8c, - 0x479e4e8c, 0x479e4e8c, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479f88b4, - 0x479f88b4, 0x479f88b4, 0x479f88b4, 0x479f88b4, 0x47a025c9, 0x47a025c9, 0x47a025c9, 0x47a025c9, - 0x47a025c9, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a15ff2, 0x47a15ff2, - 0x47a15ff2, 0x47a15ff2, 0x47a15ff2, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, - 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a3372f, 0x47a3372f, 0x47a3372f, - 0x47a3372f, 0x47a3372f, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a47157, - 0x47a47157, 0x47a47157, 0x47a47157, 0x47a47157, 0x47a50e6c, 0x47a50e6c, 0x47a50e6c, 0x47a50e6c, - 0x47a50e6c, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a64895, 0x47a64895, - 0x47a64895, 0x47a64895, 0x47a64895, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, - 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a81fd2, 0x47a81fd2, 0x47a81fd2, - 0x47a81fd2, 0x47a81fd2, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a959fb, - 0x47a959fb, 0x47a959fb, 0x47a959fb, 0x47a959fb, 0x47a9f70f, 0x47a9f70f, 0x47a9f70f, 0x47a9f70f, - 0x47a9f70f, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47ab3138, 0x47ab3138, - 0x47ab3138, 0x47ab3138, 0x47ab3138, 0x47abce4c, 0x47abce4c, 0x47abce4c, 0x47abce4c, 0x47abce4c, - 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ad0875, 0x47ad0875, 0x47ad0875, - 0x47ad0875, 0x47ad0875, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ae429e, - 0x47ae429e, 0x47ae429e, 0x47ae429e, 0x47ae429e, 0x47aedfb2, 0x47aedfb2, 0x47aedfb2, 0x47aedfb2, - 0x47aedfb2, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47b019db, 0x47b019db, - 0x47b019db, 0x47b019db, 0x47b019db, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, - 0x47b15404, 0x47b15404, 0x47b15404, 0x47b15404, 0x47b15404, 0x47b1f118, 0x47b1f118, 0x47b1f118, - 0x47b1f118, 0x47b1f118, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b32b41, - 0x47b32b41, 0x47b32b41, 0x47b32b41, 0x47b32b41, 0x47b3c855, 0x47b3c855, 0x47b3c855, 0x47b3c855, - 0x47b3c855, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b5027e, 0x47b5027e, - 0x47b5027e, 0x47b5027e, 0x47b5027e, 0x47b59f92, 0x47b59f92, 0x47b59f92, 0x47b59f92, 0x47b59f92, - 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b6d9bb, 0x47b6d9bb, 0x47b6d9bb, - 0x47b6d9bb, 0x47b6d9bb, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b813e4, - 0x47b813e4, 0x47b813e4, 0x47b813e4, 0x47b813e4, 0x47b8b0f8, 0x47b8b0f8, 0x47b8b0f8, 0x47b8b0f8, - 0x47b8b0f8, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b9eb21, 0x47b9eb21, - 0x47b9eb21, 0x47b9eb21, 0x47b9eb21, 0x47ba8835, 0x47ba8835, 0x47ba8835, 0x47ba8835, 0x47ba8835, - 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bbc25e, 0x47bbc25e, 0x47bbc25e, - 0x47bbc25e, 0x47bbc25e, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bcfc87, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbac5e30b, 0xbac5e30b, 0xbac5e30b, 0xbac5e30b, 0xbac5e30b, 0x3b57710a, 0x3b57710a, 0x3b57710a, - 0x3b57710a, 0x3b57710a, 0x398e9e7e, 0x398e9e7e, 0x398e9e7e, 0x398e9e7e, 0x398e9e7e, 0xbb33c976, - 0xbb33c976, 0xbb33c976, 0xbb33c976, 0xbb33c976, 0x3b069921, 0x3b069921, 0x3b069921, 0x3b069921, - 0x3b069921, 0xba7c10b1, 0xba7c10b1, 0xba7c10b1, 0xba7c10b1, 0xba7c10b1, 0x3b7b5e57, 0x3b7b5e57, - 0x3b7b5e57, 0x3b7b5e57, 0x3b7b5e57, 0x3a5704a9, 0x3a5704a9, 0x3a5704a9, 0x3a5704a9, 0x3a5704a9, - 0xbb0fdc22, 0xbb0fdc22, 0xbb0fdc22, 0xbb0fdc22, 0xbb0fdc22, 0x3b2a8676, 0x3b2a8676, 0x3b2a8676, - 0x3b2a8676, 0x3b2a8676, 0xb9d8b68f, 0xb9d8b68f, 0xb9d8b68f, 0xb9d8b68f, 0xb9d8b68f, 0xbb60b409, - 0xbb60b409, 0xbb60b409, 0xbb60b409, 0xbb60b409, 0x3ab35d08, 0x3ab35d08, 0x3ab35d08, 0x3ab35d08, - 0x3ab35d08, 0xbad7dd97, 0xbad7dd97, 0xbad7dd97, 0xbad7dd97, 0xbad7dd97, 0x3b4e73c7, 0x3b4e73c7, - 0x3b4e73c7, 0x3b4e73c7, 0x3b4e73c7, 0x390d6891, 0x390d6891, 0x390d6891, 0x390d6891, 0x390d6891, - 0xbb3cc6ba, 0xbb3cc6ba, 0xbb3cc6ba, 0xbb3cc6ba, 0xbb3cc6ba, 0x3afb37b7, 0x3afb37b7, 0x3afb37b7, - 0x3afb37b7, 0x3afb37b7, 0xba9002e5, 0xba9002e5, 0xba9002e5, 0xba9002e5, 0xba9002e5, 0x3b726114, - 0x3b726114, 0x3b726114, 0x3b726114, 0x3b726114, 0x3a330f8f, 0x3a330f8f, 0x3a330f8f, 0x3a330f8f, - 0x3a330f8f, 0xbb18d967, 0xbb18d967, 0xbb18d967, 0xbb18d967, 0xbb18d967, 0x3b218931, 0x3b218931, - 0x3b218931, 0x3b218931, 0x3b218931, 0xba105062, 0xba105062, 0xba105062, 0xba105062, 0xba105062, - 0xbb69b14c, 0xbb69b14c, 0xbb69b14c, 0xbb69b14c, 0xbb69b14c, 0x3aa1627b, 0x3aa1627b, 0x3aa1627b, - 0x3aa1627b, 0x3aa1627b, 0xbae9d822, 0xbae9d822, 0xbae9d822, 0xbae9d822, 0xbae9d822, 0x3b457683, - 0x3b457683, 0x3b457683, 0x3b457683, 0x3b457683, 0xb61af629, 0xb61af629, 0xb61af629, 0xb61af629, - 0xb61af629, 0xbb45c3fe, 0xbb45c3fe, 0xbb45c3fe, 0xbb45c3fe, 0xbb45c3fe, 0x3ae93d2c, 0x3ae93d2c, - 0x3ae93d2c, 0x3ae93d2c, 0x3ae93d2c, 0xbaa1fd72, 0xbaa1fd72, 0xbaa1fd72, 0xbaa1fd72, 0xbaa1fd72, - 0x3b6963d1, 0x3b6963d1, 0x3b6963d1, 0x3b6963d1, 0x3b6963d1, 0x3a0f1a75, 0x3a0f1a75, 0x3a0f1a75, - 0x3a0f1a75, 0x3a0f1a75, 0xbb21d6ac, 0xbb21d6ac, 0xbb21d6ac, 0xbb21d6ac, 0xbb21d6ac, 0x3b188bec, - 0x3b188bec, 0x3b188bec, 0x3b188bec, 0x3b188bec, 0xba34457c, 0xba34457c, 0xba34457c, 0xba34457c, - 0xba34457c, 0xbb72ae8f, 0xbb72ae8f, 0xbb72ae8f, 0xbb72ae8f, 0xbb72ae8f, 0x3a8f67ef, 0x3a8f67ef, - 0x3a8f67ef, 0x3a8f67ef, 0x3a8f67ef, 0xbafbd2ad, 0xbafbd2ad, 0xbafbd2ad, 0xbafbd2ad, 0xbafbd2ad, - 0x3b3c793f, 0x3b3c793f, 0x3b3c793f, 0x3b3c793f, 0x3b3c793f, 0xb9124043, 0xb9124043, 0xb9124043, - 0xb9124043, 0xb9124043, 0xbb4ec142, 0xbb4ec142, 0xbb4ec142, 0xbb4ec142, 0xbb4ec142, 0x3ad742a1, - 0x3ad742a1, 0x3ad742a1, 0x3ad742a1, 0x3ad742a1, 0xbab3f7fe, 0xbab3f7fe, 0xbab3f7fe, 0xbab3f7fe, - 0xbab3f7fe, 0x3b60668e, 0x3b60668e, 0x3b60668e, 0x3b60668e, 0x3b60668e, 0x39d64ab6, 0x39d64ab6, - 0x39d64ab6, 0x39d64ab6, 0x39d64ab6, 0xbb2ad3f1, 0xbb2ad3f1, 0xbb2ad3f1, 0xbb2ad3f1, 0xbb2ad3f1, - 0x3b0f8ea7, 0x3b0f8ea7, 0x3b0f8ea7, 0x3b0f8ea7, 0x3b0f8ea7, 0xba583a96, 0xba583a96, 0xba583a96, - 0xba583a96, 0xba583a96, 0xbb7babd1, 0xbb7babd1, 0xbb7babd1, 0xbb7babd1, 0xbb7babd1, 0x3a7adac5, -] )) ), - -################ chunk 3072 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47bcfc87, 0x47bcfc87, 0x47bcfc87, 0x47bcfc87, 0x47bd999b, 0x47bd999b, 0x47bd999b, 0x47bd999b, - 0x47bd999b, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47bed3c4, 0x47bed3c4, - 0x47bed3c4, 0x47bed3c4, 0x47bed3c4, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, - 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c0ab01, 0x47c0ab01, 0x47c0ab01, - 0x47c0ab01, 0x47c0ab01, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c1e52a, - 0x47c1e52a, 0x47c1e52a, 0x47c1e52a, 0x47c1e52a, 0x47c2823e, 0x47c2823e, 0x47c2823e, 0x47c2823e, - 0x47c2823e, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c3bc67, 0x47c3bc67, - 0x47c3bc67, 0x47c3bc67, 0x47c3bc67, 0x47c4597c, 0x47c4597c, 0x47c4597c, 0x47c4597c, 0x47c4597c, - 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c593a4, 0x47c593a4, 0x47c593a4, - 0x47c593a4, 0x47c593a4, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c6cdcd, - 0x47c6cdcd, 0x47c6cdcd, 0x47c6cdcd, 0x47c6cdcd, 0x47c76ae1, 0x47c76ae1, 0x47c76ae1, 0x47c76ae1, - 0x47c76ae1, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c8a50a, 0x47c8a50a, - 0x47c8a50a, 0x47c8a50a, 0x47c8a50a, 0x47c9421f, 0x47c9421f, 0x47c9421f, 0x47c9421f, 0x47c9421f, - 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47ca7c47, 0x47ca7c47, 0x47ca7c47, - 0x47ca7c47, 0x47ca7c47, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cbb670, - 0x47cbb670, 0x47cbb670, 0x47cbb670, 0x47cbb670, 0x47cc5385, 0x47cc5385, 0x47cc5385, 0x47cc5385, - 0x47cc5385, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47cd8dad, 0x47cd8dad, - 0x47cd8dad, 0x47cd8dad, 0x47cd8dad, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, - 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cf64ea, 0x47cf64ea, 0x47cf64ea, - 0x47cf64ea, 0x47cf64ea, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d09f13, - 0x47d09f13, 0x47d09f13, 0x47d09f13, 0x47d09f13, 0x47d13c28, 0x47d13c28, 0x47d13c28, 0x47d13c28, - 0x47d13c28, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d27650, 0x47d27650, - 0x47d27650, 0x47d27650, 0x47d27650, 0x47d31365, 0x47d31365, 0x47d31365, 0x47d31365, 0x47d31365, - 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d44d8e, 0x47d44d8e, 0x47d44d8e, - 0x47d44d8e, 0x47d44d8e, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d587b6, - 0x47d587b6, 0x47d587b6, 0x47d587b6, 0x47d587b6, 0x47d624cb, 0x47d624cb, 0x47d624cb, 0x47d624cb, - 0x47d624cb, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d75ef3, 0x47d75ef3, - 0x47d75ef3, 0x47d75ef3, 0x47d75ef3, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, - 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d93631, 0x47d93631, 0x47d93631, - 0x47d93631, 0x47d93631, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47da7059, - 0x47da7059, 0x47da7059, 0x47da7059, 0x47da7059, 0x47db0d6e, 0x47db0d6e, 0x47db0d6e, 0x47db0d6e, - 0x47db0d6e, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dc4797, 0x47dc4797, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3a7adac5, 0x3a7adac5, 0x3a7adac5, 0x3a7adac5, 0xbb06e69c, 0xbb06e69c, 0xbb06e69c, 0xbb06e69c, - 0xbb06e69c, 0x3b337bfb, 0x3b337bfb, 0x3b337bfb, 0x3b337bfb, 0x3b337bfb, 0xb9910a56, 0xb9910a56, - 0xb9910a56, 0xb9910a56, 0xb9910a56, 0xbb57be85, 0xbb57be85, 0xbb57be85, 0xbb57be85, 0xbb57be85, - 0x3ac54815, 0x3ac54815, 0x3ac54815, 0x3ac54815, 0x3ac54815, 0xbac5f28a, 0xbac5f28a, 0xbac5f28a, - 0xbac5f28a, 0xbac5f28a, 0x3b57694b, 0x3b57694b, 0x3b57694b, 0x3b57694b, 0x3b57694b, 0x398e6081, - 0x398e6081, 0x398e6081, 0x398e6081, 0x398e6081, 0xbb33d135, 0xbb33d135, 0xbb33d135, 0xbb33d135, - 0xbb33d135, 0x3b069162, 0x3b069162, 0x3b069162, 0x3b069162, 0x3b069162, 0xba7c2faf, 0xba7c2faf, - 0xba7c2faf, 0xba7c2faf, 0xba7c2faf, 0x3b7b5697, 0x3b7b5697, 0x3b7b5697, 0x3b7b5697, 0x3b7b5697, - 0x3a56e5ab, 0x3a56e5ab, 0x3a56e5ab, 0x3a56e5ab, 0x3a56e5ab, 0xbb0fe3e1, 0xbb0fe3e1, 0xbb0fe3e1, - 0xbb0fe3e1, 0xbb0fe3e1, 0x3b2a7eb6, 0x3b2a7eb6, 0x3b2a7eb6, 0x3b2a7eb6, 0x3b2a7eb6, 0xb9d8f48b, - 0xb9d8f48b, 0xb9d8f48b, 0xb9d8f48b, 0xb9d8f48b, 0xbb60bbc9, 0xbb60bbc9, 0xbb60bbc9, 0xbb60bbc9, - 0xbb60bbc9, 0x3ab34d89, 0x3ab34d89, 0x3ab34d89, 0x3ab34d89, 0x3ab34d89, 0xbad7ed16, 0xbad7ed16, - 0xbad7ed16, 0xbad7ed16, 0xbad7ed16, 0x3b4e6c07, 0x3b4e6c07, 0x3b4e6c07, 0x3b4e6c07, 0x3b4e6c07, - 0x390cec99, 0x390cec99, 0x390cec99, 0x390cec99, 0x390cec99, 0xbb3cce7a, 0xbb3cce7a, 0xbb3cce7a, - 0xbb3cce7a, 0xbb3cce7a, 0x3afb2838, 0x3afb2838, 0x3afb2838, 0x3afb2838, 0x3afb2838, 0xba901264, - 0xba901264, 0xba901264, 0xba901264, 0xba901264, 0x3b725955, 0x3b725955, 0x3b725955, 0x3b725955, - 0x3b725955, 0x3a32f091, 0x3a32f091, 0x3a32f091, 0x3a32f091, 0x3a32f091, 0xbb18e127, 0xbb18e127, - 0xbb18e127, 0xbb18e127, 0xbb18e127, 0x3b218171, 0x3b218171, 0x3b218171, 0x3b218171, 0x3b218171, - 0xba106f60, 0xba106f60, 0xba106f60, 0xba106f60, 0xba106f60, 0xbb69b90c, 0xbb69b90c, 0xbb69b90c, - 0xbb69b90c, 0xbb69b90c, 0x3aa152fc, 0x3aa152fc, 0x3aa152fc, 0x3aa152fc, 0x3aa152fc, 0xbae9e7a1, - 0xbae9e7a1, 0xbae9e7a1, 0xbae9e7a1, 0xbae9e7a1, 0x3b456ec4, 0x3b456ec4, 0x3b456ec4, 0x3b456ec4, - 0x3b456ec4, 0xb639f432, 0xb639f432, 0xb639f432, 0xb639f432, 0xb639f432, 0xbb45cbbe, 0xbb45cbbe, - 0xbb45cbbe, 0xbb45cbbe, 0xbb45cbbe, 0x3ae92dad, 0x3ae92dad, 0x3ae92dad, 0x3ae92dad, 0x3ae92dad, - 0xbaa20cf1, 0xbaa20cf1, 0xbaa20cf1, 0xbaa20cf1, 0xbaa20cf1, 0x3b695c12, 0x3b695c12, 0x3b695c12, - 0x3b695c12, 0x3b695c12, 0x3a0efb77, 0x3a0efb77, 0x3a0efb77, 0x3a0efb77, 0x3a0efb77, 0xbb21de6b, - 0xbb21de6b, 0xbb21de6b, 0xbb21de6b, 0xbb21de6b, 0x3b18842d, 0x3b18842d, 0x3b18842d, 0x3b18842d, - 0x3b18842d, 0xba34647a, 0xba34647a, 0xba34647a, 0xba34647a, 0xba34647a, 0xbb72b64f, 0xbb72b64f, - 0xbb72b64f, 0xbb72b64f, 0xbb72b64f, 0x3a8f5870, 0x3a8f5870, 0x3a8f5870, 0x3a8f5870, 0x3a8f5870, - 0xbafbe22c, 0xbafbe22c, 0xbafbe22c, 0xbafbe22c, 0xbafbe22c, 0x3b3c7180, 0x3b3c7180, 0x3b3c7180, - 0x3b3c7180, 0x3b3c7180, 0xb912bc3b, 0xb912bc3b, 0xb912bc3b, 0xb912bc3b, 0xb912bc3b, 0xbb4ec901, - 0xbb4ec901, 0xbb4ec901, 0xbb4ec901, 0xbb4ec901, 0x3ad73322, 0x3ad73322, 0x3ad73322, 0x3ad73322, - 0x3ad73322, 0xbab4077d, 0xbab4077d, 0xbab4077d, 0xbab4077d, 0xbab4077d, 0x3b605ecf, 0x3b605ecf, -] )) ), - -################ chunk 3584 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47dc4797, 0x47dc4797, 0x47dc4797, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, - 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47de1ed4, 0x47de1ed4, 0x47de1ed4, - 0x47de1ed4, 0x47de1ed4, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47df58fc, - 0x47df58fc, 0x47df58fc, 0x47df58fc, 0x47df58fc, 0x47dff611, 0x47dff611, 0x47dff611, 0x47dff611, - 0x47dff611, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e1303a, 0x47e1303a, - 0x47e1303a, 0x47e1303a, 0x47e1303a, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, - 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e30777, 0x47e30777, 0x47e30777, - 0x47e30777, 0x47e30777, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e441a0, - 0x47e441a0, 0x47e441a0, 0x47e441a0, 0x47e441a0, 0x47e4deb4, 0x47e4deb4, 0x47e4deb4, 0x47e4deb4, - 0x47e4deb4, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e618dd, 0x47e618dd, - 0x47e618dd, 0x47e618dd, 0x47e618dd, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, - 0x47e75306, 0x47e75306, 0x47e75306, 0x47e75306, 0x47e75306, 0x47e7f01a, 0x47e7f01a, 0x47e7f01a, - 0x47e7f01a, 0x47e7f01a, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e92a43, - 0x47e92a43, 0x47e92a43, 0x47e92a43, 0x47e92a43, 0x47e9c757, 0x47e9c757, 0x47e9c757, 0x47e9c757, - 0x47e9c757, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47eb0180, 0x47eb0180, - 0x47eb0180, 0x47eb0180, 0x47eb0180, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, - 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ecd8bd, 0x47ecd8bd, 0x47ecd8bd, - 0x47ecd8bd, 0x47ecd8bd, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ee12e6, - 0x47ee12e6, 0x47ee12e6, 0x47ee12e6, 0x47ee12e6, 0x47eeaffa, 0x47eeaffa, 0x47eeaffa, 0x47eeaffa, - 0x47eeaffa, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47efea23, 0x47efea23, - 0x47efea23, 0x47efea23, 0x47efea23, 0x47f08737, 0x47f08737, 0x47f08737, 0x47f08737, 0x47f08737, - 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1c160, 0x47f1c160, 0x47f1c160, - 0x47f1c160, 0x47f1c160, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f2fb89, - 0x47f2fb89, 0x47f2fb89, 0x47f2fb89, 0x47f2fb89, 0x47f3989d, 0x47f3989d, 0x47f3989d, 0x47f3989d, - 0x47f3989d, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f4d2c6, 0x47f4d2c6, - 0x47f4d2c6, 0x47f4d2c6, 0x47f4d2c6, 0x47f56fda, 0x47f56fda, 0x47f56fda, 0x47f56fda, 0x47f56fda, - 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f6aa03, 0x47f6aa03, 0x47f6aa03, - 0x47f6aa03, 0x47f6aa03, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f7e42c, - 0x47f7e42c, 0x47f7e42c, 0x47f7e42c, 0x47f7e42c, 0x47f88140, 0x47f88140, 0x47f88140, 0x47f88140, - 0x47f88140, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f9bb69, 0x47f9bb69, - 0x47f9bb69, 0x47f9bb69, 0x47f9bb69, 0x47fa587d, 0x47fa587d, 0x47fa587d, 0x47fa587d, 0x47fa587d, - 0x47faf592, 0x47faf592, 0x47faf592, 0x47faf592, 0x47faf592, 0x47fb92a6, 0x47fb92a6, 0x47fb92a6, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3b605ecf, 0x3b605ecf, 0x3b605ecf, 0x39d60cba, 0x39d60cba, 0x39d60cba, 0x39d60cba, 0x39d60cba, - 0xbb2adbb0, 0xbb2adbb0, 0xbb2adbb0, 0xbb2adbb0, 0xbb2adbb0, 0x3b0f86e7, 0x3b0f86e7, 0x3b0f86e7, - 0x3b0f86e7, 0x3b0f86e7, 0xba585994, 0xba585994, 0xba585994, 0xba585994, 0xba585994, 0xbb7bb391, - 0xbb7bb391, 0xbb7bb391, 0xbb7bb391, 0xbb7bb391, 0x3a7abbc7, 0x3a7abbc7, 0x3a7abbc7, 0x3a7abbc7, - 0x3a7abbc7, 0xbb06ee5c, 0xbb06ee5c, 0xbb06ee5c, 0xbb06ee5c, 0xbb06ee5c, 0x3b33743b, 0x3b33743b, - 0x3b33743b, 0x3b33743b, 0x3b33743b, 0xb9914852, 0xb9914852, 0xb9914852, 0xb9914852, 0xb9914852, - 0xbb57c645, 0xbb57c645, 0xbb57c645, 0xbb57c645, 0xbb57c645, 0x3ac53896, 0x3ac53896, 0x3ac53896, - 0x3ac53896, 0x3ac53896, 0xbac60209, 0xbac60209, 0xbac60209, 0xbac60209, 0xbac60209, 0x3b57618b, - 0x3b57618b, 0x3b57618b, 0x3b57618b, 0x3b57618b, 0x398e2285, 0x398e2285, 0x398e2285, 0x398e2285, - 0x398e2285, 0xbb33d8f5, 0xbb33d8f5, 0xbb33d8f5, 0xbb33d8f5, 0xbb33d8f5, 0x3b0689a2, 0x3b0689a2, - 0x3b0689a2, 0x3b0689a2, 0x3b0689a2, 0xba7c4ead, 0xba7c4ead, 0xba7c4ead, 0xba7c4ead, 0xba7c4ead, - 0x3b7b4ed8, 0x3b7b4ed8, 0x3b7b4ed8, 0x3b7b4ed8, 0x3b7b4ed8, 0x3a56c6ad, 0x3a56c6ad, 0x3a56c6ad, - 0x3a56c6ad, 0x3a56c6ad, 0xbb0feba1, 0xbb0feba1, 0xbb0feba1, 0xbb0feba1, 0xbb0feba1, 0x3b2a76f7, - 0x3b2a76f7, 0x3b2a76f7, 0x3b2a76f7, 0x3b2a76f7, 0xb9d93287, 0xb9d93287, 0xb9d93287, 0xb9d93287, - 0xb9d93287, 0xbb60c388, 0xbb60c388, 0xbb60c388, 0xbb60c388, 0xbb60c388, 0x3ab33e0a, 0x3ab33e0a, - 0x3ab33e0a, 0x3ab33e0a, 0x3ab33e0a, 0xbad7fc95, 0xbad7fc95, 0xbad7fc95, 0xbad7fc95, 0xbad7fc95, - 0x3b4e6448, 0x3b4e6448, 0x3b4e6448, 0x3b4e6448, 0x3b4e6448, 0x390c70a1, 0x390c70a1, 0x390c70a1, - 0x390c70a1, 0x390c70a1, 0xbb3cd639, 0xbb3cd639, 0xbb3cd639, 0xbb3cd639, 0xbb3cd639, 0x3afb18b9, - 0x3afb18b9, 0x3afb18b9, 0x3afb18b9, 0x3afb18b9, 0xba9021e3, 0xba9021e3, 0xba9021e3, 0xba9021e3, - 0xba9021e3, 0x3b725195, 0x3b725195, 0x3b725195, 0x3b725195, 0x3b725195, 0x3a32d193, 0x3a32d193, - 0x3a32d193, 0x3a32d193, 0x3a32d193, 0xbb18e8e6, 0xbb18e8e6, 0xbb18e8e6, 0xbb18e8e6, 0xbb18e8e6, - 0x3b2179b2, 0x3b2179b2, 0x3b2179b2, 0x3b2179b2, 0x3b2179b2, 0xba108e5e, 0xba108e5e, 0xba108e5e, - 0xba108e5e, 0xba108e5e, 0xbb69c0cb, 0xbb69c0cb, 0xbb69c0cb, 0xbb69c0cb, 0xbb69c0cb, 0x3aa1437d, - 0x3aa1437d, 0x3aa1437d, 0x3aa1437d, 0x3aa1437d, 0xbae9f720, 0xbae9f720, 0xbae9f720, 0xbae9f720, - 0xbae9f720, 0x3b456704, 0x3b456704, 0x3b456704, 0x3b456704, 0x3b456704, 0xb658f23a, 0xb658f23a, - 0xb658f23a, 0xb658f23a, 0xb658f23a, 0xbb45d37d, 0xbb45d37d, 0xbb45d37d, 0xbb45d37d, 0xbb45d37d, - 0x3ae91e2e, 0x3ae91e2e, 0x3ae91e2e, 0x3ae91e2e, 0x3ae91e2e, 0xbaa21c70, 0xbaa21c70, 0xbaa21c70, - 0xbaa21c70, 0xbaa21c70, 0x3b695452, 0x3b695452, 0x3b695452, 0x3b695452, 0x3b695452, 0x3a0edc79, - 0x3a0edc79, 0x3a0edc79, 0x3a0edc79, 0x3a0edc79, 0xbb21e62b, 0xbb21e62b, 0xbb21e62b, 0xbb21e62b, - 0xbb21e62b, 0x3b187c6d, 0x3b187c6d, 0x3b187c6d, 0x3b187c6d, 0x3b187c6d, 0xba348378, 0xba348378, - 0xba348378, 0xba348378, 0xba348378, 0xbb72be0e, 0xbb72be0e, 0xbb72be0e, 0xbb72be0e, 0xbb72be0e, - 0x3a8f48f1, 0x3a8f48f1, 0x3a8f48f1, 0x3a8f48f1, 0x3a8f48f1, 0xbafbf1ab, 0xbafbf1ab, 0xbafbf1ab, -] )) ), - -################ chunk 4096 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47fb92a6, 0x47fb92a6, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fccccf, - 0x47fccccf, 0x47fccccf, 0x47fccccf, 0x47fccccf, 0x47fd69e3, 0x47fd69e3, 0x47fd69e3, 0x47fd69e3, - 0x47fd69e3, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fea40c, 0x47fea40c, - 0x47fea40c, 0x47fea40c, 0x47fea40c, 0x47ff4121, 0x47ff4121, 0x47ff4121, 0x47ff4121, 0x47ff4121, - 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x48003da5, 0x48003da5, 0x48003da5, - 0x48003da5, 0x48003da5, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x4800dab9, - 0x4800dab9, 0x4800dab9, 0x4800dab9, 0x4800dab9, 0x48012943, 0x48012943, 0x48012943, 0x48012943, - 0x48012943, 0x480177cd, 0x480177cd, 0x480177cd, 0x480177cd, 0x480177cd, 0x4801c658, 0x4801c658, - 0x4801c658, 0x4801c658, 0x4801c658, 0x480214e2, 0x480214e2, 0x480214e2, 0x480214e2, 0x480214e2, - 0x4802636c, 0x4802636c, 0x4802636c, 0x4802636c, 0x4802636c, 0x4802b1f6, 0x4802b1f6, 0x4802b1f6, - 0x4802b1f6, 0x4802b1f6, 0x48030080, 0x48030080, 0x48030080, 0x48030080, 0x48030080, 0x48034f0b, - 0x48034f0b, 0x48034f0b, 0x48034f0b, 0x48034f0b, 0x48039d95, 0x48039d95, 0x48039d95, 0x48039d95, - 0x48039d95, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x48043aa9, 0x48043aa9, - 0x48043aa9, 0x48043aa9, 0x48043aa9, 0x48048933, 0x48048933, 0x48048933, 0x48048933, 0x48048933, - 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x48052648, 0x48052648, 0x48052648, - 0x48052648, 0x48052648, 0x480574d2, 0x480574d2, 0x480574d2, 0x480574d2, 0x480574d2, 0x4805c35c, - 0x4805c35c, 0x4805c35c, 0x4805c35c, 0x4805c35c, 0x480611e6, 0x480611e6, 0x480611e6, 0x480611e6, - 0x480611e6, 0x48066071, 0x48066071, 0x48066071, 0x48066071, 0x48066071, 0x4806aefb, 0x4806aefb, - 0x4806aefb, 0x4806aefb, 0x4806aefb, 0x4806fd85, 0x4806fd85, 0x4806fd85, 0x4806fd85, 0x4806fd85, - 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48079a99, 0x48079a99, 0x48079a99, - 0x48079a99, 0x48079a99, 0x4807e923, 0x4807e923, 0x4807e923, 0x4807e923, 0x4807e923, 0x480837ae, - 0x480837ae, 0x480837ae, 0x480837ae, 0x480837ae, 0x48088638, 0x48088638, 0x48088638, 0x48088638, - 0x48088638, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4809234c, 0x4809234c, - 0x4809234c, 0x4809234c, 0x4809234c, 0x480971d6, 0x480971d6, 0x480971d6, 0x480971d6, 0x480971d6, - 0x4809c061, 0x4809c061, 0x4809c061, 0x4809c061, 0x4809c061, 0x480a0eeb, 0x480a0eeb, 0x480a0eeb, - 0x480a0eeb, 0x480a0eeb, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480aabff, - 0x480aabff, 0x480aabff, 0x480aabff, 0x480aabff, 0x480afa89, 0x480afa89, 0x480afa89, 0x480afa89, - 0x480afa89, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b979e, 0x480b979e, - 0x480b979e, 0x480b979e, 0x480b979e, 0x480be628, 0x480be628, 0x480be628, 0x480be628, 0x480be628, - 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c833c, 0x480c833c, 0x480c833c, - 0x480c833c, 0x480c833c, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480d2051, - 0x480d2051, 0x480d2051, 0x480d2051, 0x480d2051, 0x480d6edb, 0x480d6edb, 0x480d6edb, 0x480d6edb, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbafbf1ab, 0xbafbf1ab, 0x3b3c69c0, 0x3b3c69c0, 0x3b3c69c0, 0x3b3c69c0, 0x3b3c69c0, 0xb9133833, - 0xb9133833, 0xb9133833, 0xb9133833, 0xb9133833, 0xbb4ed0c1, 0xbb4ed0c1, 0xbb4ed0c1, 0xbb4ed0c1, - 0xbb4ed0c1, 0x3ad723a2, 0x3ad723a2, 0x3ad723a2, 0x3ad723a2, 0x3ad723a2, 0xbab416fc, 0xbab416fc, - 0xbab416fc, 0xbab416fc, 0xbab416fc, 0x3b60570f, 0x3b60570f, 0x3b60570f, 0x3b60570f, 0x3b60570f, - 0x39d5cebe, 0x39d5cebe, 0x39d5cebe, 0x39d5cebe, 0x39d5cebe, 0x3baa8e0f, 0x3baa8e0f, 0x3baa8e0f, - 0x3baa8e0f, 0x3baa8e0f, 0x3b0f7f28, 0x3b0f7f28, 0x3b0f7f28, 0x3b0f7f28, 0x3b0f7f28, 0xba587892, - 0xba587892, 0xba587892, 0xba587892, 0xba587892, 0xbb7bbb50, 0xbb7bbb50, 0xbb7bbb50, 0xbb7bbb50, - 0xbb7bbb50, 0xbbe0abf3, 0xbbe0abf3, 0xbbe0abf3, 0xbbe0abf3, 0xbbe0abf3, 0x3bbc84ab, 0x3bbc84ab, - 0x3bbc84ab, 0x3bbc84ab, 0x3bbc84ab, 0x3b336c7c, 0x3b336c7c, 0x3b336c7c, 0x3b336c7c, 0x3b336c7c, - 0xb991864e, 0xb991864e, 0xb991864e, 0xb991864e, 0xb991864e, 0xbb57ce04, 0xbb57ce04, 0xbb57ce04, - 0xbb57ce04, 0xbb57ce04, 0xbbceb55f, 0xbbceb55f, 0xbbceb55f, 0xbbceb55f, 0xbbceb55f, 0x3bce7b43, - 0x3bce7b43, 0x3bce7b43, 0x3bce7b43, 0x3bce7b43, 0x3b5759cc, 0x3b5759cc, 0x3b5759cc, 0x3b5759cc, - 0x3b5759cc, 0x398de489, 0x398de489, 0x398de489, 0x398de489, 0x398de489, 0xbb33e0b4, 0xbb33e0b4, - 0xbb33e0b4, 0xbb33e0b4, 0xbb33e0b4, 0xbbbcbec7, 0xbbbcbec7, 0xbbbcbec7, 0xbbbcbec7, 0xbbbcbec7, - 0x3be071d7, 0x3be071d7, 0x3be071d7, 0x3be071d7, 0x3be071d7, 0x3b7b4718, 0x3b7b4718, 0x3b7b4718, - 0x3b7b4718, 0x3b7b4718, 0x3a56a7af, 0x3a56a7af, 0x3a56a7af, 0x3a56a7af, 0x3a56a7af, 0xbb0ff360, - 0xbb0ff360, 0xbb0ff360, 0xbb0ff360, 0xbb0ff360, 0xbbaac82b, 0xbbaac82b, 0xbbaac82b, 0xbbaac82b, - 0xbbaac82b, 0x3bf26867, 0x3bf26867, 0x3bf26867, 0x3bf26867, 0x3bf26867, 0x3b8f9a30, 0x3b8f9a30, - 0x3b8f9a30, 0x3b8f9a30, 0x3b8f9a30, 0x3ab32e8b, 0x3ab32e8b, 0x3ab32e8b, 0x3ab32e8b, 0x3ab32e8b, - 0xbad80c14, 0xbad80c14, 0xbad80c14, 0xbad80c14, 0xbad80c14, 0xbb98d18c, 0xbb98d18c, 0xbb98d18c, - 0xbb98d18c, 0xbb98d18c, 0xbbfb9fb9, 0xbbfb9fb9, 0xbbfb9fb9, 0xbbfb9fb9, 0xbbfb9fb9, 0x3ba190d0, - 0x3ba190d0, 0x3ba190d0, 0x3ba190d0, 0x3ba190d0, 0x3afb093a, 0x3afb093a, 0x3afb093a, 0x3afb093a, - 0x3afb093a, 0xba903162, 0xba903162, 0xba903162, 0xba903162, 0xba903162, 0xbb86daea, 0xbb86daea, - 0xbb86daea, 0xbb86daea, 0xbb86daea, 0xbbe9a92b, 0xbbe9a92b, 0xbbe9a92b, 0xbbe9a92b, 0xbbe9a92b, - 0x3bb3876e, 0x3bb3876e, 0x3bb3876e, 0x3bb3876e, 0x3bb3876e, 0x3b2171f2, 0x3b2171f2, 0x3b2171f2, - 0x3b2171f2, 0x3b2171f2, 0xba10ad5c, 0xba10ad5c, 0xba10ad5c, 0xba10ad5c, 0xba10ad5c, 0xbb69c88b, - 0xbb69c88b, 0xbb69c88b, 0xbb69c88b, 0xbb69c88b, 0xbbd7b29a, 0xbbd7b29a, 0xbbd7b29a, 0xbbd7b29a, - 0xbbd7b29a, 0x3bc57e08, 0x3bc57e08, 0x3bc57e08, 0x3bc57e08, 0x3bc57e08, 0x3b455f45, 0x3b455f45, - 0x3b455f45, 0x3b455f45, 0x3b455f45, 0xb677f042, 0xb677f042, 0xb677f042, 0xb677f042, 0xb677f042, - 0xbb45db3d, 0xbb45db3d, 0xbb45db3d, 0xbb45db3d, 0xbb45db3d, 0xbbc5bc04, 0xbbc5bc04, 0xbbc5bc04, - 0xbbc5bc04, 0xbbc5bc04, 0x3bd7749e, 0x3bd7749e, 0x3bd7749e, 0x3bd7749e, 0x3bd7749e, 0x3b694c93, - 0x3b694c93, 0x3b694c93, 0x3b694c93, 0x3b694c93, 0x3a0ebd7b, 0x3a0ebd7b, 0x3a0ebd7b, 0x3a0ebd7b, -] )) ), - -################ chunk 4608 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x480d6edb, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480e0bef, 0x480e0bef, - 0x480e0bef, 0x480e0bef, 0x480e0bef, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, - 0x480ea904, 0x480ea904, 0x480ea904, 0x480ea904, 0x480ea904, 0x480ef78e, 0x480ef78e, 0x480ef78e, - 0x480ef78e, 0x480ef78e, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f94a2, - 0x480f94a2, 0x480f94a2, 0x480f94a2, 0x480f94a2, 0x480fe32d, 0x480fe32d, 0x480fe32d, 0x480fe32d, - 0x480fe32d, 0x481031b7, 0x481031b7, 0x481031b7, 0x481031b7, 0x481031b7, 0x48108041, 0x48108041, - 0x48108041, 0x48108041, 0x48108041, 0x4810cecb, 0x4810cecb, 0x4810cecb, 0x4810cecb, 0x4810cecb, - 0x48111d55, 0x48111d55, 0x48111d55, 0x48111d55, 0x48111d55, 0x48116bdf, 0x48116bdf, 0x48116bdf, - 0x48116bdf, 0x48116bdf, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x481208f4, - 0x481208f4, 0x481208f4, 0x481208f4, 0x481208f4, 0x4812577e, 0x4812577e, 0x4812577e, 0x4812577e, - 0x4812577e, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812f492, 0x4812f492, - 0x4812f492, 0x4812f492, 0x4812f492, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, - 0x481391a7, 0x481391a7, 0x481391a7, 0x481391a7, 0x481391a7, 0x4813e031, 0x4813e031, 0x4813e031, - 0x4813e031, 0x4813e031, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48147d45, - 0x48147d45, 0x48147d45, 0x48147d45, 0x48147d45, 0x4814cbd0, 0x4814cbd0, 0x4814cbd0, 0x4814cbd0, - 0x4814cbd0, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x481568e4, 0x481568e4, - 0x481568e4, 0x481568e4, 0x481568e4, 0x4815b76e, 0x4815b76e, 0x4815b76e, 0x4815b76e, 0x4815b76e, - 0x481605f8, 0x481605f8, 0x481605f8, 0x481605f8, 0x481605f8, 0x48165483, 0x48165483, 0x48165483, - 0x48165483, 0x48165483, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816f197, - 0x4816f197, 0x4816f197, 0x4816f197, 0x4816f197, 0x48174021, 0x48174021, 0x48174021, 0x48174021, - 0x48174021, 0x48178eab, 0x48178eab, 0x48178eab, 0x48178eab, 0x48178eab, 0x4817dd36, 0x4817dd36, - 0x4817dd36, 0x4817dd36, 0x4817dd36, 0x48182bc0, 0x48182bc0, 0x48182bc0, 0x48182bc0, 0x48182bc0, - 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x4818c8d4, 0x4818c8d4, 0x4818c8d4, - 0x4818c8d4, 0x4818c8d4, 0x4819175e, 0x4819175e, 0x4819175e, 0x4819175e, 0x4819175e, 0x481965e8, - 0x481965e8, 0x481965e8, 0x481965e8, 0x481965e8, 0x4819b473, 0x4819b473, 0x4819b473, 0x4819b473, - 0x4819b473, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a5187, 0x481a5187, - 0x481a5187, 0x481a5187, 0x481a5187, 0x481aa011, 0x481aa011, 0x481aa011, 0x481aa011, 0x481aa011, - 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481b3d26, 0x481b3d26, 0x481b3d26, - 0x481b3d26, 0x481b3d26, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481bda3a, - 0x481bda3a, 0x481bda3a, 0x481bda3a, 0x481bda3a, 0x481c28c4, 0x481c28c4, 0x481c28c4, 0x481c28c4, - 0x481c28c4, 0x481c774e, 0x481c774e, 0x481c774e, 0x481c774e, 0x481c774e, 0x481cc5d9, 0x481cc5d9, - 0x481cc5d9, 0x481cc5d9, 0x481cc5d9, 0x481d1463, 0x481d1463, 0x481d1463, 0x481d1463, 0x481d1463, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3a0ebd7b, 0xbb21edea, 0xbb21edea, 0xbb21edea, 0xbb21edea, 0xbb21edea, 0xbbb3c56a, 0xbbb3c56a, - 0xbbb3c56a, 0xbbb3c56a, 0xbbb3c56a, 0x3be96b30, 0x3be96b30, 0x3be96b30, 0x3be96b30, 0x3be96b30, - 0x3b869cee, 0x3b869cee, 0x3b869cee, 0x3b869cee, 0x3b869cee, 0x3a8f3972, 0x3a8f3972, 0x3a8f3972, - 0x3a8f3972, 0x3a8f3972, 0xbafc012a, 0xbafc012a, 0xbafc012a, 0xbafc012a, 0xbafc012a, 0xbba1cecc, - 0xbba1cecc, 0xbba1cecc, 0xbba1cecc, 0xbba1cecc, 0x3bfb61bd, 0x3bfb61bd, 0x3bfb61bd, 0x3bfb61bd, - 0x3bfb61bd, 0x3b989390, 0x3b989390, 0x3b989390, 0x3b989390, 0x3b989390, 0x3ad71423, 0x3ad71423, - 0x3ad71423, 0x3ad71423, 0x3ad71423, 0xbab4267b, 0xbab4267b, 0xbab4267b, 0xbab4267b, 0xbab4267b, - 0xbb8fd82b, 0xbb8fd82b, 0xbb8fd82b, 0xbb8fd82b, 0xbb8fd82b, 0xbbf2a663, 0xbbf2a663, 0xbbf2a663, - 0xbbf2a663, 0xbbf2a663, 0x3baa8a30, 0x3baa8a30, 0x3baa8a30, 0x3baa8a30, 0x3baa8a30, 0x3b0f7768, - 0x3b0f7768, 0x3b0f7768, 0x3b0f7768, 0x3b0f7768, 0xba589790, 0xba589790, 0xba589790, 0xba589790, - 0xba589790, 0xbb7bc310, 0xbb7bc310, 0xbb7bc310, 0xbb7bc310, 0xbb7bc310, 0xbbe0afd3, 0xbbe0afd3, - 0xbbe0afd3, 0xbbe0afd3, 0xbbe0afd3, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, - 0x3b3364bc, 0x3b3364bc, 0x3b3364bc, 0x3b3364bc, 0x3b3364bc, 0xb991c44a, 0xb991c44a, 0xb991c44a, - 0xb991c44a, 0xb991c44a, 0xbb57d5c4, 0xbb57d5c4, 0xbb57d5c4, 0xbb57d5c4, 0xbb57d5c4, 0xbbceb93f, - 0xbbceb93f, 0xbbceb93f, 0xbbceb93f, 0xbbceb93f, 0x3bce7764, 0x3bce7764, 0x3bce7764, 0x3bce7764, - 0x3bce7764, 0x3b57520c, 0x3b57520c, 0x3b57520c, 0x3b57520c, 0x3b57520c, 0x398da68d, 0x398da68d, - 0x398da68d, 0x398da68d, 0x398da68d, 0xbb33e874, 0xbb33e874, 0xbb33e874, 0xbb33e874, 0xbb33e874, - 0xbbbcc2a7, 0xbbbcc2a7, 0xbbbcc2a7, 0xbbbcc2a7, 0xbbbcc2a7, 0x3be06df8, 0x3be06df8, 0x3be06df8, - 0x3be06df8, 0x3be06df8, 0x3b7b3f59, 0x3b7b3f59, 0x3b7b3f59, 0x3b7b3f59, 0x3b7b3f59, 0x3a5688b1, - 0x3a5688b1, 0x3a5688b1, 0x3a5688b1, 0x3a5688b1, 0xbb0ffb20, 0xbb0ffb20, 0xbb0ffb20, 0xbb0ffb20, - 0xbb0ffb20, 0xbbaacc0b, 0xbbaacc0b, 0xbbaacc0b, 0xbbaacc0b, 0xbbaacc0b, 0x3bf26487, 0x3bf26487, - 0x3bf26487, 0x3bf26487, 0x3bf26487, 0x3b8f9650, 0x3b8f9650, 0x3b8f9650, 0x3b8f9650, 0x3b8f9650, - 0x3ab31f0c, 0x3ab31f0c, 0x3ab31f0c, 0x3ab31f0c, 0x3ab31f0c, 0xbad81b93, 0xbad81b93, 0xbad81b93, - 0xbad81b93, 0xbad81b93, 0xbb98d56c, 0xbb98d56c, 0xbb98d56c, 0xbb98d56c, 0xbb98d56c, 0xbbfba398, - 0xbbfba398, 0xbbfba398, 0xbbfba398, 0xbbfba398, 0x3ba18cf1, 0x3ba18cf1, 0x3ba18cf1, 0x3ba18cf1, - 0x3ba18cf1, 0x3afaf9bb, 0x3afaf9bb, 0x3afaf9bb, 0x3afaf9bb, 0x3afaf9bb, 0xba9040e1, 0xba9040e1, - 0xba9040e1, 0xba9040e1, 0xba9040e1, 0xbb86deca, 0xbb86deca, 0xbb86deca, 0xbb86deca, 0xbb86deca, - 0xbbe9ad0b, 0xbbe9ad0b, 0xbbe9ad0b, 0xbbe9ad0b, 0xbbe9ad0b, 0x3bb3838e, 0x3bb3838e, 0x3bb3838e, - 0x3bb3838e, 0x3bb3838e, 0x3b216a33, 0x3b216a33, 0x3b216a33, 0x3b216a33, 0x3b216a33, 0xba10cc5a, - 0xba10cc5a, 0xba10cc5a, 0xba10cc5a, 0xba10cc5a, 0xbb69d04a, 0xbb69d04a, 0xbb69d04a, 0xbb69d04a, - 0xbb69d04a, 0xbbd7b679, 0xbbd7b679, 0xbbd7b679, 0xbbd7b679, 0xbbd7b679, 0x3bc57a28, 0x3bc57a28, - 0x3bc57a28, 0x3bc57a28, 0x3bc57a28, 0x3b455785, 0x3b455785, 0x3b455785, 0x3b455785, 0x3b455785, -] )) ), - -################ chunk 5120 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481db177, 0x481db177, 0x481db177, - 0x481db177, 0x481db177, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e4e8c, - 0x481e4e8c, 0x481e4e8c, 0x481e4e8c, 0x481e4e8c, 0x481e9d16, 0x481e9d16, 0x481e9d16, 0x481e9d16, - 0x481e9d16, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481f3a2a, 0x481f3a2a, - 0x481f3a2a, 0x481f3a2a, 0x481f3a2a, 0x481f88b4, 0x481f88b4, 0x481f88b4, 0x481f88b4, 0x481f88b4, - 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x482025c9, 0x482025c9, 0x482025c9, - 0x482025c9, 0x482025c9, 0x48207453, 0x48207453, 0x48207453, 0x48207453, 0x48207453, 0x4820c2dd, - 0x4820c2dd, 0x4820c2dd, 0x4820c2dd, 0x4820c2dd, 0x48211167, 0x48211167, 0x48211167, 0x48211167, - 0x48211167, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x4821ae7c, 0x4821ae7c, - 0x4821ae7c, 0x4821ae7c, 0x4821ae7c, 0x4821fd06, 0x4821fd06, 0x4821fd06, 0x4821fd06, 0x4821fd06, - 0x48224b90, 0x48224b90, 0x48224b90, 0x48224b90, 0x48224b90, 0x48229a1a, 0x48229a1a, 0x48229a1a, - 0x48229a1a, 0x48229a1a, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4823372f, - 0x4823372f, 0x4823372f, 0x4823372f, 0x4823372f, 0x482385b9, 0x482385b9, 0x482385b9, 0x482385b9, - 0x482385b9, 0x4823d443, 0x4823d443, 0x4823d443, 0x4823d443, 0x4823d443, 0x482422cd, 0x482422cd, - 0x482422cd, 0x482422cd, 0x482422cd, 0x48247157, 0x48247157, 0x48247157, 0x48247157, 0x48247157, - 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x48250e6c, 0x48250e6c, 0x48250e6c, - 0x48250e6c, 0x48250e6c, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x4825ab80, - 0x4825ab80, 0x4825ab80, 0x4825ab80, 0x4825ab80, 0x4825fa0a, 0x4825fa0a, 0x4825fa0a, 0x4825fa0a, - 0x4825fa0a, 0x48264895, 0x48264895, 0x48264895, 0x48264895, 0x48264895, 0x4826971f, 0x4826971f, - 0x4826971f, 0x4826971f, 0x4826971f, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, - 0x48273433, 0x48273433, 0x48273433, 0x48273433, 0x48273433, 0x482782bd, 0x482782bd, 0x482782bd, - 0x482782bd, 0x482782bd, 0x4827d148, 0x4827d148, 0x4827d148, 0x4827d148, 0x4827d148, 0x48281fd2, - 0x48281fd2, 0x48281fd2, 0x48281fd2, 0x48281fd2, 0x48286e5c, 0x48286e5c, 0x48286e5c, 0x48286e5c, - 0x48286e5c, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x48290b70, 0x48290b70, - 0x48290b70, 0x48290b70, 0x48290b70, 0x482959fb, 0x482959fb, 0x482959fb, 0x482959fb, 0x482959fb, - 0x4829a885, 0x4829a885, 0x4829a885, 0x4829a885, 0x4829a885, 0x4829f70f, 0x4829f70f, 0x4829f70f, - 0x4829f70f, 0x4829f70f, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a9423, - 0x482a9423, 0x482a9423, 0x482a9423, 0x482a9423, 0x482ae2ad, 0x482ae2ad, 0x482ae2ad, 0x482ae2ad, - 0x482ae2ad, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b7fc2, 0x482b7fc2, - 0x482b7fc2, 0x482b7fc2, 0x482b7fc2, 0x482bce4c, 0x482bce4c, 0x482bce4c, 0x482bce4c, 0x482bce4c, - 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c6b60, 0x482c6b60, 0x482c6b60, - 0x482c6b60, 0x482c6b60, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482d0875, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xb68b7725, 0xb68b7725, 0xb68b7725, 0xb68b7725, 0xb68b7725, 0xbb45e2fc, 0xbb45e2fc, 0xbb45e2fc, - 0xbb45e2fc, 0xbb45e2fc, 0xbbc5bfe3, 0xbbc5bfe3, 0xbbc5bfe3, 0xbbc5bfe3, 0xbbc5bfe3, 0x3bd770be, - 0x3bd770be, 0x3bd770be, 0x3bd770be, 0x3bd770be, 0x3b6944d3, 0x3b6944d3, 0x3b6944d3, 0x3b6944d3, - 0x3b6944d3, 0x3a0e9e7d, 0x3a0e9e7d, 0x3a0e9e7d, 0x3a0e9e7d, 0x3a0e9e7d, 0xbb21f5aa, 0xbb21f5aa, - 0xbb21f5aa, 0xbb21f5aa, 0xbb21f5aa, 0xbbb3c949, 0xbbb3c949, 0xbbb3c949, 0xbbb3c949, 0xbbb3c949, - 0x3be96750, 0x3be96750, 0x3be96750, 0x3be96750, 0x3be96750, 0x3b86990e, 0x3b86990e, 0x3b86990e, - 0x3b86990e, 0x3b86990e, 0x3a8f29f3, 0x3a8f29f3, 0x3a8f29f3, 0x3a8f29f3, 0x3a8f29f3, 0xbafc10a9, - 0xbafc10a9, 0xbafc10a9, 0xbafc10a9, 0xbafc10a9, 0xbba1d2ac, 0xbba1d2ac, 0xbba1d2ac, 0xbba1d2ac, - 0xbba1d2ac, 0x3bfb5ddd, 0x3bfb5ddd, 0x3bfb5ddd, 0x3bfb5ddd, 0x3bfb5ddd, 0x3b988fb1, 0x3b988fb1, - 0x3b988fb1, 0x3b988fb1, 0x3b988fb1, 0x3ad704a4, 0x3ad704a4, 0x3ad704a4, 0x3ad704a4, 0x3ad704a4, - 0xbab435fa, 0xbab435fa, 0xbab435fa, 0xbab435fa, 0xbab435fa, 0xbb8fdc0b, 0xbb8fdc0b, 0xbb8fdc0b, - 0xbb8fdc0b, 0xbb8fdc0b, 0xbbf2aa42, 0xbbf2aa42, 0xbbf2aa42, 0xbbf2aa42, 0xbbf2aa42, 0x3baa8650, - 0x3baa8650, 0x3baa8650, 0x3baa8650, 0x3baa8650, 0x3b0f6fa9, 0x3b0f6fa9, 0x3b0f6fa9, 0x3b0f6fa9, - 0x3b0f6fa9, 0xba58b68e, 0xba58b68e, 0xba58b68e, 0xba58b68e, 0xba58b68e, 0xbb7bcacf, 0xbb7bcacf, - 0xbb7bcacf, 0xbb7bcacf, 0xbb7bcacf, 0xbbe0b3b3, 0xbbe0b3b3, 0xbbe0b3b3, 0xbbe0b3b3, 0xbbe0b3b3, - 0x3bbc7cec, 0x3bbc7cec, 0x3bbc7cec, 0x3bbc7cec, 0x3bbc7cec, 0x3b335cfd, 0x3b335cfd, 0x3b335cfd, - 0x3b335cfd, 0x3b335cfd, 0xb9920246, 0xb9920246, 0xb9920246, 0xb9920246, 0xb9920246, 0xbb57dd83, - 0xbb57dd83, 0xbb57dd83, 0xbb57dd83, 0xbb57dd83, 0xbbcebd1f, 0xbbcebd1f, 0xbbcebd1f, 0xbbcebd1f, - 0xbbcebd1f, 0x3bce7384, 0x3bce7384, 0x3bce7384, 0x3bce7384, 0x3bce7384, 0x3b574a4d, 0x3b574a4d, - 0x3b574a4d, 0x3b574a4d, 0x3b574a4d, 0x398d6891, 0x398d6891, 0x398d6891, 0x398d6891, 0x398d6891, - 0xbb33f033, 0xbb33f033, 0xbb33f033, 0xbb33f033, 0xbb33f033, 0xbbbcc687, 0xbbbcc687, 0xbbbcc687, - 0xbbbcc687, 0xbbbcc687, 0x3be06a18, 0x3be06a18, 0x3be06a18, 0x3be06a18, 0x3be06a18, 0x3b7b3799, - 0x3b7b3799, 0x3b7b3799, 0x3b7b3799, 0x3b7b3799, 0x3a5669b3, 0x3a5669b3, 0x3a5669b3, 0x3a5669b3, - 0x3a5669b3, 0xbb1002df, 0xbb1002df, 0xbb1002df, 0xbb1002df, 0xbb1002df, 0xbbaacfeb, 0xbbaacfeb, - 0xbbaacfeb, 0xbbaacfeb, 0xbbaacfeb, 0x3bf260a7, 0x3bf260a7, 0x3bf260a7, 0x3bf260a7, 0x3bf260a7, - 0x3b8f9270, 0x3b8f9270, 0x3b8f9270, 0x3b8f9270, 0x3b8f9270, 0x3ab30f8d, 0x3ab30f8d, 0x3ab30f8d, - 0x3ab30f8d, 0x3ab30f8d, 0xbad82b12, 0xbad82b12, 0xbad82b12, 0xbad82b12, 0xbad82b12, 0xbb98d94c, - 0xbb98d94c, 0xbb98d94c, 0xbb98d94c, 0xbb98d94c, 0xbbfba778, 0xbbfba778, 0xbbfba778, 0xbbfba778, - 0xbbfba778, 0x3ba18911, 0x3ba18911, 0x3ba18911, 0x3ba18911, 0x3ba18911, 0x3afaea3c, 0x3afaea3c, - 0x3afaea3c, 0x3afaea3c, 0x3afaea3c, 0xba905060, 0xba905060, 0xba905060, 0xba905060, 0xba905060, - 0xbb86e2aa, 0xbb86e2aa, 0xbb86e2aa, 0xbb86e2aa, 0xbb86e2aa, 0xbbe9b0eb, 0xbbe9b0eb, 0xbbe9b0eb, - 0xbbe9b0eb, 0xbbe9b0eb, 0x3bb37fae, 0x3bb37fae, 0x3bb37fae, 0x3bb37fae, 0x3bb37fae, 0x3b216273, -] )) ), - -################ chunk 5632 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x482d0875, 0x482d0875, 0x482d0875, 0x482d0875, 0x482d56ff, 0x482d56ff, 0x482d56ff, 0x482d56ff, - 0x482d56ff, 0x482da589, 0x482da589, 0x482da589, 0x482da589, 0x482da589, 0x482df413, 0x482df413, - 0x482df413, 0x482df413, 0x482df413, 0x482e429e, 0x482e429e, 0x482e429e, 0x482e429e, 0x482e429e, - 0x482e9128, 0x482e9128, 0x482e9128, 0x482e9128, 0x482e9128, 0x482edfb2, 0x482edfb2, 0x482edfb2, - 0x482edfb2, 0x482edfb2, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f7cc6, - 0x482f7cc6, 0x482f7cc6, 0x482f7cc6, 0x482f7cc6, 0x482fcb51, 0x482fcb51, 0x482fcb51, 0x482fcb51, - 0x482fcb51, 0x483019db, 0x483019db, 0x483019db, 0x483019db, 0x483019db, 0x48306865, 0x48306865, - 0x48306865, 0x48306865, 0x48306865, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, - 0x48310579, 0x48310579, 0x48310579, 0x48310579, 0x48310579, 0x48315404, 0x48315404, 0x48315404, - 0x48315404, 0x48315404, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831f118, - 0x4831f118, 0x4831f118, 0x4831f118, 0x4831f118, 0x48323fa2, 0x48323fa2, 0x48323fa2, 0x48323fa2, - 0x48323fa2, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x4832dcb7, 0x4832dcb7, - 0x4832dcb7, 0x4832dcb7, 0x4832dcb7, 0x48332b41, 0x48332b41, 0x48332b41, 0x48332b41, 0x48332b41, - 0x483379cb, 0x483379cb, 0x483379cb, 0x483379cb, 0x483379cb, 0x4833c855, 0x4833c855, 0x4833c855, - 0x4833c855, 0x4833c855, 0x483416df, 0x483416df, 0x483416df, 0x483416df, 0x483416df, 0x48346569, - 0x48346569, 0x48346569, 0x48346569, 0x48346569, 0x4834b3f4, 0x4834b3f4, 0x4834b3f4, 0x4834b3f4, - 0x4834b3f4, 0x4835027e, 0x4835027e, 0x4835027e, 0x4835027e, 0x4835027e, 0x48355108, 0x48355108, - 0x48355108, 0x48355108, 0x48355108, 0x48359f92, 0x48359f92, 0x48359f92, 0x48359f92, 0x48359f92, - 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x48363ca7, 0x48363ca7, 0x48363ca7, - 0x48363ca7, 0x48363ca7, 0x48368b31, 0x48368b31, 0x48368b31, 0x48368b31, 0x48368b31, 0x4836d9bb, - 0x4836d9bb, 0x4836d9bb, 0x4836d9bb, 0x4836d9bb, 0x48372845, 0x48372845, 0x48372845, 0x48372845, - 0x48372845, 0x483776cf, 0x483776cf, 0x483776cf, 0x483776cf, 0x483776cf, 0x4837c55a, 0x4837c55a, - 0x4837c55a, 0x4837c55a, 0x4837c55a, 0x483813e4, 0x483813e4, 0x483813e4, 0x483813e4, 0x483813e4, - 0x4838626e, 0x4838626e, 0x4838626e, 0x4838626e, 0x4838626e, 0x4838b0f8, 0x4838b0f8, 0x4838b0f8, - 0x4838b0f8, 0x4838b0f8, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x48394e0d, - 0x48394e0d, 0x48394e0d, 0x48394e0d, 0x48394e0d, 0x48399c97, 0x48399c97, 0x48399c97, 0x48399c97, - 0x48399c97, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x483a39ab, 0x483a39ab, - 0x483a39ab, 0x483a39ab, 0x483a39ab, 0x483a8835, 0x483a8835, 0x483a8835, 0x483a8835, 0x483a8835, - 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483b254a, 0x483b254a, 0x483b254a, - 0x483b254a, 0x483b254a, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483bc25e, - 0x483bc25e, 0x483bc25e, 0x483bc25e, 0x483bc25e, 0x483c10e8, 0x483c10e8, 0x483c10e8, 0x483c10e8, - 0x483c10e8, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483cadfd, 0x483cadfd, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3b216273, 0x3b216273, 0x3b216273, 0x3b216273, 0xba10eb58, 0xba10eb58, 0xba10eb58, 0xba10eb58, - 0xba10eb58, 0xbb69d80a, 0xbb69d80a, 0xbb69d80a, 0xbb69d80a, 0xbb69d80a, 0xbbd7ba59, 0xbbd7ba59, - 0xbbd7ba59, 0xbbd7ba59, 0xbbd7ba59, 0x3bc57648, 0x3bc57648, 0x3bc57648, 0x3bc57648, 0x3bc57648, - 0x3b454fc6, 0x3b454fc6, 0x3b454fc6, 0x3b454fc6, 0x3b454fc6, 0xb69af629, 0xb69af629, 0xb69af629, - 0xb69af629, 0xb69af629, 0xbb45eabc, 0xbb45eabc, 0xbb45eabc, 0xbb45eabc, 0xbb45eabc, 0xbbc5c3c3, - 0xbbc5c3c3, 0xbbc5c3c3, 0xbbc5c3c3, 0xbbc5c3c3, 0x3bd76cde, 0x3bd76cde, 0x3bd76cde, 0x3bd76cde, - 0x3bd76cde, 0x3b693d14, 0x3b693d14, 0x3b693d14, 0x3b693d14, 0x3b693d14, 0x3a0e7f7f, 0x3a0e7f7f, - 0x3a0e7f7f, 0x3a0e7f7f, 0x3a0e7f7f, 0xbb21fd69, 0xbb21fd69, 0xbb21fd69, 0xbb21fd69, 0xbb21fd69, - 0xbbb3cd29, 0xbbb3cd29, 0xbbb3cd29, 0xbbb3cd29, 0xbbb3cd29, 0x3be96370, 0x3be96370, 0x3be96370, - 0x3be96370, 0x3be96370, 0x3b86952f, 0x3b86952f, 0x3b86952f, 0x3b86952f, 0x3b86952f, 0x3a8f1a74, - 0x3a8f1a74, 0x3a8f1a74, 0x3a8f1a74, 0x3a8f1a74, 0xbafc2028, 0xbafc2028, 0xbafc2028, 0xbafc2028, - 0xbafc2028, 0xbba1d68c, 0xbba1d68c, 0xbba1d68c, 0xbba1d68c, 0xbba1d68c, 0x3bfb59fe, 0x3bfb59fe, - 0x3bfb59fe, 0x3bfb59fe, 0x3bfb59fe, 0x3b988bd1, 0x3b988bd1, 0x3b988bd1, 0x3b988bd1, 0x3b988bd1, - 0x3ad6f525, 0x3ad6f525, 0x3ad6f525, 0x3ad6f525, 0x3ad6f525, 0xbab44579, 0xbab44579, 0xbab44579, - 0xbab44579, 0xbab44579, 0xbb8fdfeb, 0xbb8fdfeb, 0xbb8fdfeb, 0xbb8fdfeb, 0xbb8fdfeb, 0xbbf2ae22, - 0xbbf2ae22, 0xbbf2ae22, 0xbbf2ae22, 0xbbf2ae22, 0x3baa8270, 0x3baa8270, 0x3baa8270, 0x3baa8270, - 0x3baa8270, 0x3b0f67e9, 0x3b0f67e9, 0x3b0f67e9, 0x3b0f67e9, 0x3b0f67e9, 0xba58d58c, 0xba58d58c, - 0xba58d58c, 0xba58d58c, 0xba58d58c, 0xbb7bd28f, 0xbb7bd28f, 0xbb7bd28f, 0xbb7bd28f, 0xbb7bd28f, - 0xbbe0b792, 0xbbe0b792, 0xbbe0b792, 0xbbe0b792, 0xbbe0b792, 0x3bbc790c, 0x3bbc790c, 0x3bbc790c, - 0x3bbc790c, 0x3bbc790c, 0x3b33553d, 0x3b33553d, 0x3b33553d, 0x3b33553d, 0x3b33553d, 0xb9924043, - 0xb9924043, 0xb9924043, 0xb9924043, 0xb9924043, 0xbb57e543, 0xbb57e543, 0xbb57e543, 0xbb57e543, - 0xbb57e543, 0xbbcec0fe, 0xbbcec0fe, 0xbbcec0fe, 0xbbcec0fe, 0xbbcec0fe, 0x3bce6fa4, 0x3bce6fa4, - 0x3bce6fa4, 0x3bce6fa4, 0x3bce6fa4, 0x3b57428d, 0x3b57428d, 0x3b57428d, 0x3b57428d, 0x3b57428d, - 0x398d2a95, 0x398d2a95, 0x398d2a95, 0x398d2a95, 0x398d2a95, 0xbb33f7f3, 0xbb33f7f3, 0xbb33f7f3, - 0xbb33f7f3, 0xbb33f7f3, 0xbbbcca66, 0xbbbcca66, 0xbbbcca66, 0xbbbcca66, 0xbbbcca66, 0x3be06638, - 0x3be06638, 0x3be06638, 0x3be06638, 0x3be06638, 0x3b7b2fda, 0x3b7b2fda, 0x3b7b2fda, 0x3b7b2fda, - 0x3b7b2fda, 0x3a564ab5, 0x3a564ab5, 0x3a564ab5, 0x3a564ab5, 0x3a564ab5, 0xbb100a9f, 0xbb100a9f, - 0xbb100a9f, 0xbb100a9f, 0xbb100a9f, 0xbbaad3cb, 0xbbaad3cb, 0xbbaad3cb, 0xbbaad3cb, 0xbbaad3cb, - 0x3bf25cc8, 0x3bf25cc8, 0x3bf25cc8, 0x3bf25cc8, 0x3bf25cc8, 0x3b8f8e90, 0x3b8f8e90, 0x3b8f8e90, - 0x3b8f8e90, 0x3b8f8e90, 0x3ab3000e, 0x3ab3000e, 0x3ab3000e, 0x3ab3000e, 0x3ab3000e, 0xbad83a91, - 0xbad83a91, 0xbad83a91, 0xbad83a91, 0xbad83a91, 0xbb98dd2c, 0xbb98dd2c, 0xbb98dd2c, 0xbb98dd2c, - 0xbb98dd2c, 0xbbfbab58, 0xbbfbab58, 0xbbfbab58, 0xbbfbab58, 0xbbfbab58, 0x3ba18531, 0x3ba18531, -] )) ), - -################ chunk 6144 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x483cadfd, 0x483cadfd, 0x483cadfd, 0x483cfc87, 0x483cfc87, 0x483cfc87, 0x483cfc87, 0x483cfc87, - 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d999b, 0x483d999b, 0x483d999b, - 0x483d999b, 0x483d999b, 0x483de825, 0x483de825, 0x483de825, 0x483de825, 0x483de825, 0x483e36b0, - 0x483e36b0, 0x483e36b0, 0x483e36b0, 0x483e36b0, 0x483e853a, 0x483e853a, 0x483e853a, 0x483e853a, - 0x483e853a, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483f224e, 0x483f224e, - 0x483f224e, 0x483f224e, 0x483f224e, 0x483f70d8, 0x483f70d8, 0x483f70d8, 0x483f70d8, 0x483f70d8, - 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x48400ded, 0x48400ded, 0x48400ded, - 0x48400ded, 0x48400ded, 0x48405c77, 0x48405c77, 0x48405c77, 0x48405c77, 0x48405c77, 0x4840ab01, - 0x4840ab01, 0x4840ab01, 0x4840ab01, 0x4840ab01, 0x4840f98b, 0x4840f98b, 0x4840f98b, 0x4840f98b, - 0x4840f98b, 0x48414816, 0x48414816, 0x48414816, 0x48414816, 0x48414816, 0x484196a0, 0x484196a0, - 0x484196a0, 0x484196a0, 0x484196a0, 0x4841e52a, 0x4841e52a, 0x4841e52a, 0x4841e52a, 0x4841e52a, - 0x484233b4, 0x484233b4, 0x484233b4, 0x484233b4, 0x484233b4, 0x4842823e, 0x4842823e, 0x4842823e, - 0x4842823e, 0x4842823e, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x48431f53, - 0x48431f53, 0x48431f53, 0x48431f53, 0x48431f53, 0x48436ddd, 0x48436ddd, 0x48436ddd, 0x48436ddd, - 0x48436ddd, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x48440af1, 0x48440af1, - 0x48440af1, 0x48440af1, 0x48440af1, 0x4844597c, 0x4844597c, 0x4844597c, 0x4844597c, 0x4844597c, - 0x4844a806, 0x4844a806, 0x4844a806, 0x4844a806, 0x4844a806, 0x4844f690, 0x4844f690, 0x4844f690, - 0x4844f690, 0x4844f690, 0x4845451a, 0x4845451a, 0x4845451a, 0x4845451a, 0x4845451a, 0x484593a4, - 0x484593a4, 0x484593a4, 0x484593a4, 0x484593a4, 0x4845e22e, 0x4845e22e, 0x4845e22e, 0x4845e22e, - 0x4845e22e, 0x484630b9, 0x484630b9, 0x484630b9, 0x484630b9, 0x484630b9, 0x48467f43, 0x48467f43, - 0x48467f43, 0x48467f43, 0x48467f43, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, - 0x48471c57, 0x48471c57, 0x48471c57, 0x48471c57, 0x48471c57, 0x48476ae1, 0x48476ae1, 0x48476ae1, - 0x48476ae1, 0x48476ae1, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x484807f6, - 0x484807f6, 0x484807f6, 0x484807f6, 0x484807f6, 0x48485680, 0x48485680, 0x48485680, 0x48485680, - 0x48485680, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848f394, 0x4848f394, - 0x4848f394, 0x4848f394, 0x4848f394, 0x4849421f, 0x4849421f, 0x4849421f, 0x4849421f, 0x4849421f, - 0x484990a9, 0x484990a9, 0x484990a9, 0x484990a9, 0x484990a9, 0x4849df33, 0x4849df33, 0x4849df33, - 0x4849df33, 0x4849df33, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a7c47, - 0x484a7c47, 0x484a7c47, 0x484a7c47, 0x484a7c47, 0x484acad2, 0x484acad2, 0x484acad2, 0x484acad2, - 0x484acad2, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b67e6, 0x484b67e6, - 0x484b67e6, 0x484b67e6, 0x484b67e6, 0x484bb670, 0x484bb670, 0x484bb670, 0x484bb670, 0x484bb670, - 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c5385, 0x484c5385, 0x484c5385, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3ba18531, 0x3ba18531, 0x3ba18531, 0x3afadabd, 0x3afadabd, 0x3afadabd, 0x3afadabd, 0x3afadabd, - 0xba905fdf, 0xba905fdf, 0xba905fdf, 0xba905fdf, 0xba905fdf, 0xbb86e689, 0xbb86e689, 0xbb86e689, - 0xbb86e689, 0xbb86e689, 0xbbe9b4cb, 0xbbe9b4cb, 0xbbe9b4cb, 0xbbe9b4cb, 0xbbe9b4cb, 0x3bb37bcf, - 0x3bb37bcf, 0x3bb37bcf, 0x3bb37bcf, 0x3bb37bcf, 0x3b215ab4, 0x3b215ab4, 0x3b215ab4, 0x3b215ab4, - 0x3b215ab4, 0xba110a56, 0xba110a56, 0xba110a56, 0xba110a56, 0xba110a56, 0xbb69dfc9, 0xbb69dfc9, - 0xbb69dfc9, 0xbb69dfc9, 0xbb69dfc9, 0xbbd7be39, 0xbbd7be39, 0xbbd7be39, 0xbbd7be39, 0xbbd7be39, - 0x3bc57269, 0x3bc57269, 0x3bc57269, 0x3bc57269, 0x3bc57269, 0x3b454806, 0x3b454806, 0x3b454806, - 0x3b454806, 0x3b454806, 0xb6aa752d, 0xb6aa752d, 0xb6aa752d, 0xb6aa752d, 0xb6aa752d, 0xbb45f27b, - 0xbb45f27b, 0xbb45f27b, 0xbb45f27b, 0xbb45f27b, 0xbbc5c7a3, 0xbbc5c7a3, 0xbbc5c7a3, 0xbbc5c7a3, - 0xbbc5c7a3, 0x3bd768ff, 0x3bd768ff, 0x3bd768ff, 0x3bd768ff, 0x3bd768ff, 0x3b693554, 0x3b693554, - 0x3b693554, 0x3b693554, 0x3b693554, 0x3a0e6081, 0x3a0e6081, 0x3a0e6081, 0x3a0e6081, 0x3a0e6081, - 0xbb220529, 0xbb220529, 0xbb220529, 0xbb220529, 0xbb220529, 0xbbb3d109, 0xbbb3d109, 0xbbb3d109, - 0xbbb3d109, 0xbbb3d109, 0x3be95f91, 0x3be95f91, 0x3be95f91, 0x3be95f91, 0x3be95f91, 0x3b86914f, - 0x3b86914f, 0x3b86914f, 0x3b86914f, 0x3b86914f, 0x3a8f0af5, 0x3a8f0af5, 0x3a8f0af5, 0x3a8f0af5, - 0x3a8f0af5, 0xbafc2fa7, 0xbafc2fa7, 0xbafc2fa7, 0xbafc2fa7, 0xbafc2fa7, 0xbba1da6b, 0xbba1da6b, - 0xbba1da6b, 0xbba1da6b, 0xbba1da6b, 0x3bfb561e, 0x3bfb561e, 0x3bfb561e, 0x3bfb561e, 0x3bfb561e, - 0x3b9887f1, 0x3b9887f1, 0x3b9887f1, 0x3b9887f1, 0x3b9887f1, 0x3ad6e5a6, 0x3ad6e5a6, 0x3ad6e5a6, - 0x3ad6e5a6, 0x3ad6e5a6, 0xbab454f8, 0xbab454f8, 0xbab454f8, 0xbab454f8, 0xbab454f8, 0xbb8fe3cb, - 0xbb8fe3cb, 0xbb8fe3cb, 0xbb8fe3cb, 0xbb8fe3cb, 0xbbf2b202, 0xbbf2b202, 0xbbf2b202, 0xbbf2b202, - 0xbbf2b202, 0x3baa7e90, 0x3baa7e90, 0x3baa7e90, 0x3baa7e90, 0x3baa7e90, 0x3b0f602a, 0x3b0f602a, - 0x3b0f602a, 0x3b0f602a, 0x3b0f602a, 0xba58f48a, 0xba58f48a, 0xba58f48a, 0xba58f48a, 0xba58f48a, - 0xbb7bda4e, 0xbb7bda4e, 0xbb7bda4e, 0xbb7bda4e, 0xbb7bda4e, 0xbbe0bb72, 0xbbe0bb72, 0xbbe0bb72, - 0xbbe0bb72, 0xbbe0bb72, 0x3bbc752c, 0x3bbc752c, 0x3bbc752c, 0x3bbc752c, 0x3bbc752c, 0x3b334d7e, - 0x3b334d7e, 0x3b334d7e, 0x3b334d7e, 0x3b334d7e, 0xb9927e3f, 0xb9927e3f, 0xb9927e3f, 0xb9927e3f, - 0xb9927e3f, 0xbb57ed02, 0xbb57ed02, 0xbb57ed02, 0xbb57ed02, 0xbb57ed02, 0xbbcec4de, 0xbbcec4de, - 0xbbcec4de, 0xbbcec4de, 0xbbcec4de, 0x3bce6bc4, 0x3bce6bc4, 0x3bce6bc4, 0x3bce6bc4, 0x3bce6bc4, - 0x3b573ace, 0x3b573ace, 0x3b573ace, 0x3b573ace, 0x3b573ace, 0x398cec99, 0x398cec99, 0x398cec99, - 0x398cec99, 0x398cec99, 0xbb33ffb2, 0xbb33ffb2, 0xbb33ffb2, 0xbb33ffb2, 0xbb33ffb2, 0xbbbcce46, - 0xbbbcce46, 0xbbbcce46, 0xbbbcce46, 0xbbbcce46, 0x3be06258, 0x3be06258, 0x3be06258, 0x3be06258, - 0x3be06258, 0x3b7b281a, 0x3b7b281a, 0x3b7b281a, 0x3b7b281a, 0x3b7b281a, 0x3a562bb7, 0x3a562bb7, - 0x3a562bb7, 0x3a562bb7, 0x3a562bb7, 0xbb10125e, 0xbb10125e, 0xbb10125e, 0xbb10125e, 0xbb10125e, - 0xbbaad7aa, 0xbbaad7aa, 0xbbaad7aa, 0xbbaad7aa, 0xbbaad7aa, 0x3bf258e8, 0x3bf258e8, 0x3bf258e8, -] )) ), - -################ chunk 6656 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x484c5385, 0x484c5385, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484cf099, - 0x484cf099, 0x484cf099, 0x484cf099, 0x484cf099, 0x484d3f23, 0x484d3f23, 0x484d3f23, 0x484d3f23, - 0x484d3f23, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484ddc37, 0x484ddc37, - 0x484ddc37, 0x484ddc37, 0x484ddc37, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, - 0x484e794c, 0x484e794c, 0x484e794c, 0x484e794c, 0x484e794c, 0x484ec7d6, 0x484ec7d6, 0x484ec7d6, - 0x484ec7d6, 0x484ec7d6, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f64ea, - 0x484f64ea, 0x484f64ea, 0x484f64ea, 0x484f64ea, 0x484fb375, 0x484fb375, 0x484fb375, 0x484fb375, - 0x484fb375, 0x485001ff, 0x485001ff, 0x485001ff, 0x485001ff, 0x485001ff, 0x48505089, 0x48505089, - 0x48505089, 0x48505089, 0x48505089, 0x48509f13, 0x48509f13, 0x48509f13, 0x48509f13, 0x48509f13, - 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x48513c28, 0x48513c28, 0x48513c28, - 0x48513c28, 0x48513c28, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x4851d93c, - 0x4851d93c, 0x4851d93c, 0x4851d93c, 0x4851d93c, 0x485227c6, 0x485227c6, 0x485227c6, 0x485227c6, - 0x485227c6, 0x48527650, 0x48527650, 0x48527650, 0x48527650, 0x48527650, 0x4852c4db, 0x4852c4db, - 0x4852c4db, 0x4852c4db, 0x4852c4db, 0x48531365, 0x48531365, 0x48531365, 0x48531365, 0x48531365, - 0x485361ef, 0x485361ef, 0x485361ef, 0x485361ef, 0x485361ef, 0x4853b079, 0x4853b079, 0x4853b079, - 0x4853b079, 0x4853b079, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x48544d8e, - 0x48544d8e, 0x48544d8e, 0x48544d8e, 0x48544d8e, 0x48549c18, 0x48549c18, 0x48549c18, 0x48549c18, - 0x48549c18, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4855392c, 0x4855392c, - 0x4855392c, 0x4855392c, 0x4855392c, 0x485587b6, 0x485587b6, 0x485587b6, 0x485587b6, 0x485587b6, - 0x4855d641, 0x4855d641, 0x4855d641, 0x4855d641, 0x4855d641, 0x485624cb, 0x485624cb, 0x485624cb, - 0x485624cb, 0x485624cb, 0x48567355, 0x48567355, 0x48567355, 0x48567355, 0x48567355, 0x4856c1df, - 0x4856c1df, 0x4856c1df, 0x4856c1df, 0x4856c1df, 0x48571069, 0x48571069, 0x48571069, 0x48571069, - 0x48571069, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x4857ad7e, 0x4857ad7e, - 0x4857ad7e, 0x4857ad7e, 0x4857ad7e, 0x4857fc08, 0x4857fc08, 0x4857fc08, 0x4857fc08, 0x4857fc08, - 0x48584a92, 0x48584a92, 0x48584a92, 0x48584a92, 0x48584a92, 0x4858991c, 0x4858991c, 0x4858991c, - 0x4858991c, 0x4858991c, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x48593631, - 0x48593631, 0x48593631, 0x48593631, 0x48593631, 0x485984bb, 0x485984bb, 0x485984bb, 0x485984bb, - 0x485984bb, 0x4859d345, 0x4859d345, 0x4859d345, 0x4859d345, 0x4859d345, 0x485a21cf, 0x485a21cf, - 0x485a21cf, 0x485a21cf, 0x485a21cf, 0x485a7059, 0x485a7059, 0x485a7059, 0x485a7059, 0x485a7059, - 0x485abee4, 0x485abee4, 0x485abee4, 0x485abee4, 0x485abee4, 0x485b0d6e, 0x485b0d6e, 0x485b0d6e, - 0x485b0d6e, 0x485b0d6e, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485baa82, - 0x485baa82, 0x485baa82, 0x485baa82, 0x485baa82, 0x485bf90c, 0x485bf90c, 0x485bf90c, 0x485bf90c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3bf258e8, 0x3bf258e8, 0x3b8f8ab1, 0x3b8f8ab1, 0x3b8f8ab1, 0x3b8f8ab1, 0x3b8f8ab1, 0x3ab2f08f, - 0x3ab2f08f, 0x3ab2f08f, 0x3ab2f08f, 0x3ab2f08f, 0xbad84a10, 0xbad84a10, 0xbad84a10, 0xbad84a10, - 0xbad84a10, 0xbb98e10b, 0xbb98e10b, 0xbb98e10b, 0xbb98e10b, 0xbb98e10b, 0xbbfbaf38, 0xbbfbaf38, - 0xbbfbaf38, 0xbbfbaf38, 0xbbfbaf38, 0x3ba18151, 0x3ba18151, 0x3ba18151, 0x3ba18151, 0x3ba18151, - 0x3afacb3e, 0x3afacb3e, 0x3afacb3e, 0x3afacb3e, 0x3afacb3e, 0xba906f5e, 0xba906f5e, 0xba906f5e, - 0xba906f5e, 0xba906f5e, 0xbb86ea69, 0xbb86ea69, 0xbb86ea69, 0xbb86ea69, 0xbb86ea69, 0xbbe9b8aa, - 0xbbe9b8aa, 0xbbe9b8aa, 0xbbe9b8aa, 0xbbe9b8aa, 0x3bb377ef, 0x3bb377ef, 0x3bb377ef, 0x3bb377ef, - 0x3bb377ef, 0x3b2152f4, 0x3b2152f4, 0x3b2152f4, 0x3b2152f4, 0x3b2152f4, 0xba112954, 0xba112954, - 0xba112954, 0xba112954, 0xba112954, 0xbb69e789, 0xbb69e789, 0xbb69e789, 0xbb69e789, 0xbb69e789, - 0xbbd7c219, 0xbbd7c219, 0xbbd7c219, 0xbbd7c219, 0xbbd7c219, 0x3bc56e89, 0x3bc56e89, 0x3bc56e89, - 0x3bc56e89, 0x3bc56e89, 0x3b454047, 0x3b454047, 0x3b454047, 0x3b454047, 0x3b454047, 0xb6b9f432, - 0xb6b9f432, 0xb6b9f432, 0xb6b9f432, 0xb6b9f432, 0xbb45fa3b, 0xbb45fa3b, 0xbb45fa3b, 0xbb45fa3b, - 0xbb45fa3b, 0xbbc5cb83, 0xbbc5cb83, 0xbbc5cb83, 0xbbc5cb83, 0xbbc5cb83, 0x3bd7651f, 0x3bd7651f, - 0x3bd7651f, 0x3bd7651f, 0x3bd7651f, 0x3b692d95, 0x3b692d95, 0x3b692d95, 0x3b692d95, 0x3b692d95, - 0x3a0e4183, 0x3a0e4183, 0x3a0e4183, 0x3a0e4183, 0x3a0e4183, 0xbb220ce8, 0xbb220ce8, 0xbb220ce8, - 0xbb220ce8, 0xbb220ce8, 0xbbb3d4e9, 0xbbb3d4e9, 0xbbb3d4e9, 0xbbb3d4e9, 0xbbb3d4e9, 0x3be95bb1, - 0x3be95bb1, 0x3be95bb1, 0x3be95bb1, 0x3be95bb1, 0x3b868d6f, 0x3b868d6f, 0x3b868d6f, 0x3b868d6f, - 0x3b868d6f, 0x3a8efb76, 0x3a8efb76, 0x3a8efb76, 0x3a8efb76, 0x3a8efb76, 0xbafc3f26, 0xbafc3f26, - 0xbafc3f26, 0xbafc3f26, 0xbafc3f26, 0xbba1de4b, 0xbba1de4b, 0xbba1de4b, 0xbba1de4b, 0xbba1de4b, - 0x3bfb523e, 0x3bfb523e, 0x3bfb523e, 0x3bfb523e, 0x3bfb523e, 0x3b988411, 0x3b988411, 0x3b988411, - 0x3b988411, 0x3b988411, 0x3ad6d627, 0x3ad6d627, 0x3ad6d627, 0x3ad6d627, 0x3ad6d627, 0xbab46477, - 0xbab46477, 0xbab46477, 0xbab46477, 0xbab46477, 0xbb8fe7aa, 0xbb8fe7aa, 0xbb8fe7aa, 0xbb8fe7aa, - 0xbb8fe7aa, 0xbbf2b5e1, 0xbbf2b5e1, 0xbbf2b5e1, 0xbbf2b5e1, 0xbbf2b5e1, 0x3baa7ab1, 0x3baa7ab1, - 0x3baa7ab1, 0x3baa7ab1, 0x3baa7ab1, 0x3b0f586a, 0x3b0f586a, 0x3b0f586a, 0x3b0f586a, 0x3b0f586a, - 0xba591388, 0xba591388, 0xba591388, 0xba591388, 0xba591388, 0xbb7be20e, 0xbb7be20e, 0xbb7be20e, - 0xbb7be20e, 0xbb7be20e, 0xbbe0bf52, 0xbbe0bf52, 0xbbe0bf52, 0xbbe0bf52, 0xbbe0bf52, 0x3bbc714c, - 0x3bbc714c, 0x3bbc714c, 0x3bbc714c, 0x3bbc714c, 0x3b3345be, 0x3b3345be, 0x3b3345be, 0x3b3345be, - 0x3b3345be, 0xb992bc3b, 0xb992bc3b, 0xb992bc3b, 0xb992bc3b, 0xb992bc3b, 0xbb57f4c2, 0xbb57f4c2, - 0xbb57f4c2, 0xbb57f4c2, 0xbb57f4c2, 0xbbcec8be, 0xbbcec8be, 0xbbcec8be, 0xbbcec8be, 0xbbcec8be, - 0x3bce67e5, 0x3bce67e5, 0x3bce67e5, 0x3bce67e5, 0x3bce67e5, 0x3b57330f, 0x3b57330f, 0x3b57330f, - 0x3b57330f, 0x3b57330f, 0x398cae9d, 0x398cae9d, 0x398cae9d, 0x398cae9d, 0x398cae9d, 0xbb340772, - 0xbb340772, 0xbb340772, 0xbb340772, 0xbb340772, 0xbbbcd226, 0xbbbcd226, 0xbbbcd226, 0xbbbcd226, -] )) ), - -################ chunk 7168 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x485bf90c, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c9621, 0x485c9621, - 0x485c9621, 0x485c9621, 0x485c9621, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, - 0x485d3335, 0x485d3335, 0x485d3335, 0x485d3335, 0x485d3335, 0x485d81bf, 0x485d81bf, 0x485d81bf, - 0x485d81bf, 0x485d81bf, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485e1ed4, - 0x485e1ed4, 0x485e1ed4, 0x485e1ed4, 0x485e1ed4, 0x485e6d5e, 0x485e6d5e, 0x485e6d5e, 0x485e6d5e, - 0x485e6d5e, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485f0a72, 0x485f0a72, - 0x485f0a72, 0x485f0a72, 0x485f0a72, 0x485f58fc, 0x485f58fc, 0x485f58fc, 0x485f58fc, 0x485f58fc, - 0x485fa787, 0x485fa787, 0x485fa787, 0x485fa787, 0x485fa787, 0x485ff611, 0x485ff611, 0x485ff611, - 0x485ff611, 0x485ff611, 0x4860449b, 0x4860449b, 0x4860449b, 0x4860449b, 0x4860449b, 0x48609325, - 0x48609325, 0x48609325, 0x48609325, 0x48609325, 0x4860e1af, 0x4860e1af, 0x4860e1af, 0x4860e1af, - 0x4860e1af, 0x4861303a, 0x4861303a, 0x4861303a, 0x4861303a, 0x4861303a, 0x48617ec4, 0x48617ec4, - 0x48617ec4, 0x48617ec4, 0x48617ec4, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, - 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48626a62, 0x48626a62, 0x48626a62, - 0x48626a62, 0x48626a62, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x48630777, - 0x48630777, 0x48630777, 0x48630777, 0x48630777, 0x48635601, 0x48635601, 0x48635601, 0x48635601, - 0x48635601, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863f315, 0x4863f315, - 0x4863f315, 0x4863f315, 0x4863f315, 0x486441a0, 0x486441a0, 0x486441a0, 0x486441a0, 0x486441a0, - 0x4864902a, 0x4864902a, 0x4864902a, 0x4864902a, 0x4864902a, 0x4864deb4, 0x4864deb4, 0x4864deb4, - 0x4864deb4, 0x4864deb4, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48657bc8, - 0x48657bc8, 0x48657bc8, 0x48657bc8, 0x48657bc8, 0x4865ca53, 0x4865ca53, 0x4865ca53, 0x4865ca53, - 0x4865ca53, 0x486618dd, 0x486618dd, 0x486618dd, 0x486618dd, 0x486618dd, 0x48666767, 0x48666767, - 0x48666767, 0x48666767, 0x48666767, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, - 0x4867047b, 0x4867047b, 0x4867047b, 0x4867047b, 0x4867047b, 0x48675306, 0x48675306, 0x48675306, - 0x48675306, 0x48675306, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867f01a, - 0x4867f01a, 0x4867f01a, 0x4867f01a, 0x4867f01a, 0x48683ea4, 0x48683ea4, 0x48683ea4, 0x48683ea4, - 0x48683ea4, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x4868dbb8, 0x4868dbb8, - 0x4868dbb8, 0x4868dbb8, 0x4868dbb8, 0x48692a43, 0x48692a43, 0x48692a43, 0x48692a43, 0x48692a43, - 0x486978cd, 0x486978cd, 0x486978cd, 0x486978cd, 0x486978cd, 0x4869c757, 0x4869c757, 0x4869c757, - 0x4869c757, 0x4869c757, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a646b, - 0x486a646b, 0x486a646b, 0x486a646b, 0x486a646b, 0x486ab2f6, 0x486ab2f6, 0x486ab2f6, 0x486ab2f6, - 0x486ab2f6, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b500a, 0x486b500a, - 0x486b500a, 0x486b500a, 0x486b500a, 0x486b9e94, 0x486b9e94, 0x486b9e94, 0x486b9e94, 0x486b9e94, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbbbcd226, 0x3be05e79, 0x3be05e79, 0x3be05e79, 0x3be05e79, 0x3be05e79, 0x3b7b205b, 0x3b7b205b, - 0x3b7b205b, 0x3b7b205b, 0x3b7b205b, 0x3a560cb9, 0x3a560cb9, 0x3a560cb9, 0x3a560cb9, 0x3a560cb9, - 0xbb101a1e, 0xbb101a1e, 0xbb101a1e, 0xbb101a1e, 0xbb101a1e, 0xbbaadb8a, 0xbbaadb8a, 0xbbaadb8a, - 0xbbaadb8a, 0xbbaadb8a, 0x3bf25508, 0x3bf25508, 0x3bf25508, 0x3bf25508, 0x3bf25508, 0x3b8f86d1, - 0x3b8f86d1, 0x3b8f86d1, 0x3b8f86d1, 0x3b8f86d1, 0x3ab2e110, 0x3ab2e110, 0x3ab2e110, 0x3ab2e110, - 0x3ab2e110, 0xbad8598f, 0xbad8598f, 0xbad8598f, 0xbad8598f, 0xbad8598f, 0xbb98e4eb, 0xbb98e4eb, - 0xbb98e4eb, 0xbb98e4eb, 0xbb98e4eb, 0xbbfbb317, 0xbbfbb317, 0xbbfbb317, 0xbbfbb317, 0xbbfbb317, - 0x3ba17d72, 0x3ba17d72, 0x3ba17d72, 0x3ba17d72, 0x3ba17d72, 0x3afabbbf, 0x3afabbbf, 0x3afabbbf, - 0x3afabbbf, 0x3afabbbf, 0xba907edd, 0xba907edd, 0xba907edd, 0xba907edd, 0xba907edd, 0xbb86ee49, - 0xbb86ee49, 0xbb86ee49, 0xbb86ee49, 0xbb86ee49, 0xbbe9bc8a, 0xbbe9bc8a, 0xbbe9bc8a, 0xbbe9bc8a, - 0xbbe9bc8a, 0x3bb3740f, 0x3bb3740f, 0x3bb3740f, 0x3bb3740f, 0x3bb3740f, 0x3b214b35, 0x3b214b35, - 0x3b214b35, 0x3b214b35, 0x3b214b35, 0xba114852, 0xba114852, 0xba114852, 0xba114852, 0xba114852, - 0xbb69ef48, 0xbb69ef48, 0xbb69ef48, 0xbb69ef48, 0xbb69ef48, 0xbbd7c5f8, 0xbbd7c5f8, 0xbbd7c5f8, - 0xbbd7c5f8, 0xbbd7c5f8, 0x3bc56aa9, 0x3bc56aa9, 0x3bc56aa9, 0x3bc56aa9, 0x3bc56aa9, 0x3b453887, - 0x3b453887, 0x3b453887, 0x3b453887, 0x3b453887, 0xb6c97336, 0xb6c97336, 0xb6c97336, 0xb6c97336, - 0xb6c97336, 0xbb4601fa, 0xbb4601fa, 0xbb4601fa, 0xbb4601fa, 0xbb4601fa, 0xbbc5cf62, 0xbbc5cf62, - 0xbbc5cf62, 0xbbc5cf62, 0xbbc5cf62, 0x3bd7613f, 0x3bd7613f, 0x3bd7613f, 0x3bd7613f, 0x3bd7613f, - 0x3b6925d5, 0x3b6925d5, 0x3b6925d5, 0x3b6925d5, 0x3b6925d5, 0x3a0e2285, 0x3a0e2285, 0x3a0e2285, - 0x3a0e2285, 0x3a0e2285, 0xbb2214a8, 0xbb2214a8, 0xbb2214a8, 0xbb2214a8, 0xbb2214a8, 0xbbb3d8c8, - 0xbbb3d8c8, 0xbbb3d8c8, 0xbbb3d8c8, 0xbbb3d8c8, 0x3be957d1, 0x3be957d1, 0x3be957d1, 0x3be957d1, - 0x3be957d1, 0x3b868990, 0x3b868990, 0x3b868990, 0x3b868990, 0x3b868990, 0x3a8eebf7, 0x3a8eebf7, - 0x3a8eebf7, 0x3a8eebf7, 0x3a8eebf7, 0xbafc4ea5, 0xbafc4ea5, 0xbafc4ea5, 0xbafc4ea5, 0xbafc4ea5, - 0xbba1e22b, 0xbba1e22b, 0xbba1e22b, 0xbba1e22b, 0xbba1e22b, 0x3bfb4e5e, 0x3bfb4e5e, 0x3bfb4e5e, - 0x3bfb4e5e, 0x3bfb4e5e, 0x3b988032, 0x3b988032, 0x3b988032, 0x3b988032, 0x3b988032, 0x3ad6c6a8, - 0x3ad6c6a8, 0x3ad6c6a8, 0x3ad6c6a8, 0x3ad6c6a8, 0xbab473f6, 0xbab473f6, 0xbab473f6, 0xbab473f6, - 0xbab473f6, 0xbb8feb8a, 0xbb8feb8a, 0xbb8feb8a, 0xbb8feb8a, 0xbb8feb8a, 0xbbf2b9c1, 0xbbf2b9c1, - 0xbbf2b9c1, 0xbbf2b9c1, 0xbbf2b9c1, 0x3baa76d1, 0x3baa76d1, 0x3baa76d1, 0x3baa76d1, 0x3baa76d1, - 0x3b0f50ab, 0x3b0f50ab, 0x3b0f50ab, 0x3b0f50ab, 0x3b0f50ab, 0xba593286, 0xba593286, 0xba593286, - 0xba593286, 0xba593286, 0xbb7be9cd, 0xbb7be9cd, 0xbb7be9cd, 0xbb7be9cd, 0xbb7be9cd, 0xbbe0c332, - 0xbbe0c332, 0xbbe0c332, 0xbbe0c332, 0xbbe0c332, 0x3bbc6d6d, 0x3bbc6d6d, 0x3bbc6d6d, 0x3bbc6d6d, - 0x3bbc6d6d, 0x3b333dff, 0x3b333dff, 0x3b333dff, 0x3b333dff, 0x3b333dff, 0xb992fa37, 0xb992fa37, - 0xb992fa37, 0xb992fa37, 0xb992fa37, 0xbb57fc81, 0xbb57fc81, 0xbb57fc81, 0xbb57fc81, 0xbb57fc81, -] )) ), - -################ chunk 7680 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486c3ba9, 0x486c3ba9, 0x486c3ba9, - 0x486c3ba9, 0x486c3ba9, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486cd8bd, - 0x486cd8bd, 0x486cd8bd, 0x486cd8bd, 0x486cd8bd, 0x486d2747, 0x486d2747, 0x486d2747, 0x486d2747, - 0x486d2747, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486dc45c, 0x486dc45c, - 0x486dc45c, 0x486dc45c, 0x486dc45c, 0x486e12e6, 0x486e12e6, 0x486e12e6, 0x486e12e6, 0x486e12e6, - 0x486e6170, 0x486e6170, 0x486e6170, 0x486e6170, 0x486e6170, 0x486eaffa, 0x486eaffa, 0x486eaffa, - 0x486eaffa, 0x486eaffa, 0x486efe84, 0x486efe84, 0x486efe84, 0x486efe84, 0x486efe84, 0x486f4d0f, - 0x486f4d0f, 0x486f4d0f, 0x486f4d0f, 0x486f4d0f, 0x486f9b99, 0x486f9b99, 0x486f9b99, 0x486f9b99, - 0x486f9b99, 0x486fea23, 0x486fea23, 0x486fea23, 0x486fea23, 0x486fea23, 0x487038ad, 0x487038ad, - 0x487038ad, 0x487038ad, 0x487038ad, 0x48708737, 0x48708737, 0x48708737, 0x48708737, 0x48708737, - 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4871244c, 0x4871244c, 0x4871244c, - 0x4871244c, 0x4871244c, 0x487172d6, 0x487172d6, 0x487172d6, 0x487172d6, 0x487172d6, 0x4871c160, - 0x4871c160, 0x4871c160, 0x4871c160, 0x4871c160, 0x48720fea, 0x48720fea, 0x48720fea, 0x48720fea, - 0x48720fea, 0x48725e74, 0x48725e74, 0x48725e74, 0x48725e74, 0x48725e74, 0x4872acff, 0x4872acff, - 0x4872acff, 0x4872acff, 0x4872acff, 0x4872fb89, 0x4872fb89, 0x4872fb89, 0x4872fb89, 0x4872fb89, - 0x48734a13, 0x48734a13, 0x48734a13, 0x48734a13, 0x48734a13, 0x4873989d, 0x4873989d, 0x4873989d, - 0x4873989d, 0x4873989d, 0x4873e727, 0x4873e727, 0x4873e727, 0x4873e727, 0x4873e727, 0x487435b2, - 0x487435b2, 0x487435b2, 0x487435b2, 0x487435b2, 0x4874843c, 0x4874843c, 0x4874843c, 0x4874843c, - 0x4874843c, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x48752150, 0x48752150, - 0x48752150, 0x48752150, 0x48752150, 0x48756fda, 0x48756fda, 0x48756fda, 0x48756fda, 0x48756fda, - 0x4875be65, 0x4875be65, 0x4875be65, 0x4875be65, 0x4875be65, 0x48760cef, 0x48760cef, 0x48760cef, - 0x48760cef, 0x48760cef, 0x48765b79, 0x48765b79, 0x48765b79, 0x48765b79, 0x48765b79, 0x4876aa03, - 0x4876aa03, 0x4876aa03, 0x4876aa03, 0x4876aa03, 0x4876f88d, 0x4876f88d, 0x4876f88d, 0x4876f88d, - 0x4876f88d, 0x48774718, 0x48774718, 0x48774718, 0x48774718, 0x48774718, 0x487795a2, 0x487795a2, - 0x487795a2, 0x487795a2, 0x487795a2, 0x4877e42c, 0x4877e42c, 0x4877e42c, 0x4877e42c, 0x4877e42c, - 0x487832b6, 0x487832b6, 0x487832b6, 0x487832b6, 0x487832b6, 0x48788140, 0x48788140, 0x48788140, - 0x48788140, 0x48788140, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x48791e55, - 0x48791e55, 0x48791e55, 0x48791e55, 0x48791e55, 0x48796cdf, 0x48796cdf, 0x48796cdf, 0x48796cdf, - 0x48796cdf, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x487a09f3, 0x487a09f3, - 0x487a09f3, 0x487a09f3, 0x487a09f3, 0x487a587d, 0x487a587d, 0x487a587d, 0x487a587d, 0x487a587d, - 0x487aa708, 0x487aa708, 0x487aa708, 0x487aa708, 0x487aa708, 0x487af592, 0x487af592, 0x487af592, - 0x487af592, 0x487af592, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b92a6, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbbcecc9e, 0xbbcecc9e, 0xbbcecc9e, 0xbbcecc9e, 0xbbcecc9e, 0x3bce6405, 0x3bce6405, 0x3bce6405, - 0x3bce6405, 0x3bce6405, 0x3b572b4f, 0x3b572b4f, 0x3b572b4f, 0x3b572b4f, 0x3b572b4f, 0x398c70a1, - 0x398c70a1, 0x398c70a1, 0x398c70a1, 0x398c70a1, 0xbb340f31, 0xbb340f31, 0xbb340f31, 0xbb340f31, - 0xbb340f31, 0xbbbcd606, 0xbbbcd606, 0xbbbcd606, 0xbbbcd606, 0xbbbcd606, 0x3be05a99, 0x3be05a99, - 0x3be05a99, 0x3be05a99, 0x3be05a99, 0x3b7b189b, 0x3b7b189b, 0x3b7b189b, 0x3b7b189b, 0x3b7b189b, - 0x3a55edbb, 0x3a55edbb, 0x3a55edbb, 0x3a55edbb, 0x3a55edbb, 0xbb1021dd, 0xbb1021dd, 0xbb1021dd, - 0xbb1021dd, 0xbb1021dd, 0xbbaadf6a, 0xbbaadf6a, 0xbbaadf6a, 0xbbaadf6a, 0xbbaadf6a, 0x3bf25129, - 0x3bf25129, 0x3bf25129, 0x3bf25129, 0x3bf25129, 0x3b8f82f1, 0x3b8f82f1, 0x3b8f82f1, 0x3b8f82f1, - 0x3b8f82f1, 0x3ab2d191, 0x3ab2d191, 0x3ab2d191, 0x3ab2d191, 0x3ab2d191, 0xbad8690e, 0xbad8690e, - 0xbad8690e, 0xbad8690e, 0xbad8690e, 0xbb98e8cb, 0xbb98e8cb, 0xbb98e8cb, 0xbb98e8cb, 0xbb98e8cb, - 0xbbfbb6f7, 0xbbfbb6f7, 0xbbfbb6f7, 0xbbfbb6f7, 0xbbfbb6f7, 0x3ba17992, 0x3ba17992, 0x3ba17992, - 0x3ba17992, 0x3ba17992, 0x3afaac40, 0x3afaac40, 0x3afaac40, 0x3afaac40, 0x3afaac40, 0xba908e5c, - 0xba908e5c, 0xba908e5c, 0xba908e5c, 0xba908e5c, 0xbb86f229, 0xbb86f229, 0xbb86f229, 0xbb86f229, - 0xbb86f229, 0xbbe9c06a, 0xbbe9c06a, 0xbbe9c06a, 0xbbe9c06a, 0xbbe9c06a, 0x3bb3702f, 0x3bb3702f, - 0x3bb3702f, 0x3bb3702f, 0x3bb3702f, 0x3b214375, 0x3b214375, 0x3b214375, 0x3b214375, 0x3b214375, - 0xba116750, 0xba116750, 0xba116750, 0xba116750, 0xba116750, 0xbb69f708, 0xbb69f708, 0xbb69f708, - 0xbb69f708, 0xbb69f708, 0xbbd7c9d8, 0xbbd7c9d8, 0xbbd7c9d8, 0xbbd7c9d8, 0xbbd7c9d8, 0x3bc566c9, - 0x3bc566c9, 0x3bc566c9, 0x3bc566c9, 0x3bc566c9, 0x3b4530c8, 0x3b4530c8, 0x3b4530c8, 0x3b4530c8, - 0x3b4530c8, 0xb6d8f23a, 0xb6d8f23a, 0xb6d8f23a, 0xb6d8f23a, 0xb6d8f23a, 0xbb4609ba, 0xbb4609ba, - 0xbb4609ba, 0xbb4609ba, 0xbb4609ba, 0xbbc5d342, 0xbbc5d342, 0xbbc5d342, 0xbbc5d342, 0xbbc5d342, - 0x3bd75d60, 0x3bd75d60, 0x3bd75d60, 0x3bd75d60, 0x3bd75d60, 0x3b691e16, 0x3b691e16, 0x3b691e16, - 0x3b691e16, 0x3b691e16, 0x3a0e0387, 0x3a0e0387, 0x3a0e0387, 0x3a0e0387, 0x3a0e0387, 0xbb221c67, - 0xbb221c67, 0xbb221c67, 0xbb221c67, 0xbb221c67, 0xbbb3dca8, 0xbbb3dca8, 0xbbb3dca8, 0xbbb3dca8, - 0xbbb3dca8, 0x3be953f1, 0x3be953f1, 0x3be953f1, 0x3be953f1, 0x3be953f1, 0x3b8685b0, 0x3b8685b0, - 0x3b8685b0, 0x3b8685b0, 0x3b8685b0, 0x3a8edc78, 0x3a8edc78, 0x3a8edc78, 0x3a8edc78, 0x3a8edc78, - 0xbafc5e24, 0xbafc5e24, 0xbafc5e24, 0xbafc5e24, 0xbafc5e24, 0xbba1e60b, 0xbba1e60b, 0xbba1e60b, - 0xbba1e60b, 0xbba1e60b, 0x3bfb4a7f, 0x3bfb4a7f, 0x3bfb4a7f, 0x3bfb4a7f, 0x3bfb4a7f, 0x3b987c52, - 0x3b987c52, 0x3b987c52, 0x3b987c52, 0x3b987c52, 0x3ad6b729, 0x3ad6b729, 0x3ad6b729, 0x3ad6b729, - 0x3ad6b729, 0xbab48375, 0xbab48375, 0xbab48375, 0xbab48375, 0xbab48375, 0xbb8fef6a, 0xbb8fef6a, - 0xbb8fef6a, 0xbb8fef6a, 0xbb8fef6a, 0xbbf2bda1, 0xbbf2bda1, 0xbbf2bda1, 0xbbf2bda1, 0xbbf2bda1, - 0x3baa72f1, 0x3baa72f1, 0x3baa72f1, 0x3baa72f1, 0x3baa72f1, 0x3b0f48eb, 0x3b0f48eb, 0x3b0f48eb, - 0x3b0f48eb, 0x3b0f48eb, 0xba595184, 0xba595184, 0xba595184, 0xba595184, 0xba595184, 0xbb7bf18d, -] )) ), - -################ chunk 8192 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x487b92a6, 0x487b92a6, 0x487b92a6, 0x487b92a6, 0x487be130, 0x487be130, 0x487be130, 0x487be130, - 0x487be130, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c7e45, 0x487c7e45, - 0x487c7e45, 0x487c7e45, 0x487c7e45, 0x487ccccf, 0x487ccccf, 0x487ccccf, 0x487ccccf, 0x487ccccf, - 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d69e3, 0x487d69e3, 0x487d69e3, - 0x487d69e3, 0x487d69e3, 0x487db86e, 0x487db86e, 0x487db86e, 0x487db86e, 0x487db86e, 0x487e06f8, - 0x487e06f8, 0x487e06f8, 0x487e06f8, 0x487e06f8, 0x487e5582, 0x487e5582, 0x487e5582, 0x487e5582, - 0x487e5582, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ef296, 0x487ef296, - 0x487ef296, 0x487ef296, 0x487ef296, 0x487f4121, 0x487f4121, 0x487f4121, 0x487f4121, 0x487f4121, - 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487fde35, 0x487fde35, 0x487fde35, - 0x487fde35, 0x487fde35, 0x48801660, 0x48801660, 0x48801660, 0x48801660, 0x48801660, 0x48803da5, - 0x48803da5, 0x48803da5, 0x48803da5, 0x48803da5, 0x488064ea, 0x488064ea, 0x488064ea, 0x488064ea, - 0x488064ea, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x4880b374, 0x4880b374, - 0x4880b374, 0x4880b374, 0x4880b374, 0x4880dab9, 0x4880dab9, 0x4880dab9, 0x4880dab9, 0x4880dab9, - 0x488101fe, 0x488101fe, 0x488101fe, 0x488101fe, 0x488101fe, 0x48812943, 0x48812943, 0x48812943, - 0x48812943, 0x48812943, 0x48815088, 0x48815088, 0x48815088, 0x48815088, 0x48815088, 0x488177cd, - 0x488177cd, 0x488177cd, 0x488177cd, 0x488177cd, 0x48819f13, 0x48819f13, 0x48819f13, 0x48819f13, - 0x48819f13, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881ed9d, 0x4881ed9d, - 0x4881ed9d, 0x4881ed9d, 0x4881ed9d, 0x488214e2, 0x488214e2, 0x488214e2, 0x488214e2, 0x488214e2, - 0x48823c27, 0x48823c27, 0x48823c27, 0x48823c27, 0x48823c27, 0x4882636c, 0x4882636c, 0x4882636c, - 0x4882636c, 0x4882636c, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x4882b1f6, - 0x4882b1f6, 0x4882b1f6, 0x4882b1f6, 0x4882b1f6, 0x4882d93b, 0x4882d93b, 0x4882d93b, 0x4882d93b, - 0x4882d93b, 0x48830080, 0x48830080, 0x48830080, 0x48830080, 0x48830080, 0x488327c6, 0x488327c6, - 0x488327c6, 0x488327c6, 0x488327c6, 0x48834f0b, 0x48834f0b, 0x48834f0b, 0x48834f0b, 0x48834f0b, - 0x48837650, 0x48837650, 0x48837650, 0x48837650, 0x48837650, 0x48839d95, 0x48839d95, 0x48839d95, - 0x48839d95, 0x48839d95, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883ec1f, - 0x4883ec1f, 0x4883ec1f, 0x4883ec1f, 0x4883ec1f, 0x48841364, 0x48841364, 0x48841364, 0x48841364, - 0x48841364, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x488461ee, 0x488461ee, - 0x488461ee, 0x488461ee, 0x488461ee, 0x48848933, 0x48848933, 0x48848933, 0x48848933, 0x48848933, - 0x4884b078, 0x4884b078, 0x4884b078, 0x4884b078, 0x4884b078, 0x4884d7be, 0x4884d7be, 0x4884d7be, - 0x4884d7be, 0x4884d7be, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x48852648, - 0x48852648, 0x48852648, 0x48852648, 0x48852648, 0x48854d8d, 0x48854d8d, 0x48854d8d, 0x48854d8d, - 0x48854d8d, 0x488574d2, 0x488574d2, 0x488574d2, 0x488574d2, 0x488574d2, 0x48859c17, 0x48859c17, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbb7bf18d, 0xbb7bf18d, 0xbb7bf18d, 0xbb7bf18d, 0xbbe0c711, 0xbbe0c711, 0xbbe0c711, 0xbbe0c711, - 0xbbe0c711, 0x3bbc698d, 0x3bbc698d, 0x3bbc698d, 0x3bbc698d, 0x3bbc698d, 0x3b33363f, 0x3b33363f, - 0x3b33363f, 0x3b33363f, 0x3b33363f, 0xb9933833, 0xb9933833, 0xb9933833, 0xb9933833, 0xb9933833, - 0xbb580441, 0xbb580441, 0xbb580441, 0xbb580441, 0xbb580441, 0xbbced07d, 0xbbced07d, 0xbbced07d, - 0xbbced07d, 0xbbced07d, 0x3bce6025, 0x3bce6025, 0x3bce6025, 0x3bce6025, 0x3bce6025, 0x3b572390, - 0x3b572390, 0x3b572390, 0x3b572390, 0x3b572390, 0x398c32a5, 0x398c32a5, 0x398c32a5, 0x398c32a5, - 0x398c32a5, 0xbb3416f1, 0xbb3416f1, 0xbb3416f1, 0xbb3416f1, 0xbb3416f1, 0xbbbcd9e5, 0xbbbcd9e5, - 0xbbbcd9e5, 0xbbbcd9e5, 0xbbbcd9e5, 0x3be056b9, 0x3be056b9, 0x3be056b9, 0x3be056b9, 0x3be056b9, - 0x3b7b10dc, 0x3b7b10dc, 0x3b7b10dc, 0x3b7b10dc, 0x3b7b10dc, 0x3a55cebd, 0x3a55cebd, 0x3a55cebd, - 0x3a55cebd, 0x3a55cebd, 0x3c5bf3e6, 0x3c5bf3e6, 0x3c5bf3e6, 0x3c5bf3e6, 0x3c5bf3e6, 0x3c2a8d78, - 0x3c2a8d78, 0x3c2a8d78, 0x3c2a8d78, 0x3c2a8d78, 0x3bf24d49, 0x3bf24d49, 0x3bf24d49, 0x3bf24d49, - 0x3bf24d49, 0x3b8f7f11, 0x3b8f7f11, 0x3b8f7f11, 0x3b8f7f11, 0x3b8f7f11, 0x3ab2c212, 0x3ab2c212, - 0x3ab2c212, 0x3ab2c212, 0x3ab2c212, 0xbad8788d, 0xbad8788d, 0xbad8788d, 0xbad8788d, 0xbad8788d, - 0xbb98ecab, 0xbb98ecab, 0xbb98ecab, 0xbb98ecab, 0xbb98ecab, 0xbbfbbad7, 0xbbfbbad7, 0xbbfbbad7, - 0xbbfbbad7, 0xbbfbbad7, 0xbc2f4436, 0xbc2f4436, 0xbc2f4436, 0xbc2f4436, 0xbc2f4436, 0xbc60aa99, - 0xbc60aa99, 0xbc60aa99, 0xbc60aa99, 0xbc60aa99, 0x3c6dea20, 0x3c6dea20, 0x3c6dea20, 0x3c6dea20, - 0x3c6dea20, 0x3c3c83df, 0x3c3c83df, 0x3c3c83df, 0x3c3c83df, 0x3c3c83df, 0x3c0b1d2d, 0x3c0b1d2d, - 0x3c0b1d2d, 0x3c0b1d2d, 0x3c0b1d2d, 0x3bb36c50, 0x3bb36c50, 0x3bb36c50, 0x3bb36c50, 0x3bb36c50, - 0x3b213bb6, 0x3b213bb6, 0x3b213bb6, 0x3b213bb6, 0x3b213bb6, 0xba11864e, 0xba11864e, 0xba11864e, - 0xba11864e, 0xba11864e, 0xbb69fec7, 0xbb69fec7, 0xbb69fec7, 0xbb69fec7, 0xbb69fec7, 0xbbd7cdb8, - 0xbbd7cdb8, 0xbbd7cdb8, 0xbbd7cdb8, 0xbbd7cdb8, 0xbc1d4dc6, 0xbc1d4dc6, 0xbc1d4dc6, 0xbc1d4dc6, - 0xbc1d4dc6, 0xbc4eb452, 0xbc4eb452, 0xbc4eb452, 0xbc4eb452, 0xbc4eb452, 0x3c7fe048, 0x3c7fe048, - 0x3c7fe048, 0x3c7fe048, 0x3c7fe048, 0x3c4e7a37, 0x3c4e7a37, 0x3c4e7a37, 0x3c4e7a37, 0x3c4e7a37, - 0x3c1d13aa, 0x3c1d13aa, 0x3c1d13aa, 0x3c1d13aa, 0x3c1d13aa, 0x3bd75980, 0x3bd75980, 0x3bd75980, - 0x3bd75980, 0x3bd75980, 0x3b691656, 0x3b691656, 0x3b691656, 0x3b691656, 0x3b691656, 0x3a0de489, - 0x3a0de489, 0x3a0de489, 0x3a0de489, 0x3a0de489, 0xbb222427, 0xbb222427, 0xbb222427, 0xbb222427, - 0xbb222427, 0xbbb3e088, 0xbbb3e088, 0xbbb3e088, 0xbbb3e088, 0xbbb3e088, 0xbc0b5748, 0xbc0b5748, - 0xbc0b5748, 0xbc0b5748, 0xbc0b5748, 0xbc3cbdfa, 0xbc3cbdfa, 0xbc3cbdfa, 0xbc3cbdfa, 0xbc3cbdfa, - 0xbc6e243b, 0xbc6e243b, 0xbc6e243b, 0xbc6e243b, 0xbc6e243b, 0x3c60707e, 0x3c60707e, 0x3c60707e, - 0x3c60707e, 0x3c60707e, 0x3c2f0a1b, 0x3c2f0a1b, 0x3c2f0a1b, 0x3c2f0a1b, 0x3c2f0a1b, 0x3bfb469f, - 0x3bfb469f, 0x3bfb469f, 0x3bfb469f, 0x3bfb469f, 0x3b987872, 0x3b987872, 0x3b987872, 0x3b987872, - 0x3b987872, 0x3ad6a7aa, 0x3ad6a7aa, 0x3ad6a7aa, 0x3ad6a7aa, 0x3ad6a7aa, 0xbab492f4, 0xbab492f4, -] )) ), - -################ chunk 8704 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x48859c17, 0x48859c17, 0x48859c17, 0x4885c35c, 0x4885c35c, 0x4885c35c, 0x4885c35c, 0x4885c35c, - 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x488611e6, 0x488611e6, 0x488611e6, - 0x488611e6, 0x488611e6, 0x4886392b, 0x4886392b, 0x4886392b, 0x4886392b, 0x4886392b, 0x48866071, - 0x48866071, 0x48866071, 0x48866071, 0x48866071, 0x488687b6, 0x488687b6, 0x488687b6, 0x488687b6, - 0x488687b6, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886d640, 0x4886d640, - 0x4886d640, 0x4886d640, 0x4886d640, 0x4886fd85, 0x4886fd85, 0x4886fd85, 0x4886fd85, 0x4886fd85, - 0x488724ca, 0x488724ca, 0x488724ca, 0x488724ca, 0x488724ca, 0x48874c0f, 0x48874c0f, 0x48874c0f, - 0x48874c0f, 0x48874c0f, 0x48877354, 0x48877354, 0x48877354, 0x48877354, 0x48877354, 0x48879a99, - 0x48879a99, 0x48879a99, 0x48879a99, 0x48879a99, 0x4887c1de, 0x4887c1de, 0x4887c1de, 0x4887c1de, - 0x4887c1de, 0x4887e923, 0x4887e923, 0x4887e923, 0x4887e923, 0x4887e923, 0x48881069, 0x48881069, - 0x48881069, 0x48881069, 0x48881069, 0x488837ae, 0x488837ae, 0x488837ae, 0x488837ae, 0x488837ae, - 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48888638, 0x48888638, 0x48888638, - 0x48888638, 0x48888638, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888d4c2, - 0x4888d4c2, 0x4888d4c2, 0x4888d4c2, 0x4888d4c2, 0x4888fc07, 0x4888fc07, 0x4888fc07, 0x4888fc07, - 0x4888fc07, 0x4889234c, 0x4889234c, 0x4889234c, 0x4889234c, 0x4889234c, 0x48894a91, 0x48894a91, - 0x48894a91, 0x48894a91, 0x48894a91, 0x488971d6, 0x488971d6, 0x488971d6, 0x488971d6, 0x488971d6, - 0x4889991c, 0x4889991c, 0x4889991c, 0x4889991c, 0x4889991c, 0x4889c061, 0x4889c061, 0x4889c061, - 0x4889c061, 0x4889c061, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x488a0eeb, - 0x488a0eeb, 0x488a0eeb, 0x488a0eeb, 0x488a0eeb, 0x488a3630, 0x488a3630, 0x488a3630, 0x488a3630, - 0x488a3630, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a84ba, 0x488a84ba, - 0x488a84ba, 0x488a84ba, 0x488a84ba, 0x488aabff, 0x488aabff, 0x488aabff, 0x488aabff, 0x488aabff, - 0x488ad344, 0x488ad344, 0x488ad344, 0x488ad344, 0x488ad344, 0x488afa89, 0x488afa89, 0x488afa89, - 0x488afa89, 0x488afa89, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b4914, - 0x488b4914, 0x488b4914, 0x488b4914, 0x488b4914, 0x488b7059, 0x488b7059, 0x488b7059, 0x488b7059, - 0x488b7059, 0x488b979e, 0x488b979e, 0x488b979e, 0x488b979e, 0x488b979e, 0x488bbee3, 0x488bbee3, - 0x488bbee3, 0x488bbee3, 0x488bbee3, 0x488be628, 0x488be628, 0x488be628, 0x488be628, 0x488be628, - 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c34b2, 0x488c34b2, 0x488c34b2, - 0x488c34b2, 0x488c34b2, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c833c, - 0x488c833c, 0x488c833c, 0x488c833c, 0x488c833c, 0x488caa81, 0x488caa81, 0x488caa81, 0x488caa81, - 0x488caa81, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cf90c, 0x488cf90c, - 0x488cf90c, 0x488cf90c, 0x488cf90c, 0x488d2051, 0x488d2051, 0x488d2051, 0x488d2051, 0x488d2051, - 0x488d4796, 0x488d4796, 0x488d4796, 0x488d4796, 0x488d4796, 0x488d6edb, 0x488d6edb, 0x488d6edb, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbab492f4, 0xbab492f4, 0xbab492f4, 0xbb8ff34a, 0xbb8ff34a, 0xbb8ff34a, 0xbb8ff34a, 0xbb8ff34a, - 0xbbf2c181, 0xbbf2c181, 0xbbf2c181, 0xbbf2c181, 0xbbf2c181, 0xbc2ac793, 0xbc2ac793, 0xbc2ac793, - 0xbc2ac793, 0xbc2ac793, 0xbc5c2e01, 0xbc5c2e01, 0xbc5c2e01, 0xbc5c2e01, 0xbc5c2e01, 0x3c7266b4, - 0x3c7266b4, 0x3c7266b4, 0x3c7266b4, 0x3c7266b4, 0x3c41007e, 0x3c41007e, 0x3c41007e, 0x3c41007e, - 0x3c41007e, 0x3c0f99d5, 0x3c0f99d5, 0x3c0f99d5, 0x3c0f99d5, 0x3c0f99d5, 0x3bbc65ad, 0x3bbc65ad, - 0x3bbc65ad, 0x3bbc65ad, 0x3bbc65ad, 0x3b332e80, 0x3b332e80, 0x3b332e80, 0x3b332e80, 0x3b332e80, - 0xb993762f, 0xb993762f, 0xb993762f, 0xb993762f, 0xb993762f, 0xbb580c00, 0xbb580c00, 0xbb580c00, - 0xbb580c00, 0xbb580c00, 0xbbced45d, 0xbbced45d, 0xbbced45d, 0xbbced45d, 0xbbced45d, 0xbc18d11f, - 0xbc18d11f, 0xbc18d11f, 0xbc18d11f, 0xbc18d11f, 0xbc4a37b5, 0xbc4a37b5, 0xbc4a37b5, 0xbc4a37b5, - 0xbc4a37b5, 0xbc7b9dd2, 0xbc7b9dd2, 0xbc7b9dd2, 0xbc7b9dd2, 0xbc7b9dd2, 0x3c52f6d2, 0x3c52f6d2, - 0x3c52f6d2, 0x3c52f6d2, 0x3c52f6d2, 0x3c219050, 0x3c219050, 0x3c219050, 0x3c219050, 0x3c219050, - 0x3be052d9, 0x3be052d9, 0x3be052d9, 0x3be052d9, 0x3be052d9, 0x3b7b091c, 0x3b7b091c, 0x3b7b091c, - 0x3b7b091c, 0x3b7b091c, 0x3a55afbf, 0x3a55afbf, 0x3a55afbf, 0x3a55afbf, 0x3a55afbf, 0xbb10315c, - 0xbb10315c, 0xbb10315c, 0xbb10315c, 0xbb10315c, 0xbbaae729, 0xbbaae729, 0xbbaae729, 0xbbaae729, - 0xbbaae729, 0xbc06da9f, 0xbc06da9f, 0xbc06da9f, 0xbc06da9f, 0xbc06da9f, 0xbc38415a, 0xbc38415a, - 0xbc38415a, 0xbc38415a, 0xbc38415a, 0xbc69a7a6, 0xbc69a7a6, 0xbc69a7a6, 0xbc69a7a6, 0xbc69a7a6, - 0x3c64ed16, 0x3c64ed16, 0x3c64ed16, 0x3c64ed16, 0x3c64ed16, 0x3c3386bd, 0x3c3386bd, 0x3c3386bd, - 0x3c3386bd, 0x3c3386bd, 0x3c021ffa, 0x3c021ffa, 0x3c021ffa, 0x3c021ffa, 0x3c021ffa, 0x3ba171d2, - 0x3ba171d2, 0x3ba171d2, 0x3ba171d2, 0x3ba171d2, 0x3afa8d42, 0x3afa8d42, 0x3afa8d42, 0x3afa8d42, - 0x3afa8d42, 0xba90ad5a, 0xba90ad5a, 0xba90ad5a, 0xba90ad5a, 0xba90ad5a, 0xbb86f9e8, 0xbb86f9e8, - 0xbb86f9e8, 0xbb86f9e8, 0xbb86f9e8, 0xbbe9c829, 0xbbe9c829, 0xbbe9c829, 0xbbe9c829, 0xbbe9c829, - 0xbc264af0, 0xbc264af0, 0xbc264af0, 0xbc264af0, 0xbc264af0, 0xbc57b167, 0xbc57b167, 0xbc57b167, - 0xbc57b167, 0xbc57b167, 0x3c76e347, 0x3c76e347, 0x3c76e347, 0x3c76e347, 0x3c76e347, 0x3c457d1d, - 0x3c457d1d, 0x3c457d1d, 0x3c457d1d, 0x3c457d1d, 0x3c14167d, 0x3c14167d, 0x3c14167d, 0x3c14167d, - 0x3c14167d, 0x3bc55f0a, 0x3bc55f0a, 0x3bc55f0a, 0x3bc55f0a, 0x3bc55f0a, 0x3b452149, 0x3b452149, - 0x3b452149, 0x3b452149, 0x3b452149, 0xb6f7f042, 0xb6f7f042, 0xb6f7f042, 0xb6f7f042, 0xb6f7f042, - 0xbb461939, 0xbb461939, 0xbb461939, 0xbb461939, 0xbb461939, 0xbbc5db01, 0xbbc5db01, 0xbbc5db01, - 0xbbc5db01, 0xbbc5db01, 0xbc145478, 0xbc145478, 0xbc145478, 0xbc145478, 0xbc145478, 0xbc45bb18, - 0xbc45bb18, 0xbc45bb18, 0xbc45bb18, 0xbc45bb18, 0xbc772141, 0xbc772141, 0xbc772141, 0xbc772141, - 0xbc772141, 0x3c57736d, 0x3c57736d, 0x3c57736d, 0x3c57736d, 0x3c57736d, 0x3c260cf4, 0x3c260cf4, - 0x3c260cf4, 0x3c260cf4, 0x3c260cf4, 0x3be94c32, 0x3be94c32, 0x3be94c32, 0x3be94c32, 0x3be94c32, - 0x3b867df0, 0x3b867df0, 0x3b867df0, 0x3b867df0, 0x3b867df0, 0x3a8ebd7a, 0x3a8ebd7a, 0x3a8ebd7a, -] )) ), - -################ chunk 9216 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x488d6edb, 0x488d6edb, 0x488d9620, 0x488d9620, 0x488d9620, 0x488d9620, 0x488d9620, 0x488dbd65, - 0x488dbd65, 0x488dbd65, 0x488dbd65, 0x488dbd65, 0x488de4aa, 0x488de4aa, 0x488de4aa, 0x488de4aa, - 0x488de4aa, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e3334, 0x488e3334, - 0x488e3334, 0x488e3334, 0x488e3334, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, - 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488ea904, 0x488ea904, 0x488ea904, - 0x488ea904, 0x488ea904, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ef78e, - 0x488ef78e, 0x488ef78e, 0x488ef78e, 0x488ef78e, 0x488f1ed3, 0x488f1ed3, 0x488f1ed3, 0x488f1ed3, - 0x488f1ed3, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f6d5d, 0x488f6d5d, - 0x488f6d5d, 0x488f6d5d, 0x488f6d5d, 0x488f94a2, 0x488f94a2, 0x488f94a2, 0x488f94a2, 0x488f94a2, - 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fe32d, 0x488fe32d, 0x488fe32d, - 0x488fe32d, 0x488fe32d, 0x48900a72, 0x48900a72, 0x48900a72, 0x48900a72, 0x48900a72, 0x489031b7, - 0x489031b7, 0x489031b7, 0x489031b7, 0x489031b7, 0x489058fc, 0x489058fc, 0x489058fc, 0x489058fc, - 0x489058fc, 0x48908041, 0x48908041, 0x48908041, 0x48908041, 0x48908041, 0x4890a786, 0x4890a786, - 0x4890a786, 0x4890a786, 0x4890a786, 0x4890cecb, 0x4890cecb, 0x4890cecb, 0x4890cecb, 0x4890cecb, - 0x4890f610, 0x4890f610, 0x4890f610, 0x4890f610, 0x4890f610, 0x48911d55, 0x48911d55, 0x48911d55, - 0x48911d55, 0x48911d55, 0x4891449a, 0x4891449a, 0x4891449a, 0x4891449a, 0x4891449a, 0x48916bdf, - 0x48916bdf, 0x48916bdf, 0x48916bdf, 0x48916bdf, 0x48919325, 0x48919325, 0x48919325, 0x48919325, - 0x48919325, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891e1af, 0x4891e1af, - 0x4891e1af, 0x4891e1af, 0x4891e1af, 0x489208f4, 0x489208f4, 0x489208f4, 0x489208f4, 0x489208f4, - 0x48923039, 0x48923039, 0x48923039, 0x48923039, 0x48923039, 0x4892577e, 0x4892577e, 0x4892577e, - 0x4892577e, 0x4892577e, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x4892a608, - 0x4892a608, 0x4892a608, 0x4892a608, 0x4892a608, 0x4892cd4d, 0x4892cd4d, 0x4892cd4d, 0x4892cd4d, - 0x4892cd4d, 0x4892f492, 0x4892f492, 0x4892f492, 0x4892f492, 0x4892f492, 0x48931bd8, 0x48931bd8, - 0x48931bd8, 0x48931bd8, 0x48931bd8, 0x4893431d, 0x4893431d, 0x4893431d, 0x4893431d, 0x4893431d, - 0x48936a62, 0x48936a62, 0x48936a62, 0x48936a62, 0x48936a62, 0x489391a7, 0x489391a7, 0x489391a7, - 0x489391a7, 0x489391a7, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893e031, - 0x4893e031, 0x4893e031, 0x4893e031, 0x4893e031, 0x48940776, 0x48940776, 0x48940776, 0x48940776, - 0x48940776, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48945600, 0x48945600, - 0x48945600, 0x48945600, 0x48945600, 0x48947d45, 0x48947d45, 0x48947d45, 0x48947d45, 0x48947d45, - 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894cbd0, 0x4894cbd0, 0x4894cbd0, - 0x4894cbd0, 0x4894cbd0, 0x4894f315, 0x4894f315, 0x4894f315, 0x4894f315, 0x4894f315, 0x48951a5a, - 0x48951a5a, 0x48951a5a, 0x48951a5a, 0x48951a5a, 0x4895419f, 0x4895419f, 0x4895419f, 0x4895419f, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3a8ebd7a, 0x3a8ebd7a, 0xbafc7d22, 0xbafc7d22, 0xbafc7d22, 0xbafc7d22, 0xbafc7d22, 0xbba1edca, - 0xbba1edca, 0xbba1edca, 0xbba1edca, 0xbba1edca, 0xbc025df6, 0xbc025df6, 0xbc025df6, 0xbc025df6, - 0xbc025df6, 0xbc33c4b8, 0xbc33c4b8, 0xbc33c4b8, 0xbc33c4b8, 0xbc33c4b8, 0xbc652b10, 0xbc652b10, - 0xbc652b10, 0xbc652b10, 0xbc652b10, 0x3c6969ac, 0x3c6969ac, 0x3c6969ac, 0x3c6969ac, 0x3c6969ac, - 0x3c38035f, 0x3c38035f, 0x3c38035f, 0x3c38035f, 0x3c38035f, 0x3c069ca4, 0x3c069ca4, 0x3c069ca4, - 0x3c069ca4, 0x3c069ca4, 0x3baa6b32, 0x3baa6b32, 0x3baa6b32, 0x3baa6b32, 0x3baa6b32, 0x3b0f396c, - 0x3b0f396c, 0x3b0f396c, 0x3b0f396c, 0x3b0f396c, 0xba598f80, 0xba598f80, 0xba598f80, 0xba598f80, - 0xba598f80, 0xbb7c010c, 0xbb7c010c, 0xbb7c010c, 0xbb7c010c, 0xbb7c010c, 0xbbe0ced1, 0xbbe0ced1, - 0xbbe0ced1, 0xbbe0ced1, 0xbbe0ced1, 0xbc21ce4b, 0xbc21ce4b, 0xbc21ce4b, 0xbc21ce4b, 0xbc21ce4b, - 0xbc5334cd, 0xbc5334cd, 0xbc5334cd, 0xbc5334cd, 0xbc5334cd, 0x3c7b5fd8, 0x3c7b5fd8, 0x3c7b5fd8, - 0x3c7b5fd8, 0x3c7b5fd8, 0x3c49f9ba, 0x3c49f9ba, 0x3c49f9ba, 0x3c49f9ba, 0x3c49f9ba, 0x3c189324, - 0x3c189324, 0x3c189324, 0x3c189324, 0x3c189324, 0x3bce5866, 0x3bce5866, 0x3bce5866, 0x3bce5866, - 0x3bce5866, 0x3b571411, 0x3b571411, 0x3b571411, 0x3b571411, 0x3b571411, 0x398bb6ad, 0x398bb6ad, - 0x398bb6ad, 0x398bb6ad, 0x398bb6ad, 0xbb342670, 0xbb342670, 0xbb342670, 0xbb342670, 0xbb342670, - 0xbbbce1a5, 0xbbbce1a5, 0xbbbce1a5, 0xbbbce1a5, 0xbbbce1a5, 0xbc0fd7d1, 0xbc0fd7d1, 0xbc0fd7d1, - 0xbc0fd7d1, 0xbc0fd7d1, 0xbc413e79, 0xbc413e79, 0xbc413e79, 0xbc413e79, 0xbc413e79, 0xbc72a4af, - 0xbc72a4af, 0xbc72a4af, 0xbc72a4af, 0xbc72a4af, 0x3c5bf006, 0x3c5bf006, 0x3c5bf006, 0x3c5bf006, - 0x3c5bf006, 0x3c2a8998, 0x3c2a8998, 0x3c2a8998, 0x3c2a8998, 0x3c2a8998, 0x3bf24589, 0x3bf24589, - 0x3bf24589, 0x3bf24589, 0x3bf24589, 0x3b8f7752, 0x3b8f7752, 0x3b8f7752, 0x3b8f7752, 0x3b8f7752, - 0x3ab2a314, 0x3ab2a314, 0x3ab2a314, 0x3ab2a314, 0x3ab2a314, 0xbad8978b, 0xbad8978b, 0xbad8978b, - 0xbad8978b, 0xbad8978b, 0xbb98f46a, 0xbb98f46a, 0xbb98f46a, 0xbb98f46a, 0xbb98f46a, 0xbbfbc296, - 0xbbfbc296, 0xbbfbc296, 0xbbfbc296, 0xbbfbc296, 0xbc2f4816, 0xbc2f4816, 0xbc2f4816, 0xbc2f4816, - 0xbc2f4816, 0xbc60ae79, 0xbc60ae79, 0xbc60ae79, 0xbc60ae79, 0xbc60ae79, 0x3c6de641, 0x3c6de641, - 0x3c6de641, 0x3c6de641, 0x3c6de641, 0x3c3c7fff, 0x3c3c7fff, 0x3c3c7fff, 0x3c3c7fff, 0x3c3c7fff, - 0x3c0b194d, 0x3c0b194d, 0x3c0b194d, 0x3c0b194d, 0x3c0b194d, 0x3bb36490, 0x3bb36490, 0x3bb36490, - 0x3bb36490, 0x3bb36490, 0x3b212c37, 0x3b212c37, 0x3b212c37, 0x3b212c37, 0x3b212c37, 0xba11c44a, - 0xba11c44a, 0xba11c44a, 0xba11c44a, 0xba11c44a, 0xbb6a0e46, 0xbb6a0e46, 0xbb6a0e46, 0xbb6a0e46, - 0xbb6a0e46, 0xbbd7d577, 0xbbd7d577, 0xbbd7d577, 0xbbd7d577, 0xbbd7d577, 0xbc1d51a5, 0xbc1d51a5, - 0xbc1d51a5, 0xbc1d51a5, 0xbc1d51a5, 0xbc4eb831, 0xbc4eb831, 0xbc4eb831, 0xbc4eb831, 0xbc4eb831, - 0x3c7fdc68, 0x3c7fdc68, 0x3c7fdc68, 0x3c7fdc68, 0x3c7fdc68, 0x3c4e7657, 0x3c4e7657, 0x3c4e7657, - 0x3c4e7657, 0x3c4e7657, 0x3c1d0fca, 0x3c1d0fca, 0x3c1d0fca, 0x3c1d0fca, 0x3c1d0fca, 0x3bd751c0, - 0x3bd751c0, 0x3bd751c0, 0x3bd751c0, 0x3bd751c0, 0x3b6906d7, 0x3b6906d7, 0x3b6906d7, 0x3b6906d7, -] )) ), - -################ chunk 9728 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4895419f, 0x489568e4, 0x489568e4, 0x489568e4, 0x489568e4, 0x489568e4, 0x48959029, 0x48959029, - 0x48959029, 0x48959029, 0x48959029, 0x4895b76e, 0x4895b76e, 0x4895b76e, 0x4895b76e, 0x4895b76e, - 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x489605f8, 0x489605f8, 0x489605f8, - 0x489605f8, 0x489605f8, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48965483, - 0x48965483, 0x48965483, 0x48965483, 0x48965483, 0x48967bc8, 0x48967bc8, 0x48967bc8, 0x48967bc8, - 0x48967bc8, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896ca52, 0x4896ca52, - 0x4896ca52, 0x4896ca52, 0x4896ca52, 0x4896f197, 0x4896f197, 0x4896f197, 0x4896f197, 0x4896f197, - 0x489718dc, 0x489718dc, 0x489718dc, 0x489718dc, 0x489718dc, 0x48974021, 0x48974021, 0x48974021, - 0x48974021, 0x48974021, 0x48976766, 0x48976766, 0x48976766, 0x48976766, 0x48976766, 0x48978eab, - 0x48978eab, 0x48978eab, 0x48978eab, 0x48978eab, 0x4897b5f0, 0x4897b5f0, 0x4897b5f0, 0x4897b5f0, - 0x4897b5f0, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4898047b, 0x4898047b, - 0x4898047b, 0x4898047b, 0x4898047b, 0x48982bc0, 0x48982bc0, 0x48982bc0, 0x48982bc0, 0x48982bc0, - 0x48985305, 0x48985305, 0x48985305, 0x48985305, 0x48985305, 0x48987a4a, 0x48987a4a, 0x48987a4a, - 0x48987a4a, 0x48987a4a, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898c8d4, - 0x4898c8d4, 0x4898c8d4, 0x4898c8d4, 0x4898c8d4, 0x4898f019, 0x4898f019, 0x4898f019, 0x4898f019, - 0x4898f019, 0x4899175e, 0x4899175e, 0x4899175e, 0x4899175e, 0x4899175e, 0x48993ea3, 0x48993ea3, - 0x48993ea3, 0x48993ea3, 0x48993ea3, 0x489965e8, 0x489965e8, 0x489965e8, 0x489965e8, 0x489965e8, - 0x431d1463, 0x431d1463, 0x431d1463, 0x431d1463, 0x431d1463, 0x43ba23ad, 0x43ba23ad, 0x43ba23ad, - 0x43ba23ad, 0x43ba23ad, 0x4412de95, 0x4412de95, 0x4412de95, 0x4412de95, 0x4412de95, 0x4448ab53, - 0x4448ab53, 0x4448ab53, 0x4448ab53, 0x4448ab53, 0x447e7811, 0x447e7811, 0x447e7811, 0x447e7811, - 0x447e7811, 0x449a2267, 0x449a2267, 0x449a2267, 0x449a2267, 0x449a2267, 0x44b508c6, 0x44b508c6, - 0x44b508c6, 0x44b508c6, 0x44b508c6, 0x44cfef25, 0x44cfef25, 0x44cfef25, 0x44cfef25, 0x44cfef25, - 0x44ead584, 0x44ead584, 0x44ead584, 0x44ead584, 0x44ead584, 0x4502ddf2, 0x4502ddf2, 0x4502ddf2, - 0x4502ddf2, 0x4502ddf2, 0x45105121, 0x45105121, 0x45105121, 0x45105121, 0x45105121, 0x451dc451, - 0x451dc451, 0x451dc451, 0x451dc451, 0x451dc451, 0x452b3780, 0x452b3780, 0x452b3780, 0x452b3780, - 0x452b3780, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x45461ddf, 0x45461ddf, - 0x45461ddf, 0x45461ddf, 0x45461ddf, 0x4553910f, 0x4553910f, 0x4553910f, 0x4553910f, 0x4553910f, - 0x4561043e, 0x4561043e, 0x4561043e, 0x4561043e, 0x4561043e, 0x456e776e, 0x456e776e, 0x456e776e, - 0x456e776e, 0x456e776e, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x4584aee6, - 0x4584aee6, 0x4584aee6, 0x4584aee6, 0x4584aee6, 0x458b687e, 0x458b687e, 0x458b687e, 0x458b687e, - 0x458b687e, 0x45922216, 0x45922216, 0x45922216, 0x45922216, 0x45922216, 0x4598dbae, 0x4598dbae, - 0x4598dbae, 0x4598dbae, 0x4598dbae, 0x459f9545, 0x459f9545, 0x459f9545, 0x459f9545, 0x459f9545, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3b6906d7, 0x3a0da68d, 0x3a0da68d, 0x3a0da68d, 0x3a0da68d, 0x3a0da68d, 0xbb2233a6, 0xbb2233a6, - 0xbb2233a6, 0xbb2233a6, 0xbb2233a6, 0xbbb3e847, 0xbbb3e847, 0xbbb3e847, 0xbbb3e847, 0xbbb3e847, - 0xbc0b5b28, 0xbc0b5b28, 0xbc0b5b28, 0xbc0b5b28, 0xbc0b5b28, 0xbc3cc1da, 0xbc3cc1da, 0xbc3cc1da, - 0xbc3cc1da, 0xbc3cc1da, 0xbc6e281b, 0xbc6e281b, 0xbc6e281b, 0xbc6e281b, 0xbc6e281b, 0x3c606c9f, - 0x3c606c9f, 0x3c606c9f, 0x3c606c9f, 0x3c606c9f, 0x3c2f063b, 0x3c2f063b, 0x3c2f063b, 0x3c2f063b, - 0x3c2f063b, 0x3bfb3ee0, 0x3bfb3ee0, 0x3bfb3ee0, 0x3bfb3ee0, 0x3bfb3ee0, 0x3b9870b3, 0x3b9870b3, - 0x3b9870b3, 0x3b9870b3, 0x3b9870b3, 0x3ad688ac, 0x3ad688ac, 0x3ad688ac, 0x3ad688ac, 0x3ad688ac, - 0xbab4b1f2, 0xbab4b1f2, 0xbab4b1f2, 0xbab4b1f2, 0xbab4b1f2, 0xbb8ffb09, 0xbb8ffb09, 0xbb8ffb09, - 0xbb8ffb09, 0xbb8ffb09, 0xbbf2c940, 0xbbf2c940, 0xbbf2c940, 0xbbf2c940, 0xbbf2c940, 0xbc2acb73, - 0xbc2acb73, 0xbc2acb73, 0xbc2acb73, 0xbc2acb73, 0xbc5c31e0, 0xbc5c31e0, 0xbc5c31e0, 0xbc5c31e0, - 0xbc5c31e0, 0x3c7262d5, 0x3c7262d5, 0x3c7262d5, 0x3c7262d5, 0x3c7262d5, 0x3c40fc9e, 0x3c40fc9e, - 0x3c40fc9e, 0x3c40fc9e, 0x3c40fc9e, 0x3c0f95f5, 0x3c0f95f5, 0x3c0f95f5, 0x3c0f95f5, 0x3c0f95f5, - 0x3bbc5dee, 0x3bbc5dee, 0x3bbc5dee, 0x3bbc5dee, 0x3bbc5dee, 0x3b331f01, 0x3b331f01, 0x3b331f01, - 0x3b331f01, 0x3b331f01, 0xb993f227, 0xb993f227, 0xb993f227, 0xb993f227, 0xb993f227, 0xbb581b7f, - 0xbb581b7f, 0xbb581b7f, 0xbb581b7f, 0xbb581b7f, 0xbbcedc1d, 0xbbcedc1d, 0xbbcedc1d, 0xbbcedc1d, - 0xbbcedc1d, 0xbc18d4ff, 0xbc18d4ff, 0xbc18d4ff, 0xbc18d4ff, 0xbc18d4ff, 0xbc4a3b95, 0xbc4a3b95, - 0xbc4a3b95, 0xbc4a3b95, 0xbc4a3b95, 0xbc7ba1b2, 0xbc7ba1b2, 0xbc7ba1b2, 0xbc7ba1b2, 0xbc7ba1b2, - 0x36455799, 0x36455799, 0x36455799, 0x36455799, 0x36455799, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0xb7972331, 0xb7972331, 0xb7972331, 0xb7972331, 0xb7972331, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x37959b6f, 0x37959b6f, 0x37959b6f, 0x37959b6f, - 0x37959b6f, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3835f62a, 0x3835f62a, - 0x3835f62a, 0x3835f62a, 0x3835f62a, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, - 0xb836ba0b, 0xb836ba0b, 0xb836ba0b, 0xb836ba0b, 0xb836ba0b, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x38377dec, 0x38377dec, 0x38377dec, 0x38377dec, 0x38377dec, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb83841cd, 0xb83841cd, 0xb83841cd, 0xb83841cd, - 0xb83841cd, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x383905ae, 0x383905ae, - 0x383905ae, 0x383905ae, 0x383905ae, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, - 0xb839c98f, 0xb839c98f, 0xb839c98f, 0xb839c98f, 0xb839c98f, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x383a8d70, 0x383a8d70, 0x383a8d70, 0x383a8d70, 0x383a8d70, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb83b5151, 0xb83b5151, 0xb83b5151, 0xb83b5151, - 0xb83b5151, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb950fab3, 0xb950fab3, - 0xb950fab3, 0xb950fab3, 0xb950fab3, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, -] )) ), - -################ chunk 10240 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45ad0875, 0x45ad0875, 0x45ad0875, - 0x45ad0875, 0x45ad0875, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45ba7ba4, - 0x45ba7ba4, 0x45ba7ba4, 0x45ba7ba4, 0x45ba7ba4, 0x45c1353c, 0x45c1353c, 0x45c1353c, 0x45c1353c, - 0x45c1353c, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45cea86c, 0x45cea86c, - 0x45cea86c, 0x45cea86c, 0x45cea86c, 0x45d56203, 0x45d56203, 0x45d56203, 0x45d56203, 0x45d56203, - 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45e2d533, 0x45e2d533, 0x45e2d533, - 0x45e2d533, 0x45e2d533, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45f04862, - 0x45f04862, 0x45f04862, 0x45f04862, 0x45f04862, 0x45f701fa, 0x45f701fa, 0x45f701fa, 0x45f701fa, - 0x45f701fa, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x46023a95, 0x46023a95, - 0x46023a95, 0x46023a95, 0x46023a95, 0x46059761, 0x46059761, 0x46059761, 0x46059761, 0x46059761, - 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x460c50f8, 0x460c50f8, 0x460c50f8, - 0x460c50f8, 0x460c50f8, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x46130a90, - 0x46130a90, 0x46130a90, 0x46130a90, 0x46130a90, 0x4616675c, 0x4616675c, 0x4616675c, 0x4616675c, - 0x4616675c, 0x4619c428, 0x4619c428, 0x4619c428, 0x4619c428, 0x4619c428, 0x461d20f4, 0x461d20f4, - 0x461d20f4, 0x461d20f4, 0x461d20f4, 0x46207dc0, 0x46207dc0, 0x46207dc0, 0x46207dc0, 0x46207dc0, - 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x46273757, 0x46273757, 0x46273757, - 0x46273757, 0x46273757, 0x462a9423, 0x462a9423, 0x462a9423, 0x462a9423, 0x462a9423, 0x462df0ef, - 0x462df0ef, 0x462df0ef, 0x462df0ef, 0x462df0ef, 0x46314dbb, 0x46314dbb, 0x46314dbb, 0x46314dbb, - 0x46314dbb, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x46380753, 0x46380753, - 0x46380753, 0x46380753, 0x46380753, 0x463b641f, 0x463b641f, 0x463b641f, 0x463b641f, 0x463b641f, - 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x46421db6, 0x46421db6, 0x46421db6, - 0x46421db6, 0x46421db6, 0x46457a82, 0x46457a82, 0x46457a82, 0x46457a82, 0x46457a82, 0x4648d74e, - 0x4648d74e, 0x4648d74e, 0x4648d74e, 0x4648d74e, 0x464c341a, 0x464c341a, 0x464c341a, 0x464c341a, - 0x464c341a, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x4652edb2, 0x4652edb2, - 0x4652edb2, 0x4652edb2, 0x4652edb2, 0x46564a7e, 0x46564a7e, 0x46564a7e, 0x46564a7e, 0x46564a7e, - 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x465d0415, 0x465d0415, 0x465d0415, - 0x465d0415, 0x465d0415, 0x466060e1, 0x466060e1, 0x466060e1, 0x466060e1, 0x466060e1, 0x4663bdad, - 0x4663bdad, 0x4663bdad, 0x4663bdad, 0x4663bdad, 0x46671a79, 0x46671a79, 0x46671a79, 0x46671a79, - 0x46671a79, 0x466a7745, 0x466a7745, 0x466a7745, 0x466a7745, 0x466a7745, 0x466dd411, 0x466dd411, - 0x466dd411, 0x466dd411, 0x466dd411, 0x467130dd, 0x467130dd, 0x467130dd, 0x467130dd, 0x467130dd, - 0x46748da9, 0x46748da9, 0x46748da9, 0x46748da9, 0x46748da9, 0x4677ea74, 0x4677ea74, 0x4677ea74, - 0x4677ea74, 0x4677ea74, 0x467b4740, 0x467b4740, 0x467b4740, 0x467b4740, 0x467b4740, 0x467ea40c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xb83cd913, 0xb83cd913, 0xb83cd913, 0xb83cd913, 0xb83cd913, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0xb95098c3, 0xb95098c3, 0xb95098c3, 0xb95098c3, 0xb95098c3, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb83e60d5, 0xb83e60d5, 0xb83e60d5, 0xb83e60d5, - 0xb83e60d5, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb95036d2, 0xb95036d2, - 0xb95036d2, 0xb95036d2, 0xb95036d2, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, - 0xb83fe897, 0xb83fe897, 0xb83fe897, 0xb83fe897, 0xb83fe897, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0xb94fd4e2, 0xb94fd4e2, 0xb94fd4e2, 0xb94fd4e2, 0xb94fd4e2, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb841705a, 0xb841705a, 0xb841705a, 0xb841705a, - 0xb841705a, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94f72f1, 0xb94f72f1, - 0xb94f72f1, 0xb94f72f1, 0xb94f72f1, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e7a0fc, 0x39e7a0fc, 0x39e7a0fc, 0x39e7a0fc, 0x39e7a0fc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3998777f, 0x3998777f, 0x3998777f, 0x3998777f, 0x3998777f, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8447fde, 0xb8447fde, 0xb8447fde, 0xb8447fde, - 0xb8447fde, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94eaf10, 0xb94eaf10, - 0xb94eaf10, 0xb94eaf10, 0xb94eaf10, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e73f0c, 0x39e73f0c, 0x39e73f0c, 0x39e73f0c, 0x39e73f0c, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3998d970, 0x3998d970, 0x3998d970, 0x3998d970, 0x3998d970, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8478f62, 0xb8478f62, 0xb8478f62, 0xb8478f62, - 0xb8478f62, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94deb2f, 0xb94deb2f, - 0xb94deb2f, 0xb94deb2f, 0xb94deb2f, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e6dd1b, 0x39e6dd1b, 0x39e6dd1b, 0x39e6dd1b, 0x39e6dd1b, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x39993b61, 0x39993b61, 0x39993b61, 0x39993b61, 0x39993b61, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb84a9ee6, 0xb84a9ee6, 0xb84a9ee6, 0xb84a9ee6, - 0xb84a9ee6, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94d274e, 0xb94d274e, - 0xb94d274e, 0xb94d274e, 0xb94d274e, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e67b2a, 0x39e67b2a, 0x39e67b2a, 0x39e67b2a, 0x39e67b2a, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x39999d51, 0x39999d51, 0x39999d51, 0x39999d51, 0x39999d51, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb84dae6b, 0xb84dae6b, 0xb84dae6b, 0xb84dae6b, - 0xb84dae6b, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94c636d, 0xb94c636d, - 0xb94c636d, 0xb94c636d, 0xb94c636d, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e6193a, 0x39e6193a, 0x39e6193a, 0x39e6193a, 0x39e6193a, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3999ff42, 0x3999ff42, 0x3999ff42, 0x3999ff42, 0x3999ff42, 0xbf800000, -] )) ), - -################ chunk 10752 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x467ea40c, 0x467ea40c, 0x467ea40c, 0x467ea40c, 0x4681006c, 0x4681006c, 0x4681006c, 0x4681006c, - 0x4681006c, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x46845d38, 0x46845d38, - 0x46845d38, 0x46845d38, 0x46845d38, 0x46860b9e, 0x46860b9e, 0x46860b9e, 0x46860b9e, 0x46860b9e, - 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4689686a, 0x4689686a, 0x4689686a, - 0x4689686a, 0x4689686a, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468cc536, - 0x468cc536, 0x468cc536, 0x468cc536, 0x468cc536, 0x468e739c, 0x468e739c, 0x468e739c, 0x468e739c, - 0x468e739c, 0x46902201, 0x46902201, 0x46902201, 0x46902201, 0x46902201, 0x4691d067, 0x4691d067, - 0x4691d067, 0x4691d067, 0x4691d067, 0x46937ecd, 0x46937ecd, 0x46937ecd, 0x46937ecd, 0x46937ecd, - 0x46952d33, 0x46952d33, 0x46952d33, 0x46952d33, 0x46952d33, 0x4696db99, 0x4696db99, 0x4696db99, - 0x4696db99, 0x4696db99, 0x469889ff, 0x469889ff, 0x469889ff, 0x469889ff, 0x469889ff, 0x469a3865, - 0x469a3865, 0x469a3865, 0x469a3865, 0x469a3865, 0x469be6cb, 0x469be6cb, 0x469be6cb, 0x469be6cb, - 0x469be6cb, 0x469d9531, 0x469d9531, 0x469d9531, 0x469d9531, 0x469d9531, 0x469f4397, 0x469f4397, - 0x469f4397, 0x469f4397, 0x469f4397, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, - 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a44ec9, 0x46a44ec9, 0x46a44ec9, - 0x46a44ec9, 0x46a44ec9, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a7ab95, - 0x46a7ab95, 0x46a7ab95, 0x46a7ab95, 0x46a7ab95, 0x46a959fb, 0x46a959fb, 0x46a959fb, 0x46a959fb, - 0x46a959fb, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46acb6c6, 0x46acb6c6, - 0x46acb6c6, 0x46acb6c6, 0x46acb6c6, 0x46ae652c, 0x46ae652c, 0x46ae652c, 0x46ae652c, 0x46ae652c, - 0x46b01392, 0x46b01392, 0x46b01392, 0x46b01392, 0x46b01392, 0x46b1c1f8, 0x46b1c1f8, 0x46b1c1f8, - 0x46b1c1f8, 0x46b1c1f8, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b51ec4, - 0x46b51ec4, 0x46b51ec4, 0x46b51ec4, 0x46b51ec4, 0x46b6cd2a, 0x46b6cd2a, 0x46b6cd2a, 0x46b6cd2a, - 0x46b6cd2a, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46ba29f6, 0x46ba29f6, - 0x46ba29f6, 0x46ba29f6, 0x46ba29f6, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, - 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bf3528, 0x46bf3528, 0x46bf3528, - 0x46bf3528, 0x46bf3528, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c291f4, - 0x46c291f4, 0x46c291f4, 0x46c291f4, 0x46c291f4, 0x46c4405a, 0x46c4405a, 0x46c4405a, 0x46c4405a, - 0x46c4405a, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c79d25, 0x46c79d25, - 0x46c79d25, 0x46c79d25, 0x46c79d25, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, - 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46cca857, 0x46cca857, 0x46cca857, - 0x46cca857, 0x46cca857, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46d00523, - 0x46d00523, 0x46d00523, 0x46d00523, 0x46d00523, 0x46d1b389, 0x46d1b389, 0x46d1b389, 0x46d1b389, - 0x46d1b389, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d51055, 0x46d51055, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb850bdef, 0xb850bdef, 0xb850bdef, 0xb850bdef, - 0xb850bdef, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94b9f8c, 0xb94b9f8c, - 0xb94b9f8c, 0xb94b9f8c, 0xb94b9f8c, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e5b749, 0x39e5b749, 0x39e5b749, 0x39e5b749, 0x39e5b749, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0xba32cf66, 0xba32cf66, 0xba32cf66, 0xba32cf66, 0xba32cf66, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a72c327, 0x3a72c327, 0x3a72c327, 0x3a72c327, - 0x3a72c327, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4d4914, 0x3a4d4914, - 0x3a4d4914, 0x3a4d4914, 0x3a4d4914, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba0d5553, 0xba0d5553, 0xba0d5553, 0xba0d5553, 0xba0d5553, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x399ac323, 0x399ac323, 0x399ac323, 0x399ac323, 0x399ac323, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb856dcf7, 0xb856dcf7, 0xb856dcf7, 0xb856dcf7, - 0xb856dcf7, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94a17ca, 0xb94a17ca, - 0xb94a17ca, 0xb94a17ca, 0xb94a17ca, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e4f368, 0x39e4f368, 0x39e4f368, 0x39e4f368, 0x39e4f368, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0xba326d75, 0xba326d75, 0xba326d75, 0xba326d75, 0xba326d75, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a726136, 0x3a726136, 0x3a726136, 0x3a726136, - 0x3a726136, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4dab04, 0x3a4dab04, - 0x3a4dab04, 0x3a4dab04, 0x3a4dab04, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba0db743, 0xba0db743, 0xba0db743, 0xba0db743, 0xba0db743, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x399b8704, 0x399b8704, 0x399b8704, 0x399b8704, 0x399b8704, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb85cfc00, 0xb85cfc00, 0xb85cfc00, 0xb85cfc00, - 0xb85cfc00, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb9489008, 0xb9489008, - 0xb9489008, 0xb9489008, 0xb9489008, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e42f87, 0x39e42f87, 0x39e42f87, 0x39e42f87, 0x39e42f87, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0xba320b85, 0xba320b85, 0xba320b85, 0xba320b85, 0xba320b85, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a71ff45, 0x3a71ff45, 0x3a71ff45, 0x3a71ff45, - 0x3a71ff45, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4e0cf5, 0x3a4e0cf5, - 0x3a4e0cf5, 0x3a4e0cf5, 0x3a4e0cf5, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba0e1934, 0xba0e1934, 0xba0e1934, 0xba0e1934, 0xba0e1934, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x399c4ae5, 0x399c4ae5, 0x399c4ae5, 0x399c4ae5, 0x399c4ae5, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8631b08, 0xb8631b08, 0xb8631b08, 0xb8631b08, - 0xb8631b08, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb9470846, 0xb9470846, -] )) ), - -################ chunk 11264 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x46d51055, 0x46d51055, 0x46d51055, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, - 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46da1b87, 0x46da1b87, 0x46da1b87, - 0x46da1b87, 0x46da1b87, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dd7853, - 0x46dd7853, 0x46dd7853, 0x46dd7853, 0x46dd7853, 0x46df26b9, 0x46df26b9, 0x46df26b9, 0x46df26b9, - 0x46df26b9, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e28384, 0x46e28384, - 0x46e28384, 0x46e28384, 0x46e28384, 0x46e431ea, 0x46e431ea, 0x46e431ea, 0x46e431ea, 0x46e431ea, - 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e78eb6, 0x46e78eb6, 0x46e78eb6, - 0x46e78eb6, 0x46e78eb6, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46eaeb82, - 0x46eaeb82, 0x46eaeb82, 0x46eaeb82, 0x46eaeb82, 0x46ec99e8, 0x46ec99e8, 0x46ec99e8, 0x46ec99e8, - 0x46ec99e8, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46eff6b4, 0x46eff6b4, - 0x46eff6b4, 0x46eff6b4, 0x46eff6b4, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, - 0x46f35380, 0x46f35380, 0x46f35380, 0x46f35380, 0x46f35380, 0x46f501e6, 0x46f501e6, 0x46f501e6, - 0x46f501e6, 0x46f501e6, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f85eb2, - 0x46f85eb2, 0x46f85eb2, 0x46f85eb2, 0x46f85eb2, 0x46fa0d18, 0x46fa0d18, 0x46fa0d18, 0x46fa0d18, - 0x46fa0d18, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fd69e3, 0x46fd69e3, - 0x46fd69e3, 0x46fd69e3, 0x46fd69e3, 0x46ff1849, 0x46ff1849, 0x46ff1849, 0x46ff1849, 0x46ff1849, - 0x47006358, 0x47006358, 0x47006358, 0x47006358, 0x47006358, 0x47013a8b, 0x47013a8b, 0x47013a8b, - 0x47013a8b, 0x47013a8b, 0x470211be, 0x470211be, 0x470211be, 0x470211be, 0x470211be, 0x4702e8f1, - 0x4702e8f1, 0x4702e8f1, 0x4702e8f1, 0x4702e8f1, 0x4703c024, 0x4703c024, 0x4703c024, 0x4703c024, - 0x4703c024, 0x47049756, 0x47049756, 0x47049756, 0x47049756, 0x47049756, 0x47056e89, 0x47056e89, - 0x47056e89, 0x47056e89, 0x47056e89, 0x470645bc, 0x470645bc, 0x470645bc, 0x470645bc, 0x470645bc, - 0x47071cef, 0x47071cef, 0x47071cef, 0x47071cef, 0x47071cef, 0x4707f422, 0x4707f422, 0x4707f422, - 0x4707f422, 0x4707f422, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4709a288, - 0x4709a288, 0x4709a288, 0x4709a288, 0x4709a288, 0x470a79bb, 0x470a79bb, 0x470a79bb, 0x470a79bb, - 0x470a79bb, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470c2821, 0x470c2821, - 0x470c2821, 0x470c2821, 0x470c2821, 0x470cff54, 0x470cff54, 0x470cff54, 0x470cff54, 0x470cff54, - 0x470dd687, 0x470dd687, 0x470dd687, 0x470dd687, 0x470dd687, 0x470eadba, 0x470eadba, 0x470eadba, - 0x470eadba, 0x470eadba, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x47105c20, - 0x47105c20, 0x47105c20, 0x47105c20, 0x47105c20, 0x47113353, 0x47113353, 0x47113353, 0x47113353, - 0x47113353, 0x47120a86, 0x47120a86, 0x47120a86, 0x47120a86, 0x47120a86, 0x4712e1b9, 0x4712e1b9, - 0x4712e1b9, 0x4712e1b9, 0x4712e1b9, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, - 0x4714901f, 0x4714901f, 0x4714901f, 0x4714901f, 0x4714901f, 0x47156752, 0x47156752, 0x47156752, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xb9470846, 0xb9470846, 0xb9470846, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e36ba6, 0x39e36ba6, 0x39e36ba6, 0x39e36ba6, 0x39e36ba6, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0xba31a994, 0xba31a994, 0xba31a994, 0xba31a994, 0xba31a994, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a719d55, 0x3a719d55, 0x3a719d55, 0x3a719d55, - 0x3a719d55, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4e6ee5, 0x3a4e6ee5, - 0x3a4e6ee5, 0x3a4e6ee5, 0x3a4e6ee5, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba0e7b24, 0xba0e7b24, 0xba0e7b24, 0xba0e7b24, 0xba0e7b24, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x399d0ec6, 0x399d0ec6, 0x399d0ec6, 0x399d0ec6, 0x399d0ec6, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8693a11, 0xb8693a11, 0xb8693a11, 0xb8693a11, - 0xb8693a11, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb9458083, 0xb9458083, - 0xb9458083, 0xb9458083, 0xb9458083, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e2a7c5, 0x39e2a7c5, 0x39e2a7c5, 0x39e2a7c5, 0x39e2a7c5, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0xba3147a4, 0xba3147a4, 0xba3147a4, 0xba3147a4, 0xba3147a4, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a713b64, 0x3a713b64, 0x3a713b64, 0x3a713b64, - 0x3a713b64, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4ed0d6, 0x3a4ed0d6, - 0x3a4ed0d6, 0x3a4ed0d6, 0x3a4ed0d6, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0x3ab89171, 0x3ab89171, 0x3ab89171, 0x3ab89171, 0x3ab89171, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, - 0x3f7fffec, 0x3f7fffec, 0xbad88b50, 0xbad88b50, 0xbad88b50, 0xbad88b50, 0xbad88b50, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af8852d, 0x3af8852d, 0x3af8852d, 0x3af8852d, - 0x3af8852d, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae780e0, 0x3ae780e0, - 0x3ae780e0, 0x3ae780e0, 0x3ae780e0, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, - 0xbac78702, 0xbac78702, 0xbac78702, 0xbac78702, 0xbac78702, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3aa78d23, 0x3aa78d23, 0x3aa78d23, 0x3aa78d23, 0x3aa78d23, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba879343, 0xba879343, 0xba879343, 0xba879343, - 0xba879343, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4f32c7, 0x3a4f32c7, - 0x3a4f32c7, 0x3a4f32c7, 0x3a4f32c7, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba0f3f06, 0xba0f3f06, 0xba0f3f06, 0xba0f3f06, 0xba0f3f06, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x399e9688, 0x399e9688, 0x399e9688, 0x399e9688, 0x399e9688, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8757822, 0xb8757822, 0xb8757822, 0xb8757822, - 0xb8757822, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb94270ff, 0xb94270ff, - 0xb94270ff, 0xb94270ff, 0xb94270ff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39e12003, 0x39e12003, 0x39e12003, 0x39e12003, 0x39e12003, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, -] )) ), - -################ chunk 11776 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47156752, 0x47156752, 0x47163e85, 0x47163e85, 0x47163e85, 0x47163e85, 0x47163e85, 0x471715b8, - 0x471715b8, 0x471715b8, 0x471715b8, 0x471715b8, 0x4717eceb, 0x4717eceb, 0x4717eceb, 0x4717eceb, - 0x4717eceb, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x47199b51, 0x47199b51, - 0x47199b51, 0x47199b51, 0x47199b51, 0x471a7284, 0x471a7284, 0x471a7284, 0x471a7284, 0x471a7284, - 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471c20ea, 0x471c20ea, 0x471c20ea, - 0x471c20ea, 0x471c20ea, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471dcf50, - 0x471dcf50, 0x471dcf50, 0x471dcf50, 0x471dcf50, 0x471ea683, 0x471ea683, 0x471ea683, 0x471ea683, - 0x471ea683, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x472054e8, 0x472054e8, - 0x472054e8, 0x472054e8, 0x472054e8, 0x47212c1b, 0x47212c1b, 0x47212c1b, 0x47212c1b, 0x47212c1b, - 0x4722034e, 0x4722034e, 0x4722034e, 0x4722034e, 0x4722034e, 0x4722da81, 0x4722da81, 0x4722da81, - 0x4722da81, 0x4722da81, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x472488e7, - 0x472488e7, 0x472488e7, 0x472488e7, 0x472488e7, 0x4725601a, 0x4725601a, 0x4725601a, 0x4725601a, - 0x4725601a, 0x4726374d, 0x4726374d, 0x4726374d, 0x4726374d, 0x4726374d, 0x47270e80, 0x47270e80, - 0x47270e80, 0x47270e80, 0x47270e80, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, - 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x47299419, 0x47299419, 0x47299419, - 0x47299419, 0x47299419, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472b427f, - 0x472b427f, 0x472b427f, 0x472b427f, 0x472b427f, 0x472c19b2, 0x472c19b2, 0x472c19b2, 0x472c19b2, - 0x472c19b2, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472dc818, 0x472dc818, - 0x472dc818, 0x472dc818, 0x472dc818, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, - 0x472f767e, 0x472f767e, 0x472f767e, 0x472f767e, 0x472f767e, 0x47304db1, 0x47304db1, 0x47304db1, - 0x47304db1, 0x47304db1, 0x473124e4, 0x473124e4, 0x473124e4, 0x473124e4, 0x473124e4, 0x4731fc17, - 0x4731fc17, 0x4731fc17, 0x4731fc17, 0x4731fc17, 0x4732d34a, 0x4732d34a, 0x4732d34a, 0x4732d34a, - 0x4732d34a, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x473481b0, 0x473481b0, - 0x473481b0, 0x473481b0, 0x473481b0, 0x473558e3, 0x473558e3, 0x473558e3, 0x473558e3, 0x473558e3, - 0x47363016, 0x47363016, 0x47363016, 0x47363016, 0x47363016, 0x47370749, 0x47370749, 0x47370749, - 0x47370749, 0x47370749, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4738b5af, - 0x4738b5af, 0x4738b5af, 0x4738b5af, 0x4738b5af, 0x47398ce2, 0x47398ce2, 0x47398ce2, 0x47398ce2, - 0x47398ce2, 0x473a6414, 0x473a6414, 0x473a6414, 0x473a6414, 0x473a6414, 0x473b3b47, 0x473b3b47, - 0x473b3b47, 0x473b3b47, 0x473b3b47, 0x473c127a, 0x473c127a, 0x473c127a, 0x473c127a, 0x473c127a, - 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473dc0e0, 0x473dc0e0, 0x473dc0e0, - 0x473dc0e0, 0x473dc0e0, 0x473e9813, 0x473e9813, 0x473e9813, 0x473e9813, 0x473e9813, 0x473f6f46, - 0x473f6f46, 0x473f6f46, 0x473f6f46, 0x473f6f46, 0x47404679, 0x47404679, 0x47404679, 0x47404679, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffffd, 0x3f7ffffd, 0xba3083c3, 0xba3083c3, 0xba3083c3, 0xba3083c3, 0xba3083c3, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a707783, 0x3a707783, 0x3a707783, 0x3a707783, - 0x3a707783, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0xba9835a2, 0xba9835a2, - 0xba9835a2, 0xba9835a2, 0xba9835a2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, - 0x3ab82f81, 0x3ab82f81, 0x3ab82f81, 0x3ab82f81, 0x3ab82f81, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, - 0x3f7fffec, 0x3f7fffec, 0xbad8295f, 0xbad8295f, 0xbad8295f, 0xbad8295f, 0xbad8295f, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af8233d, 0x3af8233d, 0x3af8233d, 0x3af8233d, - 0x3af8233d, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae7e2d0, 0x3ae7e2d0, - 0x3ae7e2d0, 0x3ae7e2d0, 0x3ae7e2d0, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, - 0xbac7e8f2, 0xbac7e8f2, 0xbac7e8f2, 0xbac7e8f2, 0xbac7e8f2, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0x3aa7ef13, 0x3aa7ef13, 0x3aa7ef13, 0x3aa7ef13, 0x3aa7ef13, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba87f534, 0xba87f534, 0xba87f534, 0xba87f534, - 0xba87f534, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a4ff6a8, 0x3a4ff6a8, - 0x3a4ff6a8, 0x3a4ff6a8, 0x3a4ff6a8, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba1002e7, 0xba1002e7, 0xba1002e7, 0xba1002e7, 0xba1002e7, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x39a01e4a, 0x39a01e4a, 0x39a01e4a, 0x39a01e4a, 0x39a01e4a, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb880db19, 0xb880db19, 0xb880db19, 0xb880db19, - 0xb880db19, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb93f617b, 0xb93f617b, - 0xb93f617b, 0xb93f617b, 0xb93f617b, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39df9841, 0x39df9841, 0x39df9841, 0x39df9841, 0x39df9841, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0xba2fbfe2, 0xba2fbfe2, 0xba2fbfe2, 0xba2fbfe2, 0xba2fbfe2, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a6fb3a2, 0x3a6fb3a2, 0x3a6fb3a2, 0x3a6fb3a2, - 0x3a6fb3a2, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0xba97d3b1, 0xba97d3b1, - 0xba97d3b1, 0xba97d3b1, 0xba97d3b1, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, - 0x3ab7cd90, 0x3ab7cd90, 0x3ab7cd90, 0x3ab7cd90, 0x3ab7cd90, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0xbad7c76f, 0xbad7c76f, 0xbad7c76f, 0xbad7c76f, 0xbad7c76f, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af7c14c, 0x3af7c14c, 0x3af7c14c, 0x3af7c14c, - 0x3af7c14c, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae844c1, 0x3ae844c1, - 0x3ae844c1, 0x3ae844c1, 0x3ae844c1, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, - 0xbac84ae3, 0xbac84ae3, 0xbac84ae3, 0xbac84ae3, 0xbac84ae3, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0x3aa85104, 0x3aa85104, 0x3aa85104, 0x3aa85104, 0x3aa85104, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba885724, 0xba885724, 0xba885724, 0xba885724, -] )) ), - -################ chunk 12288 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47404679, 0x47411dac, 0x47411dac, 0x47411dac, 0x47411dac, 0x47411dac, 0x4741f4df, 0x4741f4df, - 0x4741f4df, 0x4741f4df, 0x4741f4df, 0x4742cc12, 0x4742cc12, 0x4742cc12, 0x4742cc12, 0x4742cc12, - 0x4743a345, 0x4743a345, 0x4743a345, 0x4743a345, 0x4743a345, 0x47447a78, 0x47447a78, 0x47447a78, - 0x47447a78, 0x47447a78, 0x474551ab, 0x474551ab, 0x474551ab, 0x474551ab, 0x474551ab, 0x474628de, - 0x474628de, 0x474628de, 0x474628de, 0x474628de, 0x47470011, 0x47470011, 0x47470011, 0x47470011, - 0x47470011, 0x4747d744, 0x4747d744, 0x4747d744, 0x4747d744, 0x4747d744, 0x4748ae77, 0x4748ae77, - 0x4748ae77, 0x4748ae77, 0x4748ae77, 0x474985aa, 0x474985aa, 0x474985aa, 0x474985aa, 0x474985aa, - 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474b3410, 0x474b3410, 0x474b3410, - 0x474b3410, 0x474b3410, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474ce276, - 0x474ce276, 0x474ce276, 0x474ce276, 0x474ce276, 0x474db9a9, 0x474db9a9, 0x474db9a9, 0x474db9a9, - 0x474db9a9, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474f680f, 0x474f680f, - 0x474f680f, 0x474f680f, 0x474f680f, 0x47503f42, 0x47503f42, 0x47503f42, 0x47503f42, 0x47503f42, - 0x47511675, 0x47511675, 0x47511675, 0x47511675, 0x47511675, 0x4751eda8, 0x4751eda8, 0x4751eda8, - 0x4751eda8, 0x4751eda8, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x47539c0e, - 0x47539c0e, 0x47539c0e, 0x47539c0e, 0x47539c0e, 0x47547341, 0x47547341, 0x47547341, 0x47547341, - 0x47547341, 0x47554a73, 0x47554a73, 0x47554a73, 0x47554a73, 0x47554a73, 0x475621a6, 0x475621a6, - 0x475621a6, 0x475621a6, 0x475621a6, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, - 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4758a73f, 0x4758a73f, 0x4758a73f, - 0x4758a73f, 0x4758a73f, 0x47597e72, 0x47597e72, 0x47597e72, 0x47597e72, 0x47597e72, 0x475a55a5, - 0x475a55a5, 0x475a55a5, 0x475a55a5, 0x475a55a5, 0x475b2cd8, 0x475b2cd8, 0x475b2cd8, 0x475b2cd8, - 0x475b2cd8, 0x475c040b, 0x475c040b, 0x475c040b, 0x475c040b, 0x475c040b, 0x475cdb3e, 0x475cdb3e, - 0x475cdb3e, 0x475cdb3e, 0x475cdb3e, 0x475db271, 0x475db271, 0x475db271, 0x475db271, 0x475db271, - 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475f60d7, 0x475f60d7, 0x475f60d7, - 0x475f60d7, 0x475f60d7, 0x4760380a, 0x4760380a, 0x4760380a, 0x4760380a, 0x4760380a, 0x47610f3d, - 0x47610f3d, 0x47610f3d, 0x47610f3d, 0x47610f3d, 0x4761e670, 0x4761e670, 0x4761e670, 0x4761e670, - 0x4761e670, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x476394d6, 0x476394d6, - 0x476394d6, 0x476394d6, 0x476394d6, 0x47646c09, 0x47646c09, 0x47646c09, 0x47646c09, 0x47646c09, - 0x4765433c, 0x4765433c, 0x4765433c, 0x4765433c, 0x4765433c, 0x47661a6f, 0x47661a6f, 0x47661a6f, - 0x47661a6f, 0x47661a6f, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4767c8d5, - 0x4767c8d5, 0x4767c8d5, 0x4767c8d5, 0x4767c8d5, 0x4768a008, 0x4768a008, 0x4768a008, 0x4768a008, - 0x4768a008, 0x4769773b, 0x4769773b, 0x4769773b, 0x4769773b, 0x4769773b, 0x476a4e6e, 0x476a4e6e, - 0x476a4e6e, 0x476a4e6e, 0x476a4e6e, 0x476b25a1, 0x476b25a1, 0x476b25a1, 0x476b25a1, 0x476b25a1, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xba885724, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a50ba89, 0x3a50ba89, - 0x3a50ba89, 0x3a50ba89, 0x3a50ba89, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba10c6c8, 0xba10c6c8, 0xba10c6c8, 0xba10c6c8, 0xba10c6c8, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x39a1a60c, 0x39a1a60c, 0x39a1a60c, 0x39a1a60c, 0x39a1a60c, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb886fa22, 0xb886fa22, 0xb886fa22, 0xb886fa22, - 0xb886fa22, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb93c51f7, 0xb93c51f7, - 0xb93c51f7, 0xb93c51f7, 0xb93c51f7, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39de107f, 0x39de107f, 0x39de107f, 0x39de107f, 0x39de107f, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0xba2efc01, 0xba2efc01, 0xba2efc01, 0xba2efc01, 0xba2efc01, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a6eefc1, 0x3a6eefc1, 0x3a6eefc1, 0x3a6eefc1, - 0x3a6eefc1, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0xba9771c1, 0xba9771c1, - 0xba9771c1, 0xba9771c1, 0xba9771c1, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, - 0x3ab76ba0, 0x3ab76ba0, 0x3ab76ba0, 0x3ab76ba0, 0x3ab76ba0, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0xbad7657e, 0xbad7657e, 0xbad7657e, 0xbad7657e, 0xbad7657e, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af75f5c, 0x3af75f5c, 0x3af75f5c, 0x3af75f5c, - 0x3af75f5c, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae8a6b1, 0x3ae8a6b1, - 0x3ae8a6b1, 0x3ae8a6b1, 0x3ae8a6b1, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, - 0xbac8acd3, 0xbac8acd3, 0xbac8acd3, 0xbac8acd3, 0xbac8acd3, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0x3aa8b2f4, 0x3aa8b2f4, 0x3aa8b2f4, 0x3aa8b2f4, 0x3aa8b2f4, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba88b915, 0xba88b915, 0xba88b915, 0xba88b915, - 0xba88b915, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a517e6a, 0x3a517e6a, - 0x3a517e6a, 0x3a517e6a, 0x3a517e6a, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba118aa9, 0xba118aa9, 0xba118aa9, 0xba118aa9, 0xba118aa9, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x39a32dce, 0x39a32dce, 0x39a32dce, 0x39a32dce, 0x39a32dce, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb88d192a, 0xb88d192a, 0xb88d192a, 0xb88d192a, - 0xb88d192a, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb9394272, 0xb9394272, - 0xb9394272, 0xb9394272, 0xb9394272, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x39dc88bd, 0x39dc88bd, 0x39dc88bd, 0x39dc88bd, 0x39dc88bd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0xba2e3820, 0xba2e3820, 0xba2e3820, 0xba2e3820, 0xba2e3820, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3a6e2be0, 0x3a6e2be0, 0x3a6e2be0, 0x3a6e2be0, - 0x3a6e2be0, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0xba970fd0, 0xba970fd0, - 0xba970fd0, 0xba970fd0, 0xba970fd0, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, -] )) ), - -################ chunk 12800 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476cd407, 0x476cd407, 0x476cd407, - 0x476cd407, 0x476cd407, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476e826d, - 0x476e826d, 0x476e826d, 0x476e826d, 0x476e826d, 0x476f59a0, 0x476f59a0, 0x476f59a0, 0x476f59a0, - 0x476f59a0, 0x477030d2, 0x477030d2, 0x477030d2, 0x477030d2, 0x477030d2, 0x47710805, 0x47710805, - 0x47710805, 0x47710805, 0x47710805, 0x4771df38, 0x4771df38, 0x4771df38, 0x4771df38, 0x4771df38, - 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x47738d9e, 0x47738d9e, 0x47738d9e, - 0x47738d9e, 0x47738d9e, 0x477464d1, 0x477464d1, 0x477464d1, 0x477464d1, 0x477464d1, 0x47753c04, - 0x47753c04, 0x47753c04, 0x47753c04, 0x47753c04, 0x47761337, 0x47761337, 0x47761337, 0x47761337, - 0x47761337, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4777c19d, 0x4777c19d, - 0x4777c19d, 0x4777c19d, 0x4777c19d, 0x477898d0, 0x477898d0, 0x477898d0, 0x477898d0, 0x477898d0, - 0x47797003, 0x47797003, 0x47797003, 0x47797003, 0x47797003, 0x477a4736, 0x477a4736, 0x477a4736, - 0x477a4736, 0x477a4736, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477bf59c, - 0x477bf59c, 0x477bf59c, 0x477bf59c, 0x477bf59c, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, - 0x477ccccf, 0x477da402, 0x477da402, 0x477da402, 0x477da402, 0x477da402, 0x477e7b35, 0x477e7b35, - 0x477e7b35, 0x477e7b35, 0x477e7b35, 0x477f5268, 0x477f5268, 0x477f5268, 0x477f5268, 0x477f5268, - 0x478014cd, 0x478014cd, 0x478014cd, 0x478014cd, 0x478014cd, 0x47808067, 0x47808067, 0x47808067, - 0x47808067, 0x47808067, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4781579a, - 0x4781579a, 0x4781579a, 0x4781579a, 0x4781579a, 0x4781c333, 0x4781c333, 0x4781c333, 0x4781c333, - 0x4781c333, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47829a66, 0x47829a66, - 0x47829a66, 0x47829a66, 0x47829a66, 0x47830600, 0x47830600, 0x47830600, 0x47830600, 0x47830600, - 0x47837199, 0x47837199, 0x47837199, 0x47837199, 0x47837199, 0x4783dd33, 0x4783dd33, 0x4783dd33, - 0x4783dd33, 0x4783dd33, 0x478448cc, 0x478448cc, 0x478448cc, 0x478448cc, 0x478448cc, 0x4784b466, - 0x4784b466, 0x4784b466, 0x4784b466, 0x4784b466, 0x47851fff, 0x47851fff, 0x47851fff, 0x47851fff, - 0x47851fff, 0x47858b99, 0x47858b99, 0x47858b99, 0x47858b99, 0x47858b99, 0x4785f732, 0x4785f732, - 0x4785f732, 0x4785f732, 0x4785f732, 0x478662cc, 0x478662cc, 0x478662cc, 0x478662cc, 0x478662cc, - 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x478739ff, 0x478739ff, 0x478739ff, - 0x478739ff, 0x478739ff, 0x4787a598, 0x4787a598, 0x4787a598, 0x4787a598, 0x4787a598, 0x47881132, - 0x47881132, 0x47881132, 0x47881132, 0x47881132, 0x47887ccb, 0x47887ccb, 0x47887ccb, 0x47887ccb, - 0x47887ccb, 0x4788e865, 0x4788e865, 0x4788e865, 0x4788e865, 0x4788e865, 0x478953fe, 0x478953fe, - 0x478953fe, 0x478953fe, 0x478953fe, 0x4789bf98, 0x4789bf98, 0x4789bf98, 0x4789bf98, 0x4789bf98, - 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a96cb, 0x478a96cb, 0x478a96cb, - 0x478a96cb, 0x478a96cb, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b6dfe, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3ab709af, 0x3ab709af, 0x3ab709af, 0x3ab709af, 0x3ab709af, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0xbad7038e, 0xbad7038e, 0xbad7038e, 0xbad7038e, 0xbad7038e, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0x3af6fd6c, 0x3af6fd6c, 0x3af6fd6c, 0x3af6fd6c, - 0x3af6fd6c, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3ae908a2, 0x3ae908a2, - 0x3ae908a2, 0x3ae908a2, 0x3ae908a2, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, - 0xbac90ec4, 0xbac90ec4, 0xbac90ec4, 0xbac90ec4, 0xbac90ec4, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0x3aa914e5, 0x3aa914e5, 0x3aa914e5, 0x3aa914e5, 0x3aa914e5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xba891b05, 0xba891b05, 0xba891b05, 0xba891b05, - 0xba891b05, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3a52424b, 0x3a52424b, - 0x3a52424b, 0x3a52424b, 0x3a52424b, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0xba124e8a, 0xba124e8a, 0xba124e8a, 0xba124e8a, 0xba124e8a, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x39a4b590, 0x39a4b590, 0x39a4b590, 0x39a4b590, 0x39a4b590, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb8933833, 0xb8933833, 0xb8933833, 0xb8933833, - 0xb8933833, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb93632ee, 0xb93632ee, - 0xb93632ee, 0xb93632ee, 0xb93632ee, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0xbb649fc2, 0xbb649fc2, 0xbb649fc2, 0xbb649fc2, 0xbb649fc2, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3b54a2d8, 0x3b54a2d8, 0x3b54a2d8, 0x3b54a2d8, 0x3b54a2d8, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb44a5ec, 0xbb44a5ec, 0xbb44a5ec, 0xbb44a5ec, - 0xbb44a5ec, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3b34a900, 0x3b34a900, - 0x3b34a900, 0x3b34a900, 0x3b34a900, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, - 0xbb24ac13, 0xbb24ac13, 0xbb24ac13, 0xbb24ac13, 0xbb24ac13, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3b14af26, 0x3b14af26, 0x3b14af26, 0x3b14af26, 0x3b14af26, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbb04b238, 0xbb04b238, 0xbb04b238, 0xbb04b238, - 0xbb04b238, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, 0x3ae96a92, 0x3ae96a92, - 0x3ae96a92, 0x3ae96a92, 0x3ae96a92, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, - 0xbac970b4, 0xbac970b4, 0xbac970b4, 0xbac970b4, 0xbac970b4, 0x3f7fffcc, 0x3f7fffcc, 0x3f7fffcc, - 0x3f7fffcc, 0x3f7fffcc, 0x3aa976d5, 0x3aa976d5, 0x3aa976d5, 0x3aa976d5, 0x3aa976d5, 0xbf7fffc1, - 0xbf7fffc1, 0xbf7fffc1, 0xbf7fffc1, 0xbf7fffc1, 0xba897cf6, 0xba897cf6, 0xba897cf6, 0xba897cf6, - 0xba897cf6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3a53062c, 0x3a53062c, - 0x3a53062c, 0x3a53062c, 0x3a53062c, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, - 0xba13126b, 0xba13126b, 0xba13126b, 0xba13126b, 0xba13126b, 0x3f7fff9b, 0x3f7fff9b, 0x3f7fff9b, - 0x3f7fff9b, 0x3f7fff9b, 0x39a63d53, 0x39a63d53, 0x39a63d53, 0x39a63d53, 0x39a63d53, 0xbf7fff8c, -] )) ), - -################ chunk 13312 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x478b6dfe, 0x478b6dfe, 0x478b6dfe, 0x478b6dfe, 0x478bd997, 0x478bd997, 0x478bd997, 0x478bd997, - 0x478bd997, 0x478c4530, 0x478c4530, 0x478c4530, 0x478c4530, 0x478c4530, 0x478cb0ca, 0x478cb0ca, - 0x478cb0ca, 0x478cb0ca, 0x478cb0ca, 0x478d1c63, 0x478d1c63, 0x478d1c63, 0x478d1c63, 0x478d1c63, - 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478df396, 0x478df396, 0x478df396, - 0x478df396, 0x478df396, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478ecac9, - 0x478ecac9, 0x478ecac9, 0x478ecac9, 0x478ecac9, 0x478f3663, 0x478f3663, 0x478f3663, 0x478f3663, - 0x478f3663, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x47900d96, 0x47900d96, - 0x47900d96, 0x47900d96, 0x47900d96, 0x4790792f, 0x4790792f, 0x4790792f, 0x4790792f, 0x4790792f, - 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x47915062, 0x47915062, 0x47915062, - 0x47915062, 0x47915062, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x47922795, - 0x47922795, 0x47922795, 0x47922795, 0x47922795, 0x4792932f, 0x4792932f, 0x4792932f, 0x4792932f, - 0x4792932f, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x47936a62, 0x47936a62, - 0x47936a62, 0x47936a62, 0x47936a62, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, - 0x47944195, 0x47944195, 0x47944195, 0x47944195, 0x47944195, 0x4794ad2e, 0x4794ad2e, 0x4794ad2e, - 0x4794ad2e, 0x4794ad2e, 0x479518c8, 0x479518c8, 0x479518c8, 0x479518c8, 0x479518c8, 0x47958461, - 0x47958461, 0x47958461, 0x47958461, 0x47958461, 0x4795effb, 0x4795effb, 0x4795effb, 0x4795effb, - 0x4795effb, 0x47965b94, 0x47965b94, 0x47965b94, 0x47965b94, 0x47965b94, 0x4796c72e, 0x4796c72e, - 0x4796c72e, 0x4796c72e, 0x4796c72e, 0x479732c7, 0x479732c7, 0x479732c7, 0x479732c7, 0x479732c7, - 0x47979e61, 0x47979e61, 0x47979e61, 0x47979e61, 0x47979e61, 0x479809fa, 0x479809fa, 0x479809fa, - 0x479809fa, 0x479809fa, 0x47987594, 0x47987594, 0x47987594, 0x47987594, 0x47987594, 0x4798e12d, - 0x4798e12d, 0x4798e12d, 0x4798e12d, 0x4798e12d, 0x47994cc7, 0x47994cc7, 0x47994cc7, 0x47994cc7, - 0x47994cc7, 0x4799b860, 0x4799b860, 0x4799b860, 0x4799b860, 0x4799b860, 0x479a23f9, 0x479a23f9, - 0x479a23f9, 0x479a23f9, 0x479a23f9, 0x479a8f93, 0x479a8f93, 0x479a8f93, 0x479a8f93, 0x479a8f93, - 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479b66c6, 0x479b66c6, 0x479b66c6, - 0x479b66c6, 0x479b66c6, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479c3df9, - 0x479c3df9, 0x479c3df9, 0x479c3df9, 0x479c3df9, 0x479ca992, 0x479ca992, 0x479ca992, 0x479ca992, - 0x479ca992, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d80c5, 0x479d80c5, - 0x479d80c5, 0x479d80c5, 0x479d80c5, 0x479dec5f, 0x479dec5f, 0x479dec5f, 0x479dec5f, 0x479dec5f, - 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479ec392, 0x479ec392, 0x479ec392, - 0x479ec392, 0x479ec392, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f9ac5, - 0x479f9ac5, 0x479f9ac5, 0x479f9ac5, 0x479f9ac5, 0x47a0065e, 0x47a0065e, 0x47a0065e, 0x47a0065e, - 0x47a0065e, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a0dd91, 0x47a0dd91, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbf7fff8c, 0xbf7fff8c, 0xbf7fff8c, 0xbf7fff8c, 0xb899573b, 0xb899573b, 0xb899573b, 0xb899573b, - 0xb899573b, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0xb933236a, 0xb933236a, - 0xb933236a, 0xb933236a, 0xb933236a, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, - 0x39d97938, 0x39d97938, 0x39d97938, 0x39d97938, 0x39d97938, 0x3f7fffa1, 0x3f7fffa1, 0x3f7fffa1, - 0x3f7fffa1, 0x3f7fffa1, 0xba2cb05e, 0xba2cb05e, 0xba2cb05e, 0xba2cb05e, 0xba2cb05e, 0xbf7fffae, - 0xbf7fffae, 0xbf7fffae, 0xbf7fffae, 0xbf7fffae, 0x3a6ca41e, 0x3a6ca41e, 0x3a6ca41e, 0x3a6ca41e, - 0x3a6ca41e, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0xba964bef, 0xba964bef, - 0xba964bef, 0xba964bef, 0xba964bef, 0xbf7fffc6, 0xbf7fffc6, 0xbf7fffc6, 0xbf7fffc6, 0xbf7fffc6, - 0x3ab645ce, 0x3ab645ce, 0x3ab645ce, 0x3ab645ce, 0x3ab645ce, 0x3f7fffd0, 0x3f7fffd0, 0x3f7fffd0, - 0x3f7fffd0, 0x3f7fffd0, 0xbad63fad, 0xbad63fad, 0xbad63fad, 0xbad63fad, 0xbad63fad, 0xbf7fffd9, - 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0x3af6398b, 0x3af6398b, 0x3af6398b, 0x3af6398b, - 0x3af6398b, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0xbb0b19b4, 0xbb0b19b4, - 0xbb0b19b4, 0xbb0b19b4, 0xbb0b19b4, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, - 0x3b1b16a1, 0x3b1b16a1, 0x3b1b16a1, 0x3b1b16a1, 0x3b1b16a1, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0xbb2b138f, 0xbb2b138f, 0xbb2b138f, 0xbb2b138f, 0xbb2b138f, 0xbf7ffff4, - 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b3b107b, 0x3b3b107b, 0x3b3b107b, 0x3b3b107b, - 0x3b3b107b, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0xbb4b0d67, 0xbb4b0d67, - 0xbb4b0d67, 0xbb4b0d67, 0xbb4b0d67, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0x3b5b0a52, 0x3b5b0a52, 0x3b5b0a52, 0x3b5b0a52, 0x3b5b0a52, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0xbb6b073c, 0xbb6b073c, 0xbb6b073c, 0xbb6b073c, 0xbb6b073c, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b7b0426, 0x3b7b0426, 0x3b7b0426, 0x3b7b0426, - 0x3b7b0426, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3b74fe9c, 0x3b74fe9c, - 0x3b74fe9c, 0x3b74fe9c, 0x3b74fe9c, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0xbb6501b3, 0xbb6501b3, 0xbb6501b3, 0xbb6501b3, 0xbb6501b3, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3b5504c8, 0x3b5504c8, 0x3b5504c8, 0x3b5504c8, 0x3b5504c8, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb4507dd, 0xbb4507dd, 0xbb4507dd, 0xbb4507dd, - 0xbb4507dd, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3b350af1, 0x3b350af1, - 0x3b350af1, 0x3b350af1, 0x3b350af1, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, - 0xbb250e04, 0xbb250e04, 0xbb250e04, 0xbb250e04, 0xbb250e04, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3b151116, 0x3b151116, 0x3b151116, 0x3b151116, 0x3b151116, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbb051428, 0xbb051428, 0xbb051428, 0xbb051428, - 0xbb051428, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3aea2e73, 0x3aea2e73, -] )) ), - -################ chunk 13824 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47a0dd91, 0x47a0dd91, 0x47a0dd91, 0x47a1492b, 0x47a1492b, 0x47a1492b, 0x47a1492b, 0x47a1492b, - 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a2205e, 0x47a2205e, 0x47a2205e, - 0x47a2205e, 0x47a2205e, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a2f791, - 0x47a2f791, 0x47a2f791, 0x47a2f791, 0x47a2f791, 0x47a3632a, 0x47a3632a, 0x47a3632a, 0x47a3632a, - 0x47a3632a, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a43a5d, 0x47a43a5d, - 0x47a43a5d, 0x47a43a5d, 0x47a43a5d, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, - 0x47a51190, 0x47a51190, 0x47a51190, 0x47a51190, 0x47a51190, 0x47a57d2a, 0x47a57d2a, 0x47a57d2a, - 0x47a57d2a, 0x47a57d2a, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a6545d, - 0x47a6545d, 0x47a6545d, 0x47a6545d, 0x47a6545d, 0x47a6bff6, 0x47a6bff6, 0x47a6bff6, 0x47a6bff6, - 0x47a6bff6, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a79729, 0x47a79729, - 0x47a79729, 0x47a79729, 0x47a79729, 0x47a802c2, 0x47a802c2, 0x47a802c2, 0x47a802c2, 0x47a802c2, - 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a8d9f5, 0x47a8d9f5, 0x47a8d9f5, - 0x47a8d9f5, 0x47a8d9f5, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9b128, - 0x47a9b128, 0x47a9b128, 0x47a9b128, 0x47a9b128, 0x47aa1cc2, 0x47aa1cc2, 0x47aa1cc2, 0x47aa1cc2, - 0x47aa1cc2, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aaf3f5, 0x47aaf3f5, - 0x47aaf3f5, 0x47aaf3f5, 0x47aaf3f5, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, - 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47ac36c1, 0x47ac36c1, 0x47ac36c1, - 0x47ac36c1, 0x47ac36c1, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47ad0df4, - 0x47ad0df4, 0x47ad0df4, 0x47ad0df4, 0x47ad0df4, 0x47ad798e, 0x47ad798e, 0x47ad798e, 0x47ad798e, - 0x47ad798e, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ae50c1, 0x47ae50c1, - 0x47ae50c1, 0x47ae50c1, 0x47ae50c1, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, - 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af938d, 0x47af938d, 0x47af938d, - 0x47af938d, 0x47af938d, 0x47afff27, 0x47afff27, 0x47afff27, 0x47afff27, 0x47afff27, 0x47b06ac0, - 0x47b06ac0, 0x47b06ac0, 0x47b06ac0, 0x47b06ac0, 0x47b0d65a, 0x47b0d65a, 0x47b0d65a, 0x47b0d65a, - 0x47b0d65a, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b1ad8d, 0x47b1ad8d, - 0x47b1ad8d, 0x47b1ad8d, 0x47b1ad8d, 0x47b21926, 0x47b21926, 0x47b21926, 0x47b21926, 0x47b21926, - 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b2f059, 0x47b2f059, 0x47b2f059, - 0x47b2f059, 0x47b2f059, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b3c78c, - 0x47b3c78c, 0x47b3c78c, 0x47b3c78c, 0x47b3c78c, 0x47b43326, 0x47b43326, 0x47b43326, 0x47b43326, - 0x47b43326, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b50a58, 0x47b50a58, - 0x47b50a58, 0x47b50a58, 0x47b50a58, 0x47b575f2, 0x47b575f2, 0x47b575f2, 0x47b575f2, 0x47b575f2, - 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b64d25, 0x47b64d25, 0x47b64d25, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3aea2e73, 0x3aea2e73, 0x3aea2e73, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, - 0xbaca3495, 0xbaca3495, 0xbaca3495, 0xbaca3495, 0xbaca3495, 0x3f7fffcc, 0x3f7fffcc, 0x3f7fffcc, - 0x3f7fffcc, 0x3f7fffcc, 0x3aaa3ab6, 0x3aaa3ab6, 0x3aaa3ab6, 0x3aaa3ab6, 0x3aaa3ab6, 0xbf7fffc2, - 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xba8a40d7, 0xba8a40d7, 0xba8a40d7, 0xba8a40d7, - 0xba8a40d7, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3a548dee, 0x3a548dee, - 0x3a548dee, 0x3a548dee, 0x3a548dee, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, - 0xba149a2d, 0xba149a2d, 0xba149a2d, 0xba149a2d, 0xba149a2d, 0x3f7fff9b, 0x3f7fff9b, 0x3f7fff9b, - 0x3f7fff9b, 0x3f7fff9b, 0x39a94cd7, 0x39a94cd7, 0x39a94cd7, 0x39a94cd7, 0x39a94cd7, 0xbf7fff8d, - 0xbf7fff8d, 0xbf7fff8d, 0xbf7fff8d, 0xbf7fff8d, 0xb8a5954c, 0xb8a5954c, 0xb8a5954c, 0xb8a5954c, - 0xb8a5954c, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0x3f7fff83, 0xb92d0461, 0xb92d0461, - 0xb92d0461, 0xb92d0461, 0xb92d0461, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, - 0x39d669b4, 0x39d669b4, 0x39d669b4, 0x39d669b4, 0x39d669b4, 0x3f7fffa0, 0x3f7fffa0, 0x3f7fffa0, - 0x3f7fffa0, 0x3f7fffa0, 0xba2b289b, 0xba2b289b, 0xba2b289b, 0xba2b289b, 0xba2b289b, 0xbf7fffae, - 0xbf7fffae, 0xbf7fffae, 0xbf7fffae, 0xbf7fffae, 0x3a6b1c5c, 0x3a6b1c5c, 0x3a6b1c5c, 0x3a6b1c5c, - 0x3a6b1c5c, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0xba95880e, 0xba95880e, - 0xba95880e, 0xba95880e, 0xba95880e, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, - 0x3ab581ed, 0x3ab581ed, 0x3ab581ed, 0x3ab581ed, 0x3ab581ed, 0x3f7fffd0, 0x3f7fffd0, 0x3f7fffd0, - 0x3f7fffd0, 0x3f7fffd0, 0xbad57bcc, 0xbad57bcc, 0xbad57bcc, 0xbad57bcc, 0xbad57bcc, 0xbf7fffd9, - 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0x3af575aa, 0x3af575aa, 0x3af575aa, 0x3af575aa, - 0x3af575aa, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0xbb0ab7c3, 0xbb0ab7c3, - 0xbb0ab7c3, 0xbb0ab7c3, 0xbb0ab7c3, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, - 0x3b1ab4b1, 0x3b1ab4b1, 0x3b1ab4b1, 0x3b1ab4b1, 0x3b1ab4b1, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0xbb2ab19e, 0xbb2ab19e, 0xbb2ab19e, 0xbb2ab19e, 0xbb2ab19e, 0xbf7ffff4, - 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b3aae8b, 0x3b3aae8b, 0x3b3aae8b, 0x3b3aae8b, - 0x3b3aae8b, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0xbb4aab77, 0xbb4aab77, - 0xbb4aab77, 0xbb4aab77, 0xbb4aab77, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0x3b5aa862, 0x3b5aa862, 0x3b5aa862, 0x3b5aa862, 0x3b5aa862, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0xbb6aa54c, 0xbb6aa54c, 0xbb6aa54c, 0xbb6aa54c, 0xbb6aa54c, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b7aa235, 0x3b7aa235, 0x3b7aa235, 0x3b7aa235, - 0x3b7aa235, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3b75608d, 0x3b75608d, - 0x3b75608d, 0x3b75608d, 0x3b75608d, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0xbb6563a3, 0xbb6563a3, 0xbb6563a3, 0xbb6563a3, 0xbb6563a3, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, -] )) ), - -################ chunk 14336 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47b64d25, 0x47b64d25, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b72458, - 0x47b72458, 0x47b72458, 0x47b72458, 0x47b72458, 0x47b78ff1, 0x47b78ff1, 0x47b78ff1, 0x47b78ff1, - 0x47b78ff1, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b86724, 0x47b86724, - 0x47b86724, 0x47b86724, 0x47b86724, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, - 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b9a9f1, 0x47b9a9f1, 0x47b9a9f1, - 0x47b9a9f1, 0x47b9a9f1, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba8124, - 0x47ba8124, 0x47ba8124, 0x47ba8124, 0x47ba8124, 0x47baecbd, 0x47baecbd, 0x47baecbd, 0x47baecbd, - 0x47baecbd, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bbc3f0, 0x47bbc3f0, - 0x47bbc3f0, 0x47bbc3f0, 0x47bbc3f0, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, - 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bd06bd, 0x47bd06bd, 0x47bd06bd, - 0x47bd06bd, 0x47bd06bd, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bdddf0, - 0x47bdddf0, 0x47bdddf0, 0x47bdddf0, 0x47bdddf0, 0x47be4989, 0x47be4989, 0x47be4989, 0x47be4989, - 0x47be4989, 0x47beb523, 0x47beb523, 0x47beb523, 0x47beb523, 0x47beb523, 0x47bf20bc, 0x47bf20bc, - 0x47bf20bc, 0x47bf20bc, 0x47bf20bc, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, - 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47c06389, 0x47c06389, 0x47c06389, - 0x47c06389, 0x47c06389, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c13abc, - 0x47c13abc, 0x47c13abc, 0x47c13abc, 0x47c13abc, 0x47c1a655, 0x47c1a655, 0x47c1a655, 0x47c1a655, - 0x47c1a655, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c27d88, 0x47c27d88, - 0x47c27d88, 0x47c27d88, 0x47c27d88, 0x47c2e921, 0x47c2e921, 0x47c2e921, 0x47c2e921, 0x47c2e921, - 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c3c054, 0x47c3c054, 0x47c3c054, - 0x47c3c054, 0x47c3c054, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c49787, - 0x47c49787, 0x47c49787, 0x47c49787, 0x47c49787, 0x47c50321, 0x47c50321, 0x47c50321, 0x47c50321, - 0x47c50321, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c5da54, 0x47c5da54, - 0x47c5da54, 0x47c5da54, 0x47c5da54, 0x47c645ed, 0x47c645ed, 0x47c645ed, 0x47c645ed, 0x47c645ed, - 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c71d20, 0x47c71d20, 0x47c71d20, - 0x47c71d20, 0x47c71d20, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c7f453, - 0x47c7f453, 0x47c7f453, 0x47c7f453, 0x47c7f453, 0x47c85fed, 0x47c85fed, 0x47c85fed, 0x47c85fed, - 0x47c85fed, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c93720, 0x47c93720, - 0x47c93720, 0x47c93720, 0x47c93720, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, - 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca79ec, 0x47ca79ec, 0x47ca79ec, - 0x47ca79ec, 0x47ca79ec, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cb511f, - 0x47cb511f, 0x47cb511f, 0x47cb511f, 0x47cb511f, 0x47cbbcb9, 0x47cbbcb9, 0x47cbbcb9, 0x47cbbcb9, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffffe, 0x3f7ffffe, 0x3b5566b8, 0x3b5566b8, 0x3b5566b8, 0x3b5566b8, 0x3b5566b8, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb4569cd, 0xbb4569cd, 0xbb4569cd, 0xbb4569cd, - 0xbb4569cd, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3b356ce1, 0x3b356ce1, - 0x3b356ce1, 0x3b356ce1, 0x3b356ce1, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, - 0xbb256ff4, 0xbb256ff4, 0xbb256ff4, 0xbb256ff4, 0xbb256ff4, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3b157307, 0x3b157307, 0x3b157307, 0x3b157307, 0x3b157307, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbb057619, 0xbb057619, 0xbb057619, 0xbb057619, - 0xbb057619, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3aeaf254, 0x3aeaf254, - 0x3aeaf254, 0x3aeaf254, 0x3aeaf254, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, - 0xbacaf876, 0xbacaf876, 0xbacaf876, 0xbacaf876, 0xbacaf876, 0x3f7fffcc, 0x3f7fffcc, 0x3f7fffcc, - 0x3f7fffcc, 0x3f7fffcc, 0x3aaafe97, 0x3aaafe97, 0x3aaafe97, 0x3aaafe97, 0x3aaafe97, 0xbf7fffc2, - 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xba8b04b8, 0xba8b04b8, 0xba8b04b8, 0xba8b04b8, - 0xba8b04b8, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3a5615b0, 0x3a5615b0, - 0x3a5615b0, 0x3a5615b0, 0x3a5615b0, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, 0xbf7fffa9, - 0xba1621ef, 0xba1621ef, 0xba1621ef, 0xba1621ef, 0xba1621ef, 0x3f7fff9c, 0x3f7fff9c, 0x3f7fff9c, - 0x3f7fff9c, 0x3f7fff9c, 0x39ac5c5b, 0x39ac5c5b, 0x39ac5c5b, 0x39ac5c5b, 0x39ac5c5b, 0xbf7fff8d, - 0xbf7fff8d, 0xbf7fff8d, 0xbf7fff8d, 0xbf7fff8d, 0xb8b1d35d, 0xb8b1d35d, 0xb8b1d35d, 0xb8b1d35d, - 0xb8b1d35d, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0xb926e559, 0xb926e559, - 0xb926e559, 0xb926e559, 0xb926e559, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, 0xbf7fff92, - 0x39d35a30, 0x39d35a30, 0x39d35a30, 0x39d35a30, 0x39d35a30, 0x3f7fffa0, 0x3f7fffa0, 0x3f7fffa0, - 0x3f7fffa0, 0x3f7fffa0, 0xba29a0d9, 0xba29a0d9, 0xba29a0d9, 0xba29a0d9, 0xba29a0d9, 0xbf7fffad, - 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0x3a69949a, 0x3a69949a, 0x3a69949a, 0x3a69949a, - 0x3a69949a, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0xba94c42d, 0xba94c42d, - 0xba94c42d, 0xba94c42d, 0xba94c42d, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, - 0x3ab4be0c, 0x3ab4be0c, 0x3ab4be0c, 0x3ab4be0c, 0x3ab4be0c, 0x3f7fffcf, 0x3f7fffcf, 0x3f7fffcf, - 0x3f7fffcf, 0x3f7fffcf, 0xbad4b7eb, 0xbad4b7eb, 0xbad4b7eb, 0xbad4b7eb, 0xbad4b7eb, 0xbf7fffd9, - 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0x3af4b1c9, 0x3af4b1c9, 0x3af4b1c9, 0x3af4b1c9, - 0x3af4b1c9, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0xbb0a55d3, 0xbb0a55d3, - 0xbb0a55d3, 0xbb0a55d3, 0xbb0a55d3, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, - 0x3b1a52c1, 0x3b1a52c1, 0x3b1a52c1, 0x3b1a52c1, 0x3b1a52c1, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0xbb2a4fae, 0xbb2a4fae, 0xbb2a4fae, 0xbb2a4fae, 0xbb2a4fae, 0xbf7ffff4, - 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b3a4c9a, 0x3b3a4c9a, 0x3b3a4c9a, 0x3b3a4c9a, -] )) ), - -################ chunk 14848 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47cbbcb9, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc93ec, 0x47cc93ec, - 0x47cc93ec, 0x47cc93ec, 0x47cc93ec, 0x47ccff85, 0x47ccff85, 0x47ccff85, 0x47ccff85, 0x47ccff85, - 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cdd6b8, 0x47cdd6b8, 0x47cdd6b8, - 0x47cdd6b8, 0x47cdd6b8, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ceadeb, - 0x47ceadeb, 0x47ceadeb, 0x47ceadeb, 0x47ceadeb, 0x47cf1985, 0x47cf1985, 0x47cf1985, 0x47cf1985, - 0x47cf1985, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cff0b7, 0x47cff0b7, - 0x47cff0b7, 0x47cff0b7, 0x47cff0b7, 0x47d05c51, 0x47d05c51, 0x47d05c51, 0x47d05c51, 0x47d05c51, - 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d13384, 0x47d13384, 0x47d13384, - 0x47d13384, 0x47d13384, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d20ab7, - 0x47d20ab7, 0x47d20ab7, 0x47d20ab7, 0x47d20ab7, 0x47d27650, 0x47d27650, 0x47d27650, 0x47d27650, - 0x47d27650, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d34d83, 0x47d34d83, - 0x47d34d83, 0x47d34d83, 0x47d34d83, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, - 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d49050, 0x47d49050, 0x47d49050, - 0x47d49050, 0x47d49050, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d56783, - 0x47d56783, 0x47d56783, 0x47d56783, 0x47d56783, 0x47d5d31c, 0x47d5d31c, 0x47d5d31c, 0x47d5d31c, - 0x47d5d31c, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d6aa4f, 0x47d6aa4f, - 0x47d6aa4f, 0x47d6aa4f, 0x47d6aa4f, 0x47d715e9, 0x47d715e9, 0x47d715e9, 0x47d715e9, 0x47d715e9, - 0x47d78182, 0x47d78182, 0x47d78182, 0x47d78182, 0x47d78182, 0x47d7ed1c, 0x47d7ed1c, 0x47d7ed1c, - 0x47d7ed1c, 0x47d7ed1c, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d8c44f, - 0x47d8c44f, 0x47d8c44f, 0x47d8c44f, 0x47d8c44f, 0x47d92fe8, 0x47d92fe8, 0x47d92fe8, 0x47d92fe8, - 0x47d92fe8, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47da071b, 0x47da071b, - 0x47da071b, 0x47da071b, 0x47da071b, 0x47da72b5, 0x47da72b5, 0x47da72b5, 0x47da72b5, 0x47da72b5, - 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47db49e8, 0x47db49e8, 0x47db49e8, - 0x47db49e8, 0x47db49e8, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dc211b, - 0x47dc211b, 0x47dc211b, 0x47dc211b, 0x47dc211b, 0x47dc8cb4, 0x47dc8cb4, 0x47dc8cb4, 0x47dc8cb4, - 0x47dc8cb4, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dd63e7, 0x47dd63e7, - 0x47dd63e7, 0x47dd63e7, 0x47dd63e7, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, - 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47dea6b3, 0x47dea6b3, 0x47dea6b3, - 0x47dea6b3, 0x47dea6b3, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df7de6, - 0x47df7de6, 0x47df7de6, 0x47df7de6, 0x47df7de6, 0x47dfe980, 0x47dfe980, 0x47dfe980, 0x47dfe980, - 0x47dfe980, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e0c0b3, 0x47e0c0b3, - 0x47e0c0b3, 0x47e0c0b3, 0x47e0c0b3, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3b3a4c9a, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0xbb4a4986, 0xbb4a4986, - 0xbb4a4986, 0xbb4a4986, 0xbb4a4986, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0x3b5a4671, 0x3b5a4671, 0x3b5a4671, 0x3b5a4671, 0x3b5a4671, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0xbb6a435c, 0xbb6a435c, 0xbb6a435c, 0xbb6a435c, 0xbb6a435c, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b7a4045, 0x3b7a4045, 0x3b7a4045, 0x3b7a4045, - 0x3b7a4045, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3b75c27d, 0x3b75c27d, - 0x3b75c27d, 0x3b75c27d, 0x3b75c27d, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0xbb65c593, 0xbb65c593, 0xbb65c593, 0xbb65c593, 0xbb65c593, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3b55c8a9, 0x3b55c8a9, 0x3b55c8a9, 0x3b55c8a9, 0x3b55c8a9, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb45cbbe, 0xbb45cbbe, 0xbb45cbbe, 0xbb45cbbe, - 0xbb45cbbe, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3b35ced1, 0x3b35ced1, - 0x3b35ced1, 0x3b35ced1, 0x3b35ced1, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, - 0xbb25d1e5, 0xbb25d1e5, 0xbb25d1e5, 0xbb25d1e5, 0xbb25d1e5, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3b15d4f7, 0x3b15d4f7, 0x3b15d4f7, 0x3b15d4f7, 0x3b15d4f7, 0xbf7fffe7, - 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbb05d809, 0xbb05d809, 0xbb05d809, 0xbb05d809, - 0xbb05d809, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3aebb635, 0x3aebb635, - 0x3aebb635, 0x3aebb635, 0x3aebb635, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, 0xbf7fffd6, - 0xbacbbc57, 0xbacbbc57, 0xbacbbc57, 0xbacbbc57, 0xbacbbc57, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3aabc279, 0x3aabc279, 0x3aabc279, 0x3aabc279, 0x3aabc279, 0xbf7fffc2, - 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xba8bc899, 0xba8bc899, 0xba8bc899, 0xba8bc899, - 0xba8bc899, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3f7fffb6, 0x3a579d72, 0x3a579d72, - 0x3a579d72, 0x3a579d72, 0x3a579d72, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, - 0xba17a9b1, 0xba17a9b1, 0xba17a9b1, 0xba17a9b1, 0xba17a9b1, 0x3f7fff9c, 0x3f7fff9c, 0x3f7fff9c, - 0x3f7fff9c, 0x3f7fff9c, 0x39af6bdf, 0x39af6bdf, 0x39af6bdf, 0x39af6bdf, 0x39af6bdf, 0xbf7fff8e, - 0xbf7fff8e, 0xbf7fff8e, 0xbf7fff8e, 0xbf7fff8e, 0xb8be116e, 0xb8be116e, 0xb8be116e, 0xb8be116e, - 0xb8be116e, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0xb920c651, 0xb920c651, - 0xb920c651, 0xb920c651, 0xb920c651, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, - 0x39d04aac, 0x39d04aac, 0x39d04aac, 0x39d04aac, 0x39d04aac, 0x3f7fffa0, 0x3f7fffa0, 0x3f7fffa0, - 0x3f7fffa0, 0x3f7fffa0, 0xba281917, 0xba281917, 0xba281917, 0xba281917, 0xba281917, 0xbf7fffad, - 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0x3a680cd8, 0x3a680cd8, 0x3a680cd8, 0x3a680cd8, - 0x3a680cd8, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0xba94004c, 0xba94004c, - 0xba94004c, 0xba94004c, 0xba94004c, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, -] )) ), - -################ chunk 15360 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e2037f, 0x47e2037f, 0x47e2037f, - 0x47e2037f, 0x47e2037f, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e2dab2, - 0x47e2dab2, 0x47e2dab2, 0x47e2dab2, 0x47e2dab2, 0x47e3464c, 0x47e3464c, 0x47e3464c, 0x47e3464c, - 0x47e3464c, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e41d7f, 0x47e41d7f, - 0x47e41d7f, 0x47e41d7f, 0x47e41d7f, 0x47e48918, 0x47e48918, 0x47e48918, 0x47e48918, 0x47e48918, - 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e5604b, 0x47e5604b, 0x47e5604b, - 0x47e5604b, 0x47e5604b, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e6377e, - 0x47e6377e, 0x47e6377e, 0x47e6377e, 0x47e6377e, 0x47e6a318, 0x47e6a318, 0x47e6a318, 0x47e6a318, - 0x47e6a318, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e77a4b, 0x47e77a4b, - 0x47e77a4b, 0x47e77a4b, 0x47e77a4b, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, - 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8bd17, 0x47e8bd17, 0x47e8bd17, - 0x47e8bd17, 0x47e8bd17, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e9944a, - 0x47e9944a, 0x47e9944a, 0x47e9944a, 0x47e9944a, 0x47e9ffe4, 0x47e9ffe4, 0x47e9ffe4, 0x47e9ffe4, - 0x47e9ffe4, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ead716, 0x47ead716, - 0x47ead716, 0x47ead716, 0x47ead716, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, - 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ec19e3, 0x47ec19e3, 0x47ec19e3, - 0x47ec19e3, 0x47ec19e3, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ecf116, - 0x47ecf116, 0x47ecf116, 0x47ecf116, 0x47ecf116, 0x47ed5caf, 0x47ed5caf, 0x47ed5caf, 0x47ed5caf, - 0x47ed5caf, 0x47edc849, 0x47edc849, 0x47edc849, 0x47edc849, 0x47edc849, 0x47ee33e2, 0x47ee33e2, - 0x47ee33e2, 0x47ee33e2, 0x47ee33e2, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, - 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef76af, 0x47ef76af, 0x47ef76af, - 0x47ef76af, 0x47ef76af, 0x47efe248, 0x47efe248, 0x47efe248, 0x47efe248, 0x47efe248, 0x47f04de2, - 0x47f04de2, 0x47f04de2, 0x47f04de2, 0x47f04de2, 0x47f0b97b, 0x47f0b97b, 0x47f0b97b, 0x47f0b97b, - 0x47f0b97b, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f190ae, 0x47f190ae, - 0x47f190ae, 0x47f190ae, 0x47f190ae, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, - 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f2d37b, 0x47f2d37b, 0x47f2d37b, - 0x47f2d37b, 0x47f2d37b, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f3aaae, - 0x47f3aaae, 0x47f3aaae, 0x47f3aaae, 0x47f3aaae, 0x47f41647, 0x47f41647, 0x47f41647, 0x47f41647, - 0x47f41647, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f4ed7a, 0x47f4ed7a, - 0x47f4ed7a, 0x47f4ed7a, 0x47f4ed7a, 0x47f55914, 0x47f55914, 0x47f55914, 0x47f55914, 0x47f55914, - 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f63047, 0x47f63047, 0x47f63047, - 0x47f63047, 0x47f63047, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f7077a, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3ab3fa2b, 0x3ab3fa2b, 0x3ab3fa2b, 0x3ab3fa2b, 0x3ab3fa2b, 0x3f7fffcf, 0x3f7fffcf, 0x3f7fffcf, - 0x3f7fffcf, 0x3f7fffcf, 0xbad3f40a, 0xbad3f40a, 0xbad3f40a, 0xbad3f40a, 0xbad3f40a, 0xbf7fffd9, - 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0xbf7fffd9, 0x3af3ede8, 0x3af3ede8, 0x3af3ede8, 0x3af3ede8, - 0x3af3ede8, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0xbb09f3e2, 0xbb09f3e2, - 0xbb09f3e2, 0xbb09f3e2, 0xbb09f3e2, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, - 0x3b19f0d0, 0x3b19f0d0, 0x3b19f0d0, 0x3b19f0d0, 0x3b19f0d0, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0xbb29edbd, 0xbb29edbd, 0xbb29edbd, 0xbb29edbd, 0xbb29edbd, 0xbf7ffff4, - 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b39eaaa, 0x3b39eaaa, 0x3b39eaaa, 0x3b39eaaa, - 0x3b39eaaa, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0xbb49e796, 0xbb49e796, - 0xbb49e796, 0xbb49e796, 0xbb49e796, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0x3b59e481, 0x3b59e481, 0x3b59e481, 0x3b59e481, 0x3b59e481, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0xbb69e16b, 0xbb69e16b, 0xbb69e16b, 0xbb69e16b, 0xbb69e16b, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b79de55, 0x3b79de55, 0x3b79de55, 0x3b79de55, - 0x3b79de55, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3b76246d, 0x3b76246d, - 0x3b76246d, 0x3b76246d, 0x3b76246d, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0xbb662784, 0xbb662784, 0xbb662784, 0xbb662784, 0xbb662784, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3b562a99, 0x3b562a99, 0x3b562a99, 0x3b562a99, 0x3b562a99, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbb462dae, 0xbb462dae, 0xbb462dae, 0xbb462dae, - 0xbb462dae, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3b3630c2, 0x3b3630c2, - 0x3b3630c2, 0x3b3630c2, 0x3b3630c2, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, - 0xbb2633d5, 0xbb2633d5, 0xbb2633d5, 0xbb2633d5, 0xbb2633d5, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3b1636e8, 0x3b1636e8, 0x3b1636e8, 0x3b1636e8, 0x3b1636e8, 0xbf7fffe7, - 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbb0639fa, 0xbb0639fa, 0xbb0639fa, 0xbb0639fa, - 0xbb0639fa, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3aec7a16, 0x3aec7a16, - 0x3aec7a16, 0x3aec7a16, 0x3aec7a16, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, - 0xbacc8038, 0xbacc8038, 0xbacc8038, 0xbacc8038, 0xbacc8038, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3aac865a, 0x3aac865a, 0x3aac865a, 0x3aac865a, 0x3aac865a, 0xbf7fffc2, - 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xbf7fffc2, 0xba8c8c7a, 0xba8c8c7a, 0xba8c8c7a, 0xba8c8c7a, - 0xba8c8c7a, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3a592534, 0x3a592534, - 0x3a592534, 0x3a592534, 0x3a592534, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, 0xbf7fffaa, - 0xba193173, 0xba193173, 0xba193173, 0xba193173, 0xba193173, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, - 0x3f7fff9d, 0x3f7fff9d, 0x39b27b63, 0x39b27b63, 0x39b27b63, 0x39b27b63, 0x39b27b63, 0xbf7fff8e, -] )) ), - -################ chunk 15872 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47f7077a, 0x47f7077a, 0x47f7077a, 0x47f7077a, 0x47f77313, 0x47f77313, 0x47f77313, 0x47f77313, - 0x47f77313, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f84a46, 0x47f84a46, - 0x47f84a46, 0x47f84a46, 0x47f84a46, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, - 0x47f92179, 0x47f92179, 0x47f92179, 0x47f92179, 0x47f92179, 0x47f98d12, 0x47f98d12, 0x47f98d12, - 0x47f98d12, 0x47f98d12, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47fa6445, - 0x47fa6445, 0x47fa6445, 0x47fa6445, 0x47fa6445, 0x47facfdf, 0x47facfdf, 0x47facfdf, 0x47facfdf, - 0x47facfdf, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fba712, 0x47fba712, - 0x47fba712, 0x47fba712, 0x47fba712, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, - 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fce9de, 0x47fce9de, 0x47fce9de, - 0x47fce9de, 0x47fce9de, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fdc111, - 0x47fdc111, 0x47fdc111, 0x47fdc111, 0x47fdc111, 0x47fe2cab, 0x47fe2cab, 0x47fe2cab, 0x47fe2cab, - 0x47fe2cab, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47ff03de, 0x47ff03de, - 0x47ff03de, 0x47ff03de, 0x47ff03de, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, - 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x48002355, 0x48002355, 0x48002355, - 0x48002355, 0x48002355, 0x48005922, 0x48005922, 0x48005922, 0x48005922, 0x48005922, 0x48008eef, - 0x48008eef, 0x48008eef, 0x48008eef, 0x48008eef, 0x4800c4bb, 0x4800c4bb, 0x4800c4bb, 0x4800c4bb, - 0x4800c4bb, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x48013055, 0x48013055, - 0x48013055, 0x48013055, 0x48013055, 0x48016622, 0x48016622, 0x48016622, 0x48016622, 0x48016622, - 0x48019bee, 0x48019bee, 0x48019bee, 0x48019bee, 0x48019bee, 0x4801d1bb, 0x4801d1bb, 0x4801d1bb, - 0x4801d1bb, 0x4801d1bb, 0x48020788, 0x48020788, 0x48020788, 0x48020788, 0x48020788, 0x48023d55, - 0x48023d55, 0x48023d55, 0x48023d55, 0x48023d55, 0x48027321, 0x48027321, 0x48027321, 0x48027321, - 0x48027321, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802debb, 0x4802debb, - 0x4802debb, 0x4802debb, 0x4802debb, 0x48031487, 0x48031487, 0x48031487, 0x48031487, 0x48031487, - 0x48034a54, 0x48034a54, 0x48034a54, 0x48034a54, 0x48034a54, 0x48038021, 0x48038021, 0x48038021, - 0x48038021, 0x48038021, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803ebba, - 0x4803ebba, 0x4803ebba, 0x4803ebba, 0x4803ebba, 0x48042187, 0x48042187, 0x48042187, 0x48042187, - 0x48042187, 0x48045754, 0x48045754, 0x48045754, 0x48045754, 0x48045754, 0x48048d21, 0x48048d21, - 0x48048d21, 0x48048d21, 0x48048d21, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, - 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x48052e87, 0x48052e87, 0x48052e87, - 0x48052e87, 0x48052e87, 0x48056454, 0x48056454, 0x48056454, 0x48056454, 0x48056454, 0x48059a20, - 0x48059a20, 0x48059a20, 0x48059a20, 0x48059a20, 0x4805cfed, 0x4805cfed, 0x4805cfed, 0x4805cfed, - 0x4805cfed, 0x480605ba, 0x480605ba, 0x480605ba, 0x480605ba, 0x480605ba, 0x48063b87, 0x48063b87, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbf7fff8e, 0xbf7fff8e, 0xbf7fff8e, 0xbf7fff8e, 0xb8ca4f7f, 0xb8ca4f7f, 0xb8ca4f7f, 0xb8ca4f7f, - 0xb8ca4f7f, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0x3f7fff82, 0xb91aa748, 0xb91aa748, - 0xb91aa748, 0xb91aa748, 0xb91aa748, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, - 0x39cd3b28, 0x39cd3b28, 0x39cd3b28, 0x39cd3b28, 0x39cd3b28, 0x3f7fff9f, 0x3f7fff9f, 0x3f7fff9f, - 0x3f7fff9f, 0x3f7fff9f, 0xba269155, 0xba269155, 0xba269155, 0xba269155, 0xba269155, 0xbf7fffad, - 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0x3a668516, 0x3a668516, 0x3a668516, 0x3a668516, - 0x3a668516, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0xba933c6b, 0xba933c6b, - 0xba933c6b, 0xba933c6b, 0xba933c6b, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, 0xbf7fffc5, - 0x3ab3364a, 0x3ab3364a, 0x3ab3364a, 0x3ab3364a, 0x3ab3364a, 0x3f7fffcf, 0x3f7fffcf, 0x3f7fffcf, - 0x3f7fffcf, 0x3f7fffcf, 0xbad33029, 0xbad33029, 0xbad33029, 0xbad33029, 0xbad33029, 0xbf7fffd8, - 0xbf7fffd8, 0xbf7fffd8, 0xbf7fffd8, 0xbf7fffd8, 0x3af32a07, 0x3af32a07, 0x3af32a07, 0x3af32a07, - 0x3af32a07, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0xbb0991f2, 0xbb0991f2, - 0xbb0991f2, 0xbb0991f2, 0xbb0991f2, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, - 0x3b198ee0, 0x3b198ee0, 0x3b198ee0, 0x3b198ee0, 0x3b198ee0, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0xbb298bcd, 0xbb298bcd, 0xbb298bcd, 0xbb298bcd, 0xbb298bcd, 0xbf7ffe91, - 0xbf7ffe91, 0xbf7ffe91, 0xbf7ffe91, 0xbf7ffe91, 0xbba33b6f, 0xbba33b6f, 0xbba33b6f, 0xbba33b6f, - 0xbba33b6f, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0xbb4985a5, 0xbb4985a5, - 0xbb4985a5, 0xbb4985a5, 0xbb4985a5, 0xbf7ffe59, 0xbf7ffe59, 0xbf7ffe59, 0xbf7ffe59, 0xbf7ffe59, - 0xbb933e8a, 0xbb933e8a, 0xbb933e8a, 0xbb933e8a, 0xbb933e8a, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0xbb697f7b, 0xbb697f7b, 0xbb697f7b, 0xbb697f7b, 0xbb697f7b, 0xbf7ffe1d, - 0xbf7ffe1d, 0xbf7ffe1d, 0xbf7ffe1d, 0xbf7ffe1d, 0xbb8341a3, 0xbb8341a3, 0xbb8341a3, 0xbb8341a3, - 0xbb8341a3, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xbb84bca6, 0xbb84bca6, - 0xbb84bca6, 0xbb84bca6, 0xbb84bca6, 0xbf7ffe22, 0xbf7ffe22, 0xbf7ffe22, 0xbf7ffe22, 0xbf7ffe22, - 0xbb668974, 0xbb668974, 0xbb668974, 0xbb668974, 0xbb668974, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0xbb94b98d, 0xbb94b98d, 0xbb94b98d, 0xbb94b98d, 0xbb94b98d, 0xbf7ffe5e, - 0xbf7ffe5e, 0xbf7ffe5e, 0xbf7ffe5e, 0xbf7ffe5e, 0xbb468f9e, 0xbb468f9e, 0xbb468f9e, 0xbb468f9e, - 0xbb468f9e, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0xbba4b672, 0xbba4b672, - 0xbba4b672, 0xbba4b672, 0xbba4b672, 0xbf7ffe96, 0xbf7ffe96, 0xbf7ffe96, 0xbf7ffe96, 0xbf7ffe96, - 0xbb2695c6, 0xbb2695c6, 0xbb2695c6, 0xbb2695c6, 0xbb2695c6, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0xbbb4b354, 0xbbb4b354, 0xbbb4b354, 0xbbb4b354, 0xbbb4b354, 0xbf7ffeca, - 0xbf7ffeca, 0xbf7ffeca, 0xbf7ffeca, 0xbf7ffeca, 0xbb069bea, 0xbb069bea, 0xbb069bea, 0xbb069bea, - 0xbb069bea, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0x3f7fffdf, 0xbbc4b033, 0xbbc4b033, -] )) ), - -################ chunk 16384 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x48063b87, 0x48063b87, 0x48063b87, 0x48067153, 0x48067153, 0x48067153, 0x48067153, 0x48067153, - 0x4806a720, 0x4806a720, 0x4806a720, 0x4806a720, 0x4806a720, 0x4806dced, 0x4806dced, 0x4806dced, - 0x4806dced, 0x4806dced, 0x480712ba, 0x480712ba, 0x480712ba, 0x480712ba, 0x480712ba, 0x48074886, - 0x48074886, 0x48074886, 0x48074886, 0x48074886, 0x48077e53, 0x48077e53, 0x48077e53, 0x48077e53, - 0x48077e53, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807e9ed, 0x4807e9ed, - 0x4807e9ed, 0x4807e9ed, 0x4807e9ed, 0x48081fb9, 0x48081fb9, 0x48081fb9, 0x48081fb9, 0x48081fb9, - 0x48085586, 0x48085586, 0x48085586, 0x48085586, 0x48085586, 0x48088b53, 0x48088b53, 0x48088b53, - 0x48088b53, 0x48088b53, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808f6ec, - 0x4808f6ec, 0x4808f6ec, 0x4808f6ec, 0x4808f6ec, 0x48092cb9, 0x48092cb9, 0x48092cb9, 0x48092cb9, - 0x48092cb9, 0x48096286, 0x48096286, 0x48096286, 0x48096286, 0x48096286, 0x48099852, 0x48099852, - 0x48099852, 0x48099852, 0x48099852, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, - 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a39b9, 0x480a39b9, 0x480a39b9, - 0x480a39b9, 0x480a39b9, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480aa552, - 0x480aa552, 0x480aa552, 0x480aa552, 0x480aa552, 0x480adb1f, 0x480adb1f, 0x480adb1f, 0x480adb1f, - 0x480adb1f, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b46b8, 0x480b46b8, - 0x480b46b8, 0x480b46b8, 0x480b46b8, 0x480b7c85, 0x480b7c85, 0x480b7c85, 0x480b7c85, 0x480b7c85, - 0x480bb252, 0x480bb252, 0x480bb252, 0x480bb252, 0x480bb252, 0x480be81f, 0x480be81f, 0x480be81f, - 0x480be81f, 0x480be81f, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c53b8, - 0x480c53b8, 0x480c53b8, 0x480c53b8, 0x480c53b8, 0x480c8985, 0x480c8985, 0x480c8985, 0x480c8985, - 0x480c8985, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cf51e, 0x480cf51e, - 0x480cf51e, 0x480cf51e, 0x480cf51e, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, - 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d9685, 0x480d9685, 0x480d9685, - 0x480d9685, 0x480d9685, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480e021e, - 0x480e021e, 0x480e021e, 0x480e021e, 0x480e021e, 0x480e37eb, 0x480e37eb, 0x480e37eb, 0x480e37eb, - 0x480e37eb, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480ea384, 0x480ea384, - 0x480ea384, 0x480ea384, 0x480ea384, 0x480ed951, 0x480ed951, 0x480ed951, 0x480ed951, 0x480ed951, - 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f44eb, 0x480f44eb, 0x480f44eb, - 0x480f44eb, 0x480f44eb, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480fb084, - 0x480fb084, 0x480fb084, 0x480fb084, 0x480fb084, 0x480fe651, 0x480fe651, 0x480fe651, 0x480fe651, - 0x480fe651, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x481051ea, 0x481051ea, - 0x481051ea, 0x481051ea, 0x481051ea, 0x481087b7, 0x481087b7, 0x481087b7, 0x481087b7, 0x481087b7, - 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810f350, 0x4810f350, 0x4810f350, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbbc4b033, 0xbbc4b033, 0xbbc4b033, 0xbf7ffef9, 0xbf7ffef9, 0xbf7ffef9, 0xbf7ffef9, 0xbf7ffef9, - 0xbacd4419, 0xbacd4419, 0xbacd4419, 0xbacd4419, 0xbacd4419, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0xbbd4ad0f, 0xbbd4ad0f, 0xbbd4ad0f, 0xbbd4ad0f, 0xbbd4ad0f, 0xbf7fff25, - 0xbf7fff25, 0xbf7fff25, 0xbf7fff25, 0xbf7fff25, 0xba8d505b, 0xba8d505b, 0xba8d505b, 0xba8d505b, - 0xba8d505b, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0x3f7fffb7, 0xbbe4a9e7, 0xbbe4a9e7, - 0xbbe4a9e7, 0xbbe4a9e7, 0xbbe4a9e7, 0xbf7fff4d, 0xbf7fff4d, 0xbf7fff4d, 0xbf7fff4d, 0xbf7fff4d, - 0xba1ab935, 0xba1ab935, 0xba1ab935, 0xba1ab935, 0xba1ab935, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, - 0x3f7fff9d, 0x3f7fff9d, 0xbbf4a6bd, 0xbbf4a6bd, 0xbbf4a6bd, 0xbbf4a6bd, 0xbbf4a6bd, 0xbf7fff71, - 0xbf7fff71, 0xbf7fff71, 0xbf7fff71, 0xbf7fff71, 0xb8d68d90, 0xb8d68d90, 0xb8d68d90, 0xb8d68d90, - 0xb8d68d90, 0x3f7fff7f, 0x3f7fff7f, 0x3f7fff7f, 0x3f7fff7f, 0x3f7fff7f, 0x3bfb5b1c, 0x3bfb5b1c, - 0x3bfb5b1c, 0x3bfb5b1c, 0x3bfb5b1c, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, 0xbf7fff91, - 0x39ca2ba3, 0x39ca2ba3, 0x39ca2ba3, 0x39ca2ba3, 0x39ca2ba3, 0x3f7fff5d, 0x3f7fff5d, 0x3f7fff5d, - 0x3f7fff5d, 0x3f7fff5d, 0x3beb5e49, 0x3beb5e49, 0x3beb5e49, 0x3beb5e49, 0x3beb5e49, 0xbf7fffad, - 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0xbf7fffad, 0x3a64fd54, 0x3a64fd54, 0x3a64fd54, 0x3a64fd54, - 0x3a64fd54, 0x3f7fff36, 0x3f7fff36, 0x3f7fff36, 0x3f7fff36, 0x3f7fff36, 0x3bdb6172, 0x3bdb6172, - 0x3bdb6172, 0x3bdb6172, 0x3bdb6172, 0xbf7fffc4, 0xbf7fffc4, 0xbf7fffc4, 0xbf7fffc4, 0xbf7fffc4, - 0x3ab27269, 0x3ab27269, 0x3ab27269, 0x3ab27269, 0x3ab27269, 0x3f7fff0c, 0x3f7fff0c, 0x3f7fff0c, - 0x3f7fff0c, 0x3f7fff0c, 0x3bcb6497, 0x3bcb6497, 0x3bcb6497, 0x3bcb6497, 0x3bcb6497, 0xbf7fffd8, - 0xbf7fffd8, 0xbf7fffd8, 0xbf7fffd8, 0xbf7fffd8, 0x3af26626, 0x3af26626, 0x3af26626, 0x3af26626, - 0x3af26626, 0x3f7ffede, 0x3f7ffede, 0x3f7ffede, 0x3f7ffede, 0x3f7ffede, 0x3bbb67b9, 0x3bbb67b9, - 0x3bbb67b9, 0x3bbb67b9, 0x3bbb67b9, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, 0xbf7fffe8, - 0x3b192cef, 0x3b192cef, 0x3b192cef, 0x3b192cef, 0x3b192cef, 0x3f7ffeac, 0x3f7ffeac, 0x3f7ffeac, - 0x3f7ffeac, 0x3f7ffeac, 0x3bab6ad8, 0x3bab6ad8, 0x3bab6ad8, 0x3bab6ad8, 0x3bab6ad8, 0xbf7ffff4, - 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0xbf7ffff4, 0x3b3926c9, 0x3b3926c9, 0x3b3926c9, 0x3b3926c9, - 0x3b3926c9, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3b9b6df5, 0x3b9b6df5, - 0x3b9b6df5, 0x3b9b6df5, 0x3b9b6df5, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, - 0x3b5920a0, 0x3b5920a0, 0x3b5920a0, 0x3b5920a0, 0x3b5920a0, 0x3f7ffe3c, 0x3f7ffe3c, 0x3f7ffe3c, - 0x3f7ffe3c, 0x3f7ffe3c, 0x3b8b710f, 0x3b8b710f, 0x3b8b710f, 0x3b8b710f, 0x3b8b710f, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x3b791a74, 0x3b791a74, 0x3b791a74, 0x3b791a74, - 0x3b791a74, 0x3f7ffe02, 0x3f7ffe02, 0x3f7ffe02, 0x3f7ffe02, 0x3f7ffe02, 0x3b76e84e, 0x3b76e84e, - 0x3b76e84e, 0x3b76e84e, 0x3b76e84e, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, - 0x3b8c8a22, 0x3b8c8a22, 0x3b8c8a22, 0x3b8c8a22, 0x3b8c8a22, 0x3f7ffe40, 0x3f7ffe40, 0x3f7ffe40, -] )) ), - -################ chunk 16896 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4810f350, 0x4810f350, 0x4811291d, 0x4811291d, 0x4811291d, 0x4811291d, 0x4811291d, 0x48115eea, - 0x48115eea, 0x48115eea, 0x48115eea, 0x48115eea, 0x481194b7, 0x481194b7, 0x481194b7, 0x481194b7, - 0x481194b7, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x48120050, 0x48120050, - 0x48120050, 0x48120050, 0x48120050, 0x4812361d, 0x4812361d, 0x4812361d, 0x4812361d, 0x4812361d, - 0x48126bea, 0x48126bea, 0x48126bea, 0x48126bea, 0x48126bea, 0x4812a1b6, 0x4812a1b6, 0x4812a1b6, - 0x4812a1b6, 0x4812a1b6, 0x4812d783, 0x4812d783, 0x4812d783, 0x4812d783, 0x4812d783, 0x48130d50, - 0x48130d50, 0x48130d50, 0x48130d50, 0x48130d50, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, - 0x4813431d, 0x481378e9, 0x481378e9, 0x481378e9, 0x481378e9, 0x481378e9, 0x4813aeb6, 0x4813aeb6, - 0x4813aeb6, 0x4813aeb6, 0x4813aeb6, 0x4813e483, 0x4813e483, 0x4813e483, 0x4813e483, 0x4813e483, - 0x48141a50, 0x48141a50, 0x48141a50, 0x48141a50, 0x48141a50, 0x4814501c, 0x4814501c, 0x4814501c, - 0x4814501c, 0x4814501c, 0x481485e9, 0x481485e9, 0x481485e9, 0x481485e9, 0x481485e9, 0x4814bbb6, - 0x4814bbb6, 0x4814bbb6, 0x4814bbb6, 0x4814bbb6, 0x4814f183, 0x4814f183, 0x4814f183, 0x4814f183, - 0x4814f183, 0x4815274f, 0x4815274f, 0x4815274f, 0x4815274f, 0x4815274f, 0x48155d1c, 0x48155d1c, - 0x48155d1c, 0x48155d1c, 0x48155d1c, 0x481592e9, 0x481592e9, 0x481592e9, 0x481592e9, 0x481592e9, - 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815fe82, 0x4815fe82, 0x4815fe82, - 0x4815fe82, 0x4815fe82, 0x4816344f, 0x4816344f, 0x4816344f, 0x4816344f, 0x4816344f, 0x48166a1c, - 0x48166a1c, 0x48166a1c, 0x48166a1c, 0x48166a1c, 0x48169fe9, 0x48169fe9, 0x48169fe9, 0x48169fe9, - 0x48169fe9, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x48170b82, 0x48170b82, - 0x48170b82, 0x48170b82, 0x48170b82, 0x4817414f, 0x4817414f, 0x4817414f, 0x4817414f, 0x4817414f, - 0x4817771b, 0x4817771b, 0x4817771b, 0x4817771b, 0x4817771b, 0x4817ace8, 0x4817ace8, 0x4817ace8, - 0x4817ace8, 0x4817ace8, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x48181882, - 0x48181882, 0x48181882, 0x48181882, 0x48181882, 0x48184e4e, 0x48184e4e, 0x48184e4e, 0x48184e4e, - 0x48184e4e, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818b9e8, 0x4818b9e8, - 0x4818b9e8, 0x4818b9e8, 0x4818b9e8, 0x4818efb5, 0x4818efb5, 0x4818efb5, 0x4818efb5, 0x4818efb5, - 0x48192581, 0x48192581, 0x48192581, 0x48192581, 0x48192581, 0x48195b4e, 0x48195b4e, 0x48195b4e, - 0x48195b4e, 0x48195b4e, 0x44800000, 0x44802000, 0x447fc000, 0x44801000, 0x447fe000, 0x45000000, - 0x45001000, 0x44ffe000, 0x45000800, 0x44fff000, 0x45800000, 0x45800800, 0x457ff000, 0x45800400, - 0x457ff800, 0x46000000, 0x46000400, 0x45fff800, 0x46000200, 0x45fffc00, 0x46800000, 0x46800200, - 0x467ffc00, 0x46800100, 0x467ffe00, 0x47000000, 0x47000100, 0x46fffe00, 0x47000080, 0x46ffff00, - 0x47800000, 0x47800080, 0x477fff00, 0x47800040, 0x477fff80, 0x48000000, 0x48000040, 0x47ffff80, - 0x48000020, 0x47ffffc0, 0x48800000, 0x48800020, 0x487fffc0, 0x48800010, 0x487fffe0, 0x49000000, - 0x49000010, 0x48ffffe0, 0x49000008, 0x48fffff0, 0x49800000, 0x49800008, 0x497ffff0, 0x49800004, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffe40, 0x3f7ffe40, 0x3b56ee7a, 0x3b56ee7a, 0x3b56ee7a, 0x3b56ee7a, 0x3b56ee7a, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3b9c8708, 0x3b9c8708, 0x3b9c8708, 0x3b9c8708, - 0x3b9c8708, 0x3f7ffe7a, 0x3f7ffe7a, 0x3f7ffe7a, 0x3f7ffe7a, 0x3f7ffe7a, 0x3b36f4a3, 0x3b36f4a3, - 0x3b36f4a3, 0x3b36f4a3, 0x3b36f4a3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, 0xbf7ffff3, - 0x3bac83eb, 0x3bac83eb, 0x3bac83eb, 0x3bac83eb, 0x3bac83eb, 0x3f7ffeb0, 0x3f7ffeb0, 0x3f7ffeb0, - 0x3f7ffeb0, 0x3f7ffeb0, 0x3b16fac9, 0x3b16fac9, 0x3b16fac9, 0x3b16fac9, 0x3b16fac9, 0xbf7fffe7, - 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0xbf7fffe7, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, 0x3bbc80cb, - 0x3bbc80cb, 0x3f7ffee2, 0x3f7ffee2, 0x3f7ffee2, 0x3f7ffee2, 0x3f7ffee2, 0x3aee01d8, 0x3aee01d8, - 0x3aee01d8, 0x3aee01d8, 0x3aee01d8, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, 0xbf7fffd7, - 0x3bcc7da9, 0x3bcc7da9, 0x3bcc7da9, 0x3bcc7da9, 0x3bcc7da9, 0x3f7fff0f, 0x3f7fff0f, 0x3f7fff0f, - 0x3f7fff0f, 0x3f7fff0f, 0x3aae0e1c, 0x3aae0e1c, 0x3aae0e1c, 0x3aae0e1c, 0x3aae0e1c, 0xbf7fffc3, - 0xbf7fffc3, 0xbf7fffc3, 0xbf7fffc3, 0xbf7fffc3, 0x3bdc7a83, 0x3bdc7a83, 0x3bdc7a83, 0x3bdc7a83, - 0x3bdc7a83, 0x3f7fff39, 0x3f7fff39, 0x3f7fff39, 0x3f7fff39, 0x3f7fff39, 0x3a5c34b8, 0x3a5c34b8, - 0x3a5c34b8, 0x3a5c34b8, 0x3a5c34b8, 0xbf7fffab, 0xbf7fffab, 0xbf7fffab, 0xbf7fffab, 0xbf7fffab, - 0x3bec775a, 0x3bec775a, 0x3bec775a, 0x3bec775a, 0x3bec775a, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, - 0x3f7fff5f, 0x3f7fff5f, 0x39b89a6c, 0x39b89a6c, 0x39b89a6c, 0x39b89a6c, 0x39b89a6c, 0xbf7fff8f, - 0xbf7fff8f, 0xbf7fff8f, 0xbf7fff8f, 0xbf7fff8f, 0x3bfc742e, 0x3bfc742e, 0x3bfc742e, 0x3bfc742e, - 0x3bfc742e, 0x3f7fff81, 0x3f7fff81, 0x3f7fff81, 0x3f7fff81, 0x3f7fff81, 0xb90e6937, 0xb90e6937, - 0xb90e6937, 0xb90e6937, 0xb90e6937, 0xbf7fff6f, 0xbf7fff6f, 0xbf7fff6f, 0xbf7fff6f, 0xbf7fff6f, - 0xbbf38dab, 0xbbf38dab, 0xbbf38dab, 0xbbf38dab, 0xbbf38dab, 0x3f7fff9f, 0x3f7fff9f, 0x3f7fff9f, - 0x3f7fff9f, 0x3f7fff9f, 0xba2381d1, 0xba2381d1, 0xba2381d1, 0xba2381d1, 0xba2381d1, 0xbf7fff4a, - 0xbf7fff4a, 0xbf7fff4a, 0xbf7fff4a, 0xbf7fff4a, 0xbbe390d6, 0xbbe390d6, 0xbbe390d6, 0xbbe390d6, - 0xbbe390d6, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0x3f7fffb9, 0xba91b4a9, 0xba91b4a9, - 0xba91b4a9, 0xba91b4a9, 0xba91b4a9, 0xbf7fff22, 0xbf7fff22, 0xbf7fff22, 0xbf7fff22, 0xbf7fff22, - 0xbbd393fd, 0xbbd393fd, 0xbbd393fd, 0xbbd393fd, 0xbbd393fd, 0x3f7fffcf, 0x3f7fffcf, 0x3f7fffcf, - 0x3f7fffcf, 0x3f7fffcf, 0xbe225693, 0x3f3ec3b0, 0xbf6a9ec9, 0x3eab2109, 0xbf1ccc0f, 0xbea04902, - 0x3f21498c, 0xbf77e3c6, 0x3e38ed82, 0xbf3ae53b, 0xbf183a75, 0x3eb5e31c, 0xbf7f7136, 0xbe0baad1, - 0xbf6844e2, 0xbf74c7c4, 0xbe8a5cae, 0xbf43546a, 0xbf32e0e7, 0xbf7ac05a, 0xbf0f5821, 0xbf7fede2, - 0x3eca0fc1, 0xbf637c1f, 0xbdc0dd22, 0x3f6d87fe, 0x3f50acf8, 0x3e4001b8, 0x3f7e399a, 0x3f22ae77, - 0x3f312b34, 0xbe6f14f9, 0x3f7b3848, 0x3e85c64e, 0x3f7412b7, 0xbf7fc5ec, 0xbf0120b4, 0xbf13430a, - 0xbf5b4bce, 0xbf65a0c3, 0xbdac404e, 0xbf624969, 0x3f4b0513, 0xbf0d3193, 0x3ecece12, 0x3e2ba40f, - 0x3f6b8da8, 0xbf3d2f33, 0x3f1ea75e, 0xbea6adb3, 0x3ea93666, 0x3f790661, 0xbf1d9959, 0x3f3e15d9, -] )) ), - -################ chunk 17408 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x497ffff8, 0x4a000000, 0x4a000004, 0x49fffff8, 0x4a000002, 0x49fffffc, 0x4a800000, 0x4a800002, - 0x4a7ffffc, 0x4a800001, 0x4a7ffffe, 0x4b000000, 0x4b000001, 0x4afffffe, 0x4b000000, 0x4affffff, - 0x4b800000, 0x4b800000, 0x4b7fffff, 0x4b800000, 0x4b800000, 0x4c000000, 0x4c000000, 0x4c000000, - 0x4c000000, 0x4c000000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4d000000, - 0x4d000000, 0x4d000000, 0x4d000000, 0x4d000000, 0x4d800000, 0x4d800000, 0x4d800000, 0x4d800000, - 0x4d800000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e800000, 0x4e800000, - 0x4e800000, 0x4e800000, 0x4e800000, 0x4f000000, 0x4f000000, 0x4f000000, 0x4f000000, 0x4f000000, - 0x4f800000, 0x4f800000, 0x4f800000, 0x4f800000, 0x4f800000, 0x50000000, 0x50000000, 0x50000000, - 0x50000000, 0x50000000, 0x50800000, 0x50800000, 0x50800000, 0x50800000, 0x50800000, 0x51000000, - 0x51000000, 0x51000000, 0x51000000, 0x51000000, 0x51800000, 0x51800000, 0x51800000, 0x51800000, - 0x51800000, 0x52000000, 0x52000000, 0x52000000, 0x52000000, 0x52000000, 0x52800000, 0x52800000, - 0x52800000, 0x52800000, 0x52800000, 0x53000000, 0x53000000, 0x53000000, 0x53000000, 0x53000000, - 0x53800000, 0x53800000, 0x53800000, 0x53800000, 0x53800000, 0x54000000, 0x54000000, 0x54000000, - 0x54000000, 0x54000000, 0x54800000, 0x54800000, 0x54800000, 0x54800000, 0x54800000, 0x55000000, - 0x55000000, 0x55000000, 0x55000000, 0x55000000, 0x55800000, 0x55800000, 0x55800000, 0x55800000, - 0x55800000, 0x56000000, 0x56000000, 0x56000000, 0x56000000, 0x56000000, 0x56800000, 0x56800000, - 0x56800000, 0x56800000, 0x56800000, 0x57000000, 0x57000000, 0x57000000, 0x57000000, 0x57000000, - 0x57800000, 0x57800000, 0x57800000, 0x57800000, 0x57800000, 0x58000000, 0x58000000, 0x58000000, - 0x58000000, 0x58000000, 0x58800000, 0x58800000, 0x58800000, 0x58800000, 0x58800000, 0x447a0000, - 0x44898000, 0x44610000, 0x447a4000, 0x4479c000, 0x461c4000, 0x462be000, 0x460ca000, 0x461c4400, - 0x461c3c00, 0x47c35000, 0x47d6d800, 0x47afc800, 0x47c35080, 0x47c34f80, 0x49742400, 0x49864700, - 0x495bba00, 0x49742410, 0x497423f0, 0x4b189680, 0x4b27d8c0, 0x4b095440, 0x4b189681, 0x4b18967f, - 0x4cbebc20, 0x4cd1cef0, 0x4caba950, 0x4cbebc20, 0x4cbebc20, 0x4e6e6b28, 0x4e832156, 0x4e5693a4, - 0x4e6e6b28, 0x4e6e6b28, 0x501502f9, 0x5023e9ac, 0x50061c46, 0x501502f9, 0x501502f9, 0x51ba43b7, - 0x51cce416, 0x51a7a358, 0x51ba43b7, 0x51ba43b7, 0x5368d4a5, 0x53800e8e, 0x53518c2e, 0x5368d4a5, - 0x5368d4a5, 0x551184e7, 0x55201231, 0x5502f79d, 0x551184e7, 0x551184e7, 0x56b5e621, 0x56c816be, - 0x56a3b584, 0x56b5e621, 0x56b5e621, 0x58635fa9, 0x587a1c6d, 0x584ca2e5, 0x58635fa9, 0x58635fa9, - 0x5a0e1bca, 0x5a1c51c4, 0x59ffcb9e, 0x5a0e1bca, 0x5a0e1bca, 0x5bb1a2bc, 0x5bc36635, 0x5b9fdf43, - 0x5bb1a2bc, 0x5bb1a2bc, 0x5d5e0b6b, 0x5d743fc3, 0x5d47d714, 0x5d5e0b6b, 0x5d5e0b6b, 0x44fa0000, - 0x469c4000, 0x453b8000, 0x46ea6000, 0x459c4000, 0x47435000, 0x45fa0000, 0x479c4000, 0x464b2000, - 0x47fde800, 0x46a41000, 0x484d1400, 0x4704d000, 0x48a60400, 0x4756d800, 0x49064700, 0x47add400, - 0x49594900, 0x480ca000, 0x49afc800, 0x48638a00, 0x4a0e3640, 0x48b81500, 0x4a661a40, 0x4914ed00, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbe265983, 0x3f1fb444, 0x3f7ea5a5, 0xbea423d5, 0x3f6c134a, 0x3e30ed67, 0x3f79a214, 0x3f369f1a, - 0x3eae4435, 0x3f764698, 0x3f3fdf21, 0x3edd4fa3, 0xbf067728, 0x3f7e0a54, 0x3edd4fa3, 0x3f4fc8cd, - 0xbf47917c, 0xbf47917c, 0xbf72bf60, 0xbf47917c, 0xbf47917c, 0xbf79fd0a, 0xbf79fd0a, 0xbf79fd0a, - 0xbf79fd0a, 0xbf79fd0a, 0x3ed76dd7, 0x3ed76dd7, 0x3ed76dd7, 0x3ed76dd7, 0x3ed76dd7, 0xbf436e65, - 0xbf436e65, 0xbf436e65, 0xbf436e65, 0xbf436e65, 0xbf7c777c, 0xbf7c777c, 0xbf7c777c, 0xbf7c777c, - 0xbf7c777c, 0x3ea733e0, 0x3ea733e0, 0x3ea733e0, 0x3ea733e0, 0x3ea733e0, 0xbf1e091b, 0xbf1e091b, - 0xbf1e091b, 0xbf1e091b, 0xbf1e091b, 0xbf78a7c9, 0xbf78a7c9, 0xbf78a7c9, 0xbf78a7c9, 0xbf78a7c9, - 0xbeec8981, 0xbeec8981, 0xbeec8981, 0xbeec8981, 0xbeec8981, 0x3f51c81c, 0x3f51c81c, 0x3f51c81c, - 0x3f51c81c, 0x3f51c81c, 0x3f70779b, 0x3f70779b, 0x3f70779b, 0x3f70779b, 0x3f70779b, 0xbf24f963, - 0xbf24f963, 0xbf24f963, 0xbf24f963, 0xbf24f963, 0x3f7c4c9e, 0x3f7c4c9e, 0x3f7c4c9e, 0x3f7c4c9e, - 0x3f7c4c9e, 0x3eaafa2b, 0x3eaafa2b, 0x3eaafa2b, 0x3eaafa2b, 0x3eaafa2b, 0xbf212984, 0xbf212984, - 0xbf212984, 0xbf212984, 0xbf212984, 0xbf7a6f90, 0xbf7a6f90, 0xbf7a6f90, 0xbf7a6f90, 0xbf7a6f90, - 0xbecfb891, 0xbecfb891, 0xbecfb891, 0xbecfb891, 0xbecfb891, 0x3f3ddb99, 0x3f3ddb99, 0x3f3ddb99, - 0x3f3ddb99, 0x3f3ddb99, 0x3f7eb742, 0x3f7eb742, 0x3f7eb742, 0x3f7eb742, 0x3f7eb742, 0xbe4bd8b6, - 0xbe4bd8b6, 0xbe4bd8b6, 0xbe4bd8b6, 0xbe4bd8b6, 0x3ec7c443, 0x3ec7c443, 0x3ec7c443, 0x3ec7c443, - 0x3ec7c443, 0x3f37ef0c, 0x3f37ef0c, 0x3f37ef0c, 0x3f37ef0c, 0x3f37ef0c, 0x3f7fdd77, 0x3f7fdd77, - 0x3f7fdd77, 0x3f7fdd77, 0x3f7fdd77, 0xbd84e24a, 0xbd84e24a, 0xbd84e24a, 0xbd84e24a, 0xbd84e24a, - 0x3e049a9b, 0x3e049a9b, 0x3e049a9b, 0x3e049a9b, 0x3e049a9b, 0x3e837cc6, 0x3e837cc6, 0x3e837cc6, - 0x3e837cc6, 0x3e837cc6, 0x3efe27af, 0x3efe27af, 0x3efe27af, 0x3efe27af, 0x3efe27af, 0x3f53ae61, - 0x3edb4578, 0x3f7f7009, 0x3f6b8481, 0xbcd8c438, 0xbe9c797d, 0xbf758d68, 0x3f1d8de9, 0xbf7761c0, - 0x3f22d698, 0x3d126d55, 0x3e8af267, 0xbeadcd5e, 0xbf52558e, 0x3f5c393b, 0xbeb33259, 0x3ec43a55, - 0x3ea1efb8, 0x3f1961ba, 0xbf7a33be, 0x3ed7520a, 0x3f362410, 0x3d9c7d01, 0xbf0945a2, 0x3f7d9c33, - 0x3f6e7fe5, 0xbf7f8178, 0xbf3142f1, 0x3f6e7fe5, 0x3f6e7fe5, 0x3f0bbc65, 0x3f150ecc, 0xbf7a9d1c, - 0x3f0bbc65, 0x3f0bbc65, 0xbef99a64, 0x3c3b662d, 0x3f5861fe, 0xbef99a64, 0xbef99a64, 0x3f7f840e, - 0x3f6aa031, 0x3f756b3e, 0x3f7f840e, 0x3f7f840e, 0xbcaa6b01, 0x3e5a4eb1, 0xbe81de03, 0xbcaa6b01, - 0xbcaa6b01, 0x3f78083e, 0x3f6adda3, 0x3f1d3928, 0x3f78083e, 0x3f78083e, 0x3f77970f, 0x3e2d9996, - 0xbeac88f4, 0x3f77970f, 0x3f77970f, 0x3f7e933f, 0x3daca466, 0x3e951b6a, 0x3f7e933f, 0x3f7e933f, - 0xbefe3f08, 0x3f7d6eb1, 0xbf5eb4af, 0xbefe3f08, 0xbefe3f08, 0xbf11e9aa, 0xbf7cff7f, 0x3e5002fc, - 0xbf11e9aa, 0xbf11e9aa, 0xbe5df089, 0x3f62c5b2, 0xbdfea72c, 0xbe5df089, 0xbe5df089, 0x3f6e1712, - 0x3f14fcf4, 0x3e607356, 0xbf4d7b7b, 0xbf7ceb5e, 0xbf7ff587, 0x3f7f72a4, 0x3f1c55c4, 0x3db74116, - 0x3f47e486, 0x3f7fed46, 0xbe727baf, 0x3f7e5a47, 0xbf68146e, 0xbe0c44e5, 0x3f7b10c5, 0xbf77fbb3, - 0xbf1750b7, 0x3f6cf046, 0x3f2cf280, 0x3f18ba91, 0x3ddf826b, 0x3f04529c, 0x3f40835f, 0xbdc465ec, -] )) ), - -################ chunk 17920 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4aba2840, 0x4970f780, 0x4b169ab0, 0x49c2f240, 0x4b73aed0, 0x4a1db700, 0x4bc524c0, 0x4a7f3020, - 0x4c1f7e14, 0x4ace7390, 0x4c81083a, 0x4b2705d0, 0x4cd0c744, 0x47c54400, 0x49769500, 0x4b1a1d20, - 0x439ea683, 0x431ea683, 0x47c92c00, 0x497b7700, 0x4b1d2a60, 0x43a1cac2, 0x4321cac2, 0x47d0fc00, - 0x49829d80, 0x4b2344e0, 0x43a81341, 0x43281341, 0x47d4e400, 0x49850e80, 0x4b265220, 0x43ab3780, - 0x432b3780, 0x47dcb400, 0x4989f080, 0x4b2c6ca0, 0x43b17fff, 0x43317fff, 0x47f80c00, 0x499b0780, - 0x4b41c960, 0x43c77dbb, 0x43477dbb, 0x47ffdc00, 0x499fe980, 0x4b47e3e0, 0x43cdc63a, 0x434dc63a, - 0x4805ca00, 0x49a73c80, 0x4b510ba0, 0x43d732f8, 0x435732f8, 0x4807be00, 0x49a9ad80, 0x4b5418e0, - 0x43da5737, 0x435a5737, 0x48118200, 0x49b5e280, 0x4b635b20, 0x43ea0c75, 0x436a0c75, 0x48137600, - 0x49b85380, 0x4b666860, 0x43ed30b4, 0x436d30b4, 0x48195200, 0x49bfa680, 0x4b6f9020, 0x43f69d72, - 0x43769d72, 0x481f2e00, 0x49c6f980, 0x4b78b7e0, 0x44000518, 0x43800518, 0x48231600, 0x49cbdb80, - 0x4b7ed260, 0x44032958, 0x43832958, 0x4828f200, 0x49d32e80, 0x4b83fd10, 0x4407dfb7, 0x4387dfb7, - 0x482ece00, 0x49da8180, 0x4b8890f0, 0x440c9616, 0x438c9616, 0x4830c200, 0x49dcf280, 0x4b8a1790, - 0x440e2836, 0x438e2836, 0x483a8600, 0x49e92780, 0x4b91b8b0, 0x441602d4, 0x439602d4, 0x483c7a00, - 0x49eb9880, 0x4b933f50, 0x441794f4, 0x439794f4, 0x48406200, 0x49f07a80, 0x4b964c90, 0x441ab933, - 0x439ab933, 0x48425600, 0x49f2eb80, 0x4b97d330, 0x441c4b53, 0x439c4b53, 0x484e0e00, 0x4a00c8c0, - 0x4ba0faf0, 0x4425b811, 0x43a5b811, 0x4859c600, 0x4a081bc0, 0x4baa22b0, 0x442f24cf, 0x43af24cf, - 0x485dae00, 0x4a0a8cc0, 0x4bad2ff0, 0x4432490f, 0x43b2490f, 0x485fa200, 0x4a0bc540, 0x4baeb690, - 0x4433db2f, 0x43b3db2f, 0x48638a00, 0x4a0e3640, 0x4bb1c3d0, 0x4436ff6e, 0x43b6ff6e, 0x48696600, - 0x4a11dfc0, 0x4bb657b0, 0x443bb5cd, 0x43bbb5cd, 0x486b5a00, 0x4a131840, 0x4bb7de50, 0x443d47ed, - 0x43bd47ed, 0x48751e00, 0x4a1932c0, 0x4bbf7f70, 0x4445228b, 0x43c5228b, 0x487afa00, 0x4a1cdc40, - 0x4bc41350, 0x4449d8ea, 0x43c9d8ea, 0x48806b00, 0x4a2085c0, 0x4bc8a730, 0x444e8f4a, 0x43ce8f4a, - 0x48835900, 0x4a242f40, 0x4bcd3b10, 0x445345a9, 0x43d345a9, 0x48845300, 0x4a2567c0, 0x4bcec1b0, - 0x4454d7c8, 0x43d4d7c8, 0x48874100, 0x4a291140, 0x4bd35590, 0x44598e28, 0x43d98e28, 0x48893500, - 0x4a2b8240, 0x4bd662d0, 0x445cb267, 0x43dcb267, 0x488a2f00, 0x4a2cbac0, 0x4bd7e970, 0x445e4487, - 0x43de4487, 0x488f1100, 0x4a32d540, 0x4bdf8a90, 0x44661f25, 0x43e61f25, 0x4895e700, 0x4a3b60c0, - 0x4bea38f0, 0x44711e03, 0x43f11e03, 0x4897db00, 0x4a3dd1c0, 0x4bed4630, 0x44744243, 0x43f44243, - 0x4898d500, 0x4a3f0a40, 0x4beeccd0, 0x4475d462, 0x43f5d462, 0x489ac900, 0x4a417b40, 0x4bf1da10, - 0x4478f8a2, 0x43f8f8a2, 0x48a19f00, 0x4a4a06c0, 0x4bfc8870, 0x4481fbc0, 0x4401fbc0, 0x48a48d00, - 0x4a4db040, 0x4c008e28, 0x448456ef, 0x440456ef, 0x48a96f00, 0x4a53cac0, 0x4c045eb8, 0x4488443f, - 0x4408443f, 0x48aa6900, 0x4a550340, 0x4c052208, 0x44890d4f, 0x44090d4f, 0x48ac5d00, 0x4a577440, - 0x4c06a8a8, 0x448a9f6e, 0x440a9f6e, 0x48af4b00, 0x4a5b1dc0, 0x4c08f298, 0x448cfa9e, 0x440cfa9e, - 0x48b33300, 0x4a5fffc0, 0x4c0bffd8, 0x44901edd, 0x44101edd, 0x45800000, 0x45800000, 0x45800000, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f51c77e, 0xbedd64d0, 0x3f789ddc, 0x3eb019fd, 0x3eb8f3d3, 0x3f375624, 0xbf7de0d1, 0xbf699ad7, - 0x3f60da75, 0x3f6e085c, 0xbf164189, 0x3d36400d, 0x3edc7010, 0xbf4e662e, 0x3d405c8d, 0xbee7c9f9, - 0xb7782347, 0x3f800000, 0xbe820307, 0xbf0b0c04, 0xbf03e87d, 0xb60c48ee, 0xbf800000, 0xbef394ea, - 0xbf784f61, 0xbf21d58d, 0xb6f1e04a, 0xbf800000, 0xbf24aab4, 0xbf25aed3, 0xbf2f97f4, 0x36b841cd, - 0x3f800000, 0xbd5c6f3b, 0x3f034624, 0xbf485a8e, 0x34c85f9f, 0x3f800000, 0xbf661672, 0xbf7c2002, - 0xbf7c408c, 0xb61916d0, 0xbf800000, 0x3f74a965, 0xbe1d5380, 0xbf7fe5c3, 0xb6f8473b, 0xbf800000, - 0x3f7d60e1, 0x3f7d8cd7, 0xbf7b92b6, 0x3443e110, 0x3f800000, 0xbe6c7b16, 0x3f399fe0, 0xbf778b08, - 0x37582090, 0xbf800000, 0x3f0469fd, 0xbf3fcee4, 0xbf510c12, 0xb77e8a38, 0x3f800000, 0x3f1b1c2a, - 0xbe6538db, 0xbf45f45e, 0xb625e4b3, 0xbf800000, 0x3f635086, 0x3f7f6d36, 0xbf1edb8b, 0x36ab73ea, - 0x3f800000, 0x3f7fd59f, 0xbeb43221, 0xbee0f42e, 0x3754ed17, 0xbf800000, 0xbf347434, 0xbf7fe022, - 0xbe9d1937, 0xb7c07869, 0xbf800000, 0xbf70c7ed, 0x3ea2f2c4, 0xbdc701ed, 0xb780ded8, 0x3f800000, - 0xbf7ed5e0, 0x3f50db9b, 0x3def80e6, 0xb7028a8f, 0xbf800000, 0x3e8dea50, 0x3ea760b9, 0x3e401c41, - 0xb7d6bcc2, 0x3f800000, 0xbf0ebc0a, 0xbeb8918d, 0x3f04ff54, 0x36f7b769, 0xbf800000, 0xbf1132dd, - 0x3e7fb385, 0x3f144973, 0xb72f1340, 0x3f800000, 0xbe187d47, 0x3f7f4269, 0x3f308483, 0x377b0ed6, - 0x3f800000, 0xbf5d6d4e, 0x3f5ae6c1, 0x3f3d5081, 0xb63f8079, 0xbf800000, 0xbf6fc0a3, 0xbeda3872, - 0x3f73d890, 0x374e8625, 0xbf800000, 0xbea5440a, 0xbe141248, 0x3f7e2b10, 0x37e67635, 0xbf800000, - 0x3f61edb2, 0xbf7bb57d, 0x3f773730, 0xb708f180, 0xbf800000, 0x3de789d8, 0xbf67daa7, 0x3f71d547, - 0xb7d9f03b, 0x3f800000, 0x3f18ba91, 0x3ddf826b, 0x3f6364b3, 0xb51be5ea, 0x3f800000, 0x3e48b661, - 0x3f6b95fc, 0x3f452520, 0x36eae986, 0xbf800000, 0x3f570885, 0x3f0546fc, 0x3f38f8ef, 0xb7357a32, - 0x3f800000, 0xbf224a9b, 0xbf0d0178, 0x3edeaa0d, 0x37b9ed83, 0xbf800000, 0xbf6760e7, 0x3f7543d0, - 0x3e6ecefa, 0x37f98714, 0x3f800000, 0xbf800000, 0xbb08944f, 0x3caab641, 0xb7c6df5b, 0xbf800000, - 0xbf676c96, 0xbf74f4ff, 0xbe451be2, 0xb78745ca, 0x3f800000, 0xbd8603ed, 0xbf1be986, 0xbe8633a8, - 0x37e342bc, 0xbf800000, 0xbef8ceba, 0x3f6f6586, 0xbeec5131, 0xb7dd23b3, 0x3f800000, 0xbe787a08, - 0x3f231238, 0xbf155298, 0xb5812a80, 0x3f800000, 0xbf5025e8, 0x3d8e1373, 0xbf23cc73, 0xb79d8a22, - 0xbf800000, 0x3f18a4a4, 0xbdd705b6, 0xbf5e4bbf, 0x376e40f4, 0x3f800000, 0xbed2c7ef, 0xbf644f84, - 0xbf7ff4f6, 0x3741b843, 0xbf800000, 0x3f6c640e, 0xbf374313, 0xbf7e0359, 0xb7ca12d3, 0xbf800000, - 0x3c90be57, 0xbe33ffac, 0xbf7b16dc, 0x37a075b2, 0x3f800000, 0x3f2ba5df, 0x3f60065d, 0xbf71699f, - 0xb78a7943, 0x3f800000, 0x3f796b78, 0xbf4390c6, 0xbf2ae89f, 0xb7a0bd9b, 0xbf800000, 0x3f7a1ea9, - 0x3f56999d, 0xbefcd3cc, 0x384f6dfb, 0x3f800000, 0xbf7ed344, 0xbf517919, 0xbe220610, 0xb8263cb7, - 0xbf800000, 0x3ee8d778, 0xbf7ffd7f, 0xbdb2baa1, 0xb870f874, 0x3f800000, 0xbf70d133, 0xbea0ec7e, - 0x3d63cd5d, 0x37f32023, 0x3f800000, 0xbf348793, 0x3f7fe815, 0x3e88a823, 0xb7cd464c, 0xbf800000, - 0xbf40f796, 0xbf466c2b, 0x3f072a7b, 0x37dcdbca, 0xbf800000, 0xbf183a75, 0xbf183a75, 0xbf183a75, -] )) ), - -################ chunk 18432 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x45800000, 0x46000000, 0x46000000, 0x46000000, 0x46000000, 0x46800000, 0x46800000, 0x46800000, - 0x46800000, 0x47000000, 0x47000000, 0x47000000, 0x47000000, 0x47800000, 0x47800000, 0x47800000, - 0x47800000, 0x48000000, 0x48000000, 0x48000000, 0x48000000, 0x48800000, 0x48800000, 0x48800000, - 0x48800000, 0x49000000, 0x49000000, 0x49000000, 0x49000000, 0x49800000, 0x49800000, 0x49800000, - 0x49800000, 0x4a25e927, 0x4bcf6371, 0x4d819e27, 0x49aca22c, 0x4b57cab8, 0x4c843514, 0x4bafac5d, - 0x4544597b, 0x4546aa6a, 0x45c4597b, 0x45c6aa6a, 0x4613431d, 0x4614ffd0, 0x4644597b, 0x4646aa6a, - 0x46756fda, 0x46785505, 0x4693431d, 0x4694ffd0, 0x46abce4c, 0x46add51d, 0x46c4597b, 0x46c6aa6a, - 0x46dce4ab, 0x46df7fb8, 0x46f56fda, 0x46f85505, 0x4706fd85, 0x47089529, 0x4713431d, 0x4714ffd0, - 0x471f88b4, 0x47216a76, 0x472bce4c, 0x472dd51d, 0x473813e4, 0x473a3fc4, 0x4744597b, 0x4746aa6a, - 0x47509f13, 0x47531511, 0x475ce4ab, 0x475f7fb8, 0x47692a43, 0x476bea5e, 0x47756fda, 0x47785505, - 0x4780dab9, 0x47825fd6, 0x4786fd85, 0x47889529, 0x478d2051, 0x478eca7c, 0x4793431d, 0x4794ffd0, - 0x479965e8, 0x479b3523, 0x479f88b4, 0x47a16a76, 0x47a5ab80, 0x47a79fca, 0x47abce4c, 0x47add51d, - 0x47b1f118, 0x47b40a70, 0x47b813e4, 0x47ba3fc4, 0x47be36b0, 0x47c07517, 0x47c4597b, 0x47c6aa6a, - 0x47ca7c47, 0x47ccdfbe, 0x47d09f13, 0x47d31511, 0x47d6c1df, 0x47d94a64, 0x47dce4ab, 0x47df7fb8, - 0x47e30777, 0x47e5b50b, 0x47e92a43, 0x47ebea5e, 0x47ef4d0e, 0x47f21fb2, 0x47f56fda, 0x47f85505, - 0x47fb92a6, 0x47fe8a58, 0x4800dab9, 0x48025fd6, 0x4803ec1f, 0x48057a7f, 0x4806fd85, 0x48089529, - 0x480a0eeb, 0x480bafd3, 0x480d2051, 0x480eca7c, 0x481031b7, 0x4811e526, 0x4813431d, 0x4814ffd0, - 0x48165482, 0x48181a79, 0x481965e8, 0x481b3523, 0x481c774e, 0x481e4fcd, 0x481f88b4, 0x48216a76, - 0x48229a1a, 0x48248520, 0x4825ab80, 0x48279fca, 0x4828bce6, 0x482aba73, 0x482bce4c, 0x482dd51d, - 0x482edfb2, 0x4830efc7, 0x4831f118, 0x48340a70, 0x4835027e, 0x4837251a, 0x483813e4, 0x483a3fc4, - 0x483b254a, 0x483d5a6d, 0x483e36b0, 0x48407517, 0x48414815, 0x48438fc1, 0x4844597b, 0x4846aa6a, - 0x48476ae1, 0x4849c514, 0x484a7c47, 0x484cdfbe, 0x484d8dad, 0x484ffa67, 0x48509f13, 0x48531511, - 0x4853b079, 0x48562fbb, 0x4856c1df, 0x48594a64, 0x4859d345, 0x485c650e, 0x485ce4ab, 0x485f7fb8, - 0x485ff611, 0x48629a61, 0x48630777, 0x4865b50b, 0x486618dd, 0x4868cfb5, 0x48692a43, 0x486bea5e, - 0x486c3ba8, 0x486f0508, 0x486f4d0e, 0x48721fb2, 0x48725e74, 0x48753a5b, 0x48756fda, 0x48785505, - 0x48788140, 0x487b6fae, 0x487b92a6, 0x487e8a58, 0x487ea40c, 0x4880d281, 0x4880dab9, 0x48825fd6, - 0x4882636c, 0x4883ed2b, 0x4883ec1f, 0x48857a7f, 0x488574d2, 0x488707d4, 0x4886fd85, 0x48889529, - 0x48888638, 0x488a227e, 0x488a0eeb, 0x488bafd3, 0x488b979e, 0x488d3d28, 0x488d2051, 0x488eca7c, - 0x488ea904, 0x489057d1, 0x489031b7, 0x4891e526, 0x4891ba6a, 0x4893727b, 0x4893431d, 0x4894ffd0, - 0x4894cbcf, 0x48968d25, 0x48965482, 0x48981a79, 0x4897dd35, 0x4899a7ce, 0x489965e8, 0x489b3523, - 0x489aee9b, 0x489cc278, 0x489c774e, 0x489e4fcd, 0x489e0001, 0x489fdd22, 0x489f88b4, 0x48a16a76, - 0x48a11167, 0x48a2f7cb, 0x48a29a1a, 0x48a48520, 0x48a422cd, 0x48a61275, 0x48a5ab80, 0x48a79fca, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbf183a75, 0xbf74c7c4, 0xbf74c7c4, 0xbf74c7c4, 0xbf74c7c4, 0xbf0f5821, 0xbf0f5821, 0xbf0f5821, - 0xbf0f5821, 0x3f6d87fe, 0x3f6d87fe, 0x3f6d87fe, 0x3f6d87fe, 0x3f312b34, 0x3f312b34, 0x3f312b34, - 0x3f312b34, 0xbf7fc5ec, 0xbf7fc5ec, 0xbf7fc5ec, 0xbf7fc5ec, 0xbdac404e, 0xbdac404e, 0xbdac404e, - 0xbdac404e, 0x3e2ba40f, 0x3e2ba40f, 0x3e2ba40f, 0x3e2ba40f, 0x3ea93666, 0x3ea93666, 0x3ea93666, - 0x3ea93666, 0xbe12024a, 0xbf4d5423, 0x3ede42ac, 0x3ed76962, 0xbf4ed869, 0x3f69a0ff, 0xbf52772e, - 0xb90254a0, 0xbf191063, 0xb98254a0, 0xbf7561bf, 0x39bc810f, 0xbf705bc6, 0xba0254a0, 0xbf0be025, - 0xb9c5d390, 0x3d7f3a24, 0x3a3c810e, 0x3f257521, 0xb9105062, 0x3f797394, 0xba82549f, 0x3f6a4ce7, - 0x38d60cbb, 0x3efcec19, 0xba45d390, 0xbdfebb2c, 0x39b32e8e, 0xbf317d0d, 0x3abc810b, 0xbf7c82b8, - 0xbab3c981, 0xbf634d8f, 0xb9905062, 0xbee03e0e, 0x3a5742a5, 0x3e3d725c, 0xbb02549b, 0x3f3cced0, - 0xba69e7a7, 0x3f7eab97, 0x39560cba, 0x3f5be86b, 0x3aaa7700, 0x3ec2a9dc, 0xbac5d38c, 0xbe7cc0c8, - 0xb9d87893, 0xbf46bdd1, 0x3a332e8d, 0xbf7fcf15, 0x3ae94cab, 0xbf529b20, 0x3b3c80ff, 0xbea6327a, - 0xbb7ba412, 0x3e9d85e6, 0xbb33c976, 0x3f512225, 0xbad7dd97, 0x3f7ff1d9, 0xba105062, 0x3f499759, - 0x3a0f1a75, 0x3e854944, 0x3ad742a1, 0xbeba2d25, 0x3b337bfb, 0xbf598852, 0xbb82548a, 0xbf7f0250, - 0xbb3cce7a, 0xbf3fdd67, 0xbae9e7a1, 0xbe4f62e4, 0xba34647a, 0x3ed9cc93, 0x39d60cba, 0x3f6129ec, - 0x3ac53896, 0x3f7d38f9, 0x3b2a76f7, 0x3f340b82, 0xbb86d70a, 0x3e1377d8, 0xbb45d37d, 0xbef4eec0, - 0xbafbf1ab, 0xbf68d6ad, 0xba587892, 0xbf7a8acf, 0x398de489, 0xbf276956, 0x3ab32e8b, 0xbd9e1c93, - 0x3b2171f2, 0x3f0799cb, 0x3b694c93, 0x3f6f7615, 0x3b989390, 0x3f767193, 0x3bbc80cb, 0x3f1d3297, - 0xbc0fc852, 0x3c249470, 0xbbfba398, 0xbf15e1ea, 0xbbd7b679, 0xbf73cfea, 0xbbb3c949, 0xbf713b41, - 0xbb8fdc0b, 0xbf0f4490, 0xbb57dd83, 0x3d2a32a9, 0xbb1002df, 0x3f237ca7, 0xba905060, 0x3f788143, - 0xb69af629, 0x3f6c7d59, 0x3a8f1a74, 0x3f00b0ce, 0x3b0f67e9, 0xbdde6162, 0x3b57428d, 0xbf2d6e82, - 0x3b8f8e90, 0xbf7c1323, 0x3bb37bcf, 0xbf655ea5, 0xbc144ac9, 0xbeea34c3, 0xbc025446, 0x3e335417, - 0xbbe0bb72, 0x3f39b0ce, 0xbbbcce46, 0x3f7e0af9, 0xbb98e10b, 0x3f5d369a, 0xbb69e789, 0x3ecb16af, - 0xbb220ce8, 0xbe67191a, 0xbab46477, 0xbf451c4b, 0xb992bc3b, 0xbf7f976f, 0x3a560cb9, 0xbf5645ab, - 0x3afabbbf, 0xbeab0dac, 0x3b453887, 0x3e94cc75, 0x3b868990, 0x3f4d4658, 0x3baa76d1, 0x3f7ffc39, - 0xbc18cd40, 0x3f4c606d, 0xbc06d6c0, 0x3e91ee51, 0xbbe9c06a, 0xbeb5603b, 0xbbc5d342, 0xbf571678, - 0xbba1e60b, 0xbf7f38e3, 0xbb7bf18d, 0xbf418ec1, 0xbb3416f1, 0xbe61427e, 0xbad8788d, 0x3ecdd57c, - 0xba11864e, 0x3f5df68b, 0x3a0de489, 0x3f7d4e4f, 0x3ad6a7aa, 0x3f35dd2d, 0x3b332e80, 0x3e1da3c4, - 0x3b7b091c, 0xbeecdd69, 0x3ba171d2, 0xbf6607dc, 0x3bc55f0a, 0xbf7bcf2b, 0x3be94c32, 0xbf295937, - 0x3c069ca4, 0xbdb29d5e, 0x3c189324, 0x3f0569aa, 0x3c2a8998, 0x3f6d0f13, 0x3c3c7fff, 0x3f78241b, - 0xbc98c1dd, 0x3f2254fd, 0xbc8fc6e7, 0x3ca49250, 0xbc86cbe5, 0xbf13ca4a, 0xbc7ba1b2, 0xbf73040f, - 0xbc69ab86, 0xbf7359fe, 0xbc57b547, 0xbf14aa88, 0xbc45bef7, 0x3c823270, 0xbc33c898, 0x3f217ff3, - 0xbc21d22b, 0x3f77dfec, 0xbc0fdbb0, 0x3f6d765e, 0xbbfbca56, 0x3f06541a, 0xbbd7dd37, 0xbdaa0d07, -] )) ), - -################ chunk 18944 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x48a73433, 0x48a92d1e, 0x48a8bce6, 0x48aaba73, 0x48aa4599, 0x48ac47c8, 0x48abce4c, 0x48add51d, - 0x48ad56ff, 0x48af6272, 0x48aedfb2, 0x48b0efc7, 0x48b06865, 0x48b27d1b, 0x48b1f118, 0x48b40a70, - 0x48b379cb, 0x48b597c5, 0x48b5027e, 0x48b7251a, 0x48b68b31, 0x48b8b26f, 0x48b813e4, 0x48ba3fc4, - 0x48b99c97, 0x48bbcd18, 0x48bb254a, 0x48bd5a6d, 0x48bcadfd, 0x48bee7c2, 0x48be36b0, 0x48c07517, - 0x48bfbf62, 0x48c2026c, 0x48c14815, 0x48c38fc1, 0x48c2d0c8, 0x48c51d15, 0x48c4597b, 0x48c6aa6a, - 0x48c5e22e, 0x48c837bf, 0x48c76ae1, 0x48c9c514, 0x48c8f394, 0x48cb5269, 0x48ca7c47, 0x48ccdfbe, - 0x48cc04fa, 0x48ce6d12, 0x48cd8dad, 0x48cffa67, 0x48cf1660, 0x48d187bc, 0x48d09f13, 0x48d31511, - 0x48d227c6, 0x48d4a266, 0x48d3b079, 0x48d62fbb, 0x48d5392c, 0x48d7bd0f, 0x48d6c1df, 0x48d94a64, - 0x48d84a92, 0x48dad7b9, 0x48d9d345, 0x48dc650e, 0x48db5bf8, 0x48ddf263, 0x48dce4ab, 0x48df7fb8, - 0x48de6d5e, 0x48e10d0c, 0x48dff611, 0x48e29a61, 0x48e17ec4, 0x48e427b6, 0x48e30777, 0x48e5b50b, - 0x48e4902a, 0x48e74260, 0x48e618dd, 0x48e8cfb5, 0x48e7a190, 0x48ea5d09, 0x48e92a43, 0x48ebea5e, - 0x48eab2f5, 0x48ed77b3, 0x48ec3ba8, 0x48ef0508, 0x48edc45b, 0x48f0925d, 0x48ef4d0e, 0x48f21fb2, - 0x48f0d5c1, 0x48f3ad06, 0x48f25e74, 0x48f53a5b, 0x48f3e727, 0x48f6c7b0, 0x48f56fda, 0x48f85505, - 0x48f6f88d, 0x48f9e25a, 0x48f88140, 0x48fb6fae, 0x48fa09f3, 0x48fcfd03, 0x48fb92a6, 0x48fe8a58, - 0x48fd1b59, 0x49000bd6, 0x48fea40c, 0x4900d281, 0x4900165f, 0x4901992b, 0x4900dab9, 0x49025fd6, - 0x49019f12, 0x49032680, 0x4902636c, 0x4903ed2b, 0x490327c5, 0x4904b3d5, 0x4903ec1f, 0x49057a7f, - 0x4904b078, 0x4906412a, 0x490574d2, 0x490707d4, 0x4906392b, 0x4907ce7f, 0x4906fd85, 0x49089529, - 0x4907c1de, 0x49095bd3, 0x49088638, 0x490a227e, 0x49094a91, 0x490ae928, 0x490a0eeb, 0x490bafd3, - 0x490ad344, 0x490c767d, 0x490b979e, 0x490d3d28, 0x490c5bf7, 0x490e03d2, 0x490d2051, 0x490eca7c, - 0x490de4aa, 0x490f9127, 0x490ea904, 0x491057d1, 0x490f6d5d, 0x49111e7c, 0x491031b7, 0x4911e526, - 0x4910f610, 0x4912abd0, 0x4911ba6a, 0x4913727b, 0x49127ec3, 0x49143925, 0x4913431d, 0x4914ffd0, - 0x49140776, 0x4915c67a, 0x4914cbcf, 0x49168d25, 0x49159029, 0x491753cf, 0x49165482, 0x49181a79, - 0x491718dc, 0x4918e124, 0x4917dd35, 0x4919a7ce, 0x4918a18f, 0x491a6e79, 0x491965e8, 0x491b3523, - 0x491a2a42, 0x491bfbcd, 0x491aee9b, 0x491cc278, 0x491bb2f5, 0x491d8922, 0x491c774e, 0x491e4fcd, - 0x491d3ba8, 0x491f1677, 0x491e0001, 0x491fdd22, 0x491ec45b, 0x4920a3cc, 0x491f88b4, 0x49216a76, - 0x49204d0e, 0x49223121, 0x49211167, 0x4922f7cb, 0x4921d5c1, 0x4923be76, 0x49229a1a, 0x49248520, - 0x49235e74, 0x49254bca, 0x492422cd, 0x49261275, 0x4924e727, 0x4926d91f, 0x4925ab80, 0x49279fca, - 0x49266fda, 0x49286674, 0x49273433, 0x49292d1e, 0x4927f88d, 0x4929f3c9, 0x4928bce6, 0x492aba73, - 0x49298140, 0x492b811e, 0x492a4599, 0x492c47c8, 0x492b09f2, 0x492d0e73, 0x492bce4c, 0x492dd51d, - 0x492c92a5, 0x492e9bc7, 0x492d56ff, 0x492f6272, 0x492e1b58, 0x4930291c, 0x492edfb2, 0x4930efc7, - 0x492fa40b, 0x4931b671, 0x49306865, 0x49327d1b, 0x49312cbe, 0x493343c6, 0x4931f118, 0x49340a70, - 0x4932b571, 0x4934d11b, 0x493379cb, 0x493597c5, 0x49343e24, 0x49365e70, 0x4935027e, 0x4937251a, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbbb3f007, 0xbf2e7ac9, 0xbb9002c9, 0xbf7b9d0a, 0xbb582afe, 0xbf66800b, 0xbb10505a, 0xbeeec48d, - 0xba90eb56, 0x3e19645e, 0xb71af629, 0x3f351b32, 0x3a8e7f7e, 0x3f7e3717, 0x3b0f1a6e, 0x3f5e7f13, - 0x3b56f513, 0x3ecfccb1, 0x3b8f67d3, 0xbe5d10c6, 0x3bb35511, 0xbf40da50, 0x3bd74241, 0xbf7f22e3, - 0x3bfb2f61, 0xbf557cb9, 0x3c0f8e36, 0xbeafe473, 0x3c2184b0, 0x3e8fdeba, 0x3c337b1e, 0x3f4bba56, - 0xbc9d442b, 0x3f7ff8b1, 0xbc94493b, 0x3f50442c, 0xbc8b4e3f, 0x3e8f30bc, 0xbc825338, 0xbeb08ea2, - 0xbc72b04d, 0xbf55aeaf, 0xbc60ba18, 0xbf7fa663, 0xbc4ec3d0, 0xbf45cb5a, 0xbc3ccd79, 0xbe7ad341, - 0xbc2ad712, 0x3ed0724d, 0xbc18e09e, 0x3f5eabd8, 0xbc06ea1e, 0x3f7e2c58, 0xbbe9e727, 0x3f3a6db8, - 0xbbc5f9ff, 0x3e378ed8, 0xbba20cc8, 0xbee122cf, 0xbb7c3f08, 0xbf66a76b, 0xbb34646c, 0xbf7b8c46, - 0xbad91383, 0xbf2e386d, 0xba12bc3a, 0xbde6ec31, 0x3a0cae9d, 0x3eff8581, 0x3ad60cb4, 0x3f6a8014, - 0x3b32e105, 0x3f77c935, 0x3b7abba1, 0x3f213997, 0x3ba14b15, 0x3d3b5f1e, 0x3bc5384d, 0xbf0e604e, - 0x3be92575, 0xbf70dea5, 0x3c068945, 0xbf754fad, 0x3c187fc5, 0xbf138040, 0x3c2a763a, 0x3cafe5ce, - 0xbca1c676, 0x3f1c5927, 0xbc98cb8c, 0x3f762693, 0xbc8fd096, 0x3f6fd6cc, 0xbc86d594, 0x3f0be0bd, - 0xbc7bb510, 0xbdb56f97, 0xbc69bee4, 0xbf299d24, 0xbc57c8a5, 0xbf7a51c1, 0xbc45d256, 0xbf694879, - 0xbc33dbf7, 0xbefa507a, 0xbc21e589, 0x3e1f09ec, 0xbc0fef0f, 0x3f361cea, 0xbbfbf113, 0x3f7d5b5c, - 0xbbd803f4, 0x3f5dc955, 0xbbb416c4, 0x3edbbdea, 0xbd11fd4a, 0xbe62a412, 0xbb587879, 0xbf3c77cc, - 0xbd090352, 0xbf7f3fe2, 0xba91864c, 0xbf5d2dbc, 0xbd000930, 0xbebc2d26, 0x3a8de488, 0x3e929c05, - 0xbcee1dca, 0x3f47ae8a, 0x3b56a798, 0x3f7ffd22, 0xbcdc28ea, 0x3f5404ca, 0x3bb32e54, 0x3e9bc2b4, - 0xbcca33c4, 0xbeb33c68, 0x3bfb08a3, 0xbf51fe4a, 0xbcb83e5e, 0xbf7f9241, 0x3c217152, 0xbf49e695, - 0xbca648be, 0xbe754824, 0x3c455e1f, 0x3eb5812f, 0xbc9452ea, 0x3f5b5b1d, 0x3c694aae, 0x3f7dffba, - 0xbc825ce7, 0x3f3eded0, 0x3c869b7a, 0x3e31ef23, 0xbc60cd76, 0xbed5423b, 0x3c989172, 0xbf63ba30, - 0xbc3ce0d7, 0xbf7b475f, 0x3caa873b, 0xbf32fa3e, 0xbc18f3fd, 0xbddb9096, 0x3cbc7ccd, 0x3ef40c93, - 0xbbea0de4, 0x3f6b11d3, 0xbd18bb11, 0x3f7b0b56, 0xbba23385, 0x3f2646a2, 0xbd0fc13c, 0x3d2489d0, - 0xbb34b1e7, 0xbf08de4d, 0xbd06c739, 0xbf715989, 0xba13f227, 0xbf771bfb, 0xbcfb9a19, 0xbf18d2ac, - 0x3ad571be, 0x3cdd97c6, 0xbce9a570, 0x3f1717fc, 0x3b7a6e26, 0x3f768a0c, 0xbcd7b07e, 0x3f720ec6, - 0x3bc5118f, 0x3f0aaded, 0xbcc5bb47, 0xbd022e3a, 0x3c0675e7, 0xbf24a2e2, 0xbcb3c5d3, 0xbf7a9d5c, - 0x3c2a62db, 0xbf6be98c, 0xbca1d025, 0xbef7d181, 0x3c4e4f9a, 0x3dca775e, 0xbc8fda45, 0x3f316f54, - 0x3c723c18, 0x3f7d8ec3, 0xbc7bc86e, 0x3f64b36b, 0x3c8b1425, 0x3ed9287c, 0xbc57dc04, 0xbe2976b4, - 0x3c9d0a12, 0xbf3d6e84, 0xbc33ef55, 0xbf7f5ad8, 0x3caeffcd, 0xbf5c74ba, 0xbc10026e, 0xbeb98440, - 0x3cc0f552, 0x3e6cedaf, 0xbbd82ab1, 0x3f489291, 0xbd167f0b, 0x3f7f7020, 0xbb905044, 0x3f533703, - 0xbd0d852b, 0x3e990969, 0xbb10eb51, 0xbe97a94b, 0xbd048b1d, 0xbf52ce98, 0xb79af629, 0xbf7ffff8, - 0xbcf721cd, 0xbf4904f6, 0x3b0e7f78, 0xbe6fbb13, 0xbce52d12, 0x3eb82c4d, 0x3b8f1a58, 0x3f5c16c3, - 0xbcd3380e, 0x3f7f67ac, 0x3bd6f4c7, 0x3f3dea5e, 0xbcc142c7, 0x3e6b03c2, 0x3c0f6779, 0xbed7da42, -] )) ), - -################ chunk 19456 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4935c6d7, 0x4937ebc4, 0x49368b31, 0x4938b26f, 0x49374f8a, 0x49397919, 0x493813e4, 0x493a3fc4, - 0x4938d83d, 0x493b066e, 0x49399c97, 0x493bcd18, 0x493a60f0, 0x493c93c3, 0x493b254a, 0x493d5a6d, - 0x493be9a3, 0x493e2118, 0x493cadfd, 0x493ee7c2, 0x493d7256, 0x493fae6d, 0x493e36b0, 0x49407517, - 0x493efb09, 0x49413bc1, 0x493fbf62, 0x4942026c, 0x494083bc, 0x4942c916, 0x49414815, 0x49438fc1, - 0x49420c6f, 0x4944566b, 0x4942d0c8, 0x49451d15, 0x49439522, 0x4945e3c0, 0x4944597b, 0x4946aa6a, - 0x49451dd5, 0x49477115, 0x4945e22e, 0x494837bf, 0x4946a688, 0x4948fe6a, 0x49476ae1, 0x4949c514, - 0x49482f3b, 0x494a8bbe, 0x4948f394, 0x494b5269, 0x4949b7ee, 0x494c1913, 0x494a7c47, 0x494cdfbe, - 0x494b40a1, 0x494da668, 0x494c04fa, 0x494e6d12, 0x494cc954, 0x494f33bd, 0x494d8dad, 0x494ffa67, - 0x494e5207, 0x4950c112, 0x494f1660, 0x495187bc, 0x494fdaba, 0x49524e66, 0x49509f13, 0x49531511, - 0x4951636d, 0x4953dbbb, 0x495227c6, 0x4954a266, 0x4952ec20, 0x49556910, 0x4953b079, 0x49562fbb, - 0x495474d2, 0x4956f665, 0x4955392c, 0x4957bd0f, 0x4955fd85, 0x495883ba, 0x4956c1df, 0x49594a64, - 0x49578638, 0x495a110f, 0x49584a92, 0x495ad7b9, 0x49590eeb, 0x495b9e63, 0x4959d345, 0x495c650e, - 0x495a979e, 0x495d2bb8, 0x495b5bf8, 0x495df263, 0x495c2051, 0x495eb90d, 0x495ce4ab, 0x495f7fb8, - 0x495da904, 0x49604662, 0x495e6d5e, 0x49610d0c, 0x495f31b7, 0x4961d3b7, 0x495ff611, 0x49629a61, - 0x4960ba6a, 0x4963610c, 0x49617ec4, 0x496427b6, 0x4962431d, 0x4964ee60, 0x49630777, 0x4965b50b, - 0x4963cbd0, 0x49667bb5, 0x4964902a, 0x49674260, 0x49655483, 0x4968090a, 0x496618dd, 0x4968cfb5, - 0x4966dd36, 0x4969965f, 0x4967a190, 0x496a5d09, 0x496865e9, 0x496b23b4, 0x49692a43, 0x496bea5e, - 0x4969ee9c, 0x496cb109, 0x496ab2f5, 0x496d77b3, 0x496b774f, 0x496e3e5d, 0x496c3ba8, 0x496f0508, - 0x496d0002, 0x496fcbb2, 0x496dc45b, 0x4970925d, 0x496e88b5, 0x49715907, 0x496f4d0e, 0x49721fb2, - 0x49701168, 0x4972e65c, 0x4970d5c1, 0x4973ad06, 0x49719a1b, 0x497473b1, 0x49725e74, 0x49753a5b, - 0x497322ce, 0x49760106, 0x4973e727, 0x4976c7b0, 0x4974ab81, 0x49778e5a, 0x49756fda, 0x49785505, - 0x49763434, 0x49791baf, 0x4976f88d, 0x4979e25a, 0x4977bce7, 0x497aa904, 0x49788140, 0x497b6fae, - 0x4979459a, 0x497c3659, 0x497a09f3, 0x497cfd03, 0x497ace4d, 0x497dc3ae, 0x497b92a6, 0x497e8a58, - 0x497c5700, 0x497f5103, 0x497d1b59, 0x49800bd6, 0x497ddfb3, 0x49806f2c, 0x497ea40c, 0x4980d281, - 0x497f6865, 0x498135d6, 0x4980165f, 0x4981992b, 0x4980788c, 0x4981fc81, 0x4980dab9, 0x49825fd6, - 0x49813ce6, 0x4982c32b, 0x49819f12, 0x49832680, 0x4982013f, 0x498389d5, 0x4982636c, 0x4983ed2b, - 0x4982c599, 0x49845080, 0x498327c5, 0x4984b3d5, 0x498389f2, 0x4985172a, 0x4983ec1f, 0x49857a7f, - 0x49844e4c, 0x4985ddd5, 0x4984b078, 0x4986412a, 0x498512a5, 0x4986a47f, 0x498574d2, 0x498707d4, - 0x4985d6ff, 0x49876b29, 0x4986392b, 0x4987ce7f, 0x49869b58, 0x498831d4, 0x4986fd85, 0x49889529, - 0x49875fb2, 0x4988f87e, 0x4987c1de, 0x49895bd3, 0x4988240b, 0x4989bf29, 0x49888638, 0x498a227e, - 0x4988e865, 0x498a85d3, 0x49894a91, 0x498ae928, 0x4989acbe, 0x498b4c7e, 0x498a0eeb, 0x498bafd3, - 0x498a7117, 0x498c1328, 0x498ad344, 0x498c767d, 0x498b3571, 0x498cd9d2, 0x498b979e, 0x498d3d28, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbcaf4d44, 0xbf646053, 0x3c335461, 0xbf7da7eb, 0xbc9d5789, 0xbf31f414, 0x3c574111, 0xbe278617, - 0xbc8b619d, 0x3ef68e83, 0x3c7b2d7d, 0x3f6ba1b4, 0xbc72d70a, 0x3f7ac2bb, 0x3c8f8ccd, 0x3f252fef, - 0xbc4eea8d, 0x3dc68d41, 0x3ca182ae, 0xbf0a12c6, 0xbc2afdcf, 0xbf6c1a50, 0x3cb3785c, 0xbf76bb77, - 0xbc0710db, 0xbf17acb3, 0xbd1d3cc0, 0xbcf4a292, 0xbbc6477a, 0x3f183e92, 0xbd144303, 0x3f7237a1, - 0xbb7cd9fe, 0x3f7196c7, 0xbd0b4917, 0x3f097a01, 0xbada496f, 0xbd190570, 0xbd024eff, 0xbf25ba3f, - 0x3a0a42c4, 0xbf773cc0, 0xbcf2a97c, 0xbf6b5a9e, 0x3b32460f, 0xbf0873de, 0xbce0b4ae, 0x3dd5d592, - 0x3ba0fd9a, 0x3f327635, 0xbccebf99, 0x3f7b23dd, 0x3be8d7fa, 0x3f640e33, 0xbcbcca43, 0x3ef32f29, - 0x3c185908, 0xbe2f1887, 0xbcaad4b2, 0xbf3e63ba, 0x3c3c45e4, 0xbf7de875, 0xbc98deea, 0xbf5bb9f7, - 0x3c603284, 0xbed45d45, 0xbc86e8f2, 0x3e727bb8, 0x3c820f6e, 0x3f4974ff, 0xbc69e5a1, 0x3f7f8753, - 0x3c940572, 0x3f52678d, 0xbc45f913, 0x3eb495b6, 0x3ca5fb47, 0xbe9a6334, 0xbc220c46, 0xbf4a33df, - 0xbd23fa59, 0xbf7ffe99, 0xbbfc3e8d, 0xbf4821bc, 0xbd1b00c1, 0xbe93fd40, 0xbbb4643f, 0x3ebad5f3, - 0xbd1206f8, 0x3f544b3b, 0xbb59136f, 0x3f7f4dbc, 0xbd090d00, 0x3f3cf469, 0xba92bc39, 0x3e657332, - 0xbd0012de, 0xbeda7090, 0x3a8cae9b, 0xbf5d6d02, 0xbcee3127, 0xbf7d7589, 0x3b560ca2, 0xbf3c2287, - 0xbcdc3c47, 0xbe21e275, 0x3bb2e0d9, 0x3ef90e7c, 0xbcca4721, 0x3f658ea3, 0x3bfabb29, 0x3f7a7822, - 0xbcb851bc, 0x3f300bbc, 0x3c214a95, 0x3dbb2ce7, 0xbca65c1c, 0xbf0b4626, 0x3c453762, 0xbf6ca6b6, - 0xbc946648, 0xbf7658fc, 0x3c6923f2, 0xbf23294b, 0xbc827045, 0xbcc6f173, 0x3c86881c, 0x3f0c4a17, - 0xbc60f433, 0x3f72ad08, 0x3c987e15, 0x3f711cdc, 0xbc3d0794, 0x3f158a1b, 0x3caa73dd, 0xbd2fdb6d, - 0xbc191aba, 0xbf1a5bea, 0xbd21be63, 0xbf779a9e, 0xbbea5b5f, 0xbf6ac9d0, 0xbd18c4be, 0xbf073def, - 0xbba28100, 0x3de13212, 0xbd0fcae9, 0x3f27bb2c, 0xbb354cdd, 0x3f7b69c6, 0xbd06d0e7, 0x3f6a4d7a, - 0xba165dff, 0x3ef0aa9e, 0xbcfbad75, 0xbe34b8f6, 0x3ad43bd2, 0xbf345866, 0xbce9b8cd, 0xbf7e1618, - 0x3b79d330, 0xbf62d802, 0xbcd7c3db, 0xbed1c2f6, 0x3bc4c414, 0x3e7807d3, 0xbcc5cea5, 0x3f402500, - 0x3c064f29, 0x3f7f9c7d, 0xbcb3d930, 0x3f5a5c20, 0x3c2a3c1e, 0x3eb1e8a8, 0xbca1e383, 0xbe9d1be2, - 0x3c4e28dd, 0xbf4b1354, 0xbc8feda3, 0xbf7ffb30, 0x3c72155c, 0xbf50e3a4, 0xbc7bef2b, 0xbe91408b, - 0x3c8b00c7, 0x3e9f6a0e, 0xbc5802c0, 0x3f5d88c9, 0x3c9cf6b4, 0x3f7ff6b1, 0xbc341612, 0x3f467984, - 0xbd287be8, 0x3e5fe0cd, 0xbd91e58b, 0xbedd0521, 0xbd1f826a, 0xbf55c215, 0xbbd8782c, 0xbf7f1870, - 0x3cd2d73c, 0xbf3b29ca, 0xbd88efb1, 0xbe1c3d89, 0xbd0d8ed9, 0x3efb8c78, 0xbb118647, 0x3f5ebd39, - 0x3cf6c0ff, 0x3f7d1316, 0xbd7ff257, 0x3f2f018e, 0xbcf7352a, 0x3dafcb0f, 0x3b0de482, 0xbf0c7869, - 0x3d0d54c5, 0xbf66b6b2, 0xbd6e0409, 0xbf79e8fa, 0xbcd34b6b, 0xbf220edf, 0x3bd6a74c, 0xbc993ebd, - 0x3d1f4859, 0x3f1a8816, 0xbd5c148e, 0x3f6da547, 0xbcaf60a1, 0x3f759dc5, 0x3c332da4, 0x3f1460b7, - 0x3d313b24, 0xbd46b003, 0xbd4a23fe, 0xbf27e500, 0xbc8b74fb, 0xbf7380f4, 0x3c7b06c1, 0xbf70366e, - 0x3d432d0f, 0xbf0606eb, 0xbd383270, 0x3dec8cc6, 0xbc4f114a, 0x3f1c750d, 0x3ca16f50, 0x3f7842f0, - 0xbd9542c3, 0x3f69b937, 0xbd263ff9, 0x3eee2427, 0xbc073799, 0xbe3a57f3, 0x3cc55a75, 0xbf29b787, -] )) ), - -################ chunk 19968 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x498bf9ca, 0x498da07d, 0x498c5bf7, 0x498e03d2, 0x498cbe24, 0x498e6727, 0x498d2051, 0x498eca7c, - 0x498d827d, 0x498f2dd2, 0x498de4aa, 0x498f9127, 0x498e46d7, 0x498ff47c, 0x498ea904, 0x499057d1, - 0x498f0b30, 0x4990bb26, 0x498f6d5d, 0x49911e7c, 0x498fcf8a, 0x499181d1, 0x499031b7, 0x4991e526, - 0x499093e3, 0x4992487b, 0x4990f610, 0x4992abd0, 0x4991583d, 0x49930f26, 0x4991ba6a, 0x4993727b, - 0x49921c96, 0x4993d5d0, 0x49927ec3, 0x49943925, 0x4992e0f0, 0x49949c7a, 0x4993431d, 0x4994ffd0, - 0x4993a549, 0x49956325, 0x49940776, 0x4995c67a, 0x499469a3, 0x499629cf, 0x4994cbcf, 0x49968d25, - 0x49952dfc, 0x4996f07a, 0x49959029, 0x499753cf, 0x4995f256, 0x4997b724, 0x49965482, 0x49981a79, - 0x4996b6af, 0x49987dcf, 0x499718dc, 0x4998e124, 0x49977b09, 0x49994479, 0x4997dd35, 0x4999a7ce, - 0x49983f62, 0x499a0b23, 0x4998a18f, 0x499a6e79, 0x499903bc, 0x499ad1ce, 0x499965e8, 0x499b3523, - 0x4999c815, 0x499b9878, 0x499a2a42, 0x499bfbcd, 0x499a8c6f, 0x499c5f23, 0x499aee9b, 0x499cc278, - 0x499b50c8, 0x499d25cd, 0x499bb2f5, 0x499d8922, 0x499c1522, 0x499dec77, 0x499c774e, 0x499e4fcd, - 0x499cd97b, 0x499eb322, 0x499d3ba8, 0x499f1677, 0x499d9dd5, 0x499f79cc, 0x499e0001, 0x499fdd22, - 0x499e622e, 0x49a04077, 0x499ec45b, 0x49a0a3cc, 0x499f2688, 0x49a10721, 0x499f88b4, 0x49a16a76, - 0x499feae1, 0x49a1cdcc, 0x49a04d0e, 0x49a23121, 0x49a0af3a, 0x49a29476, 0x49a11167, 0x49a2f7cb, - 0x49a17394, 0x49a35b20, 0x49a1d5c1, 0x49a3be76, 0x49a237ed, 0x49a421cb, 0x49a29a1a, 0x49a48520, - 0x49a2fc47, 0x49a4e875, 0x49a35e74, 0x49a54bca, 0x49a3c0a0, 0x49a5af20, 0x49a422cd, 0x49a61275, - 0x49a484fa, 0x49a675ca, 0x49a4e727, 0x49a6d91f, 0x49a54953, 0x49a73c74, 0x49a5ab80, 0x49a79fca, - 0x49a60dad, 0x49a8031f, 0x49a66fda, 0x49a86674, 0x49a6d206, 0x49a8c9c9, 0x49a73433, 0x49a92d1e, - 0x49a79660, 0x49a99074, 0x49a7f88d, 0x49a9f3c9, 0x49a85ab9, 0x49aa571e, 0x49a8bce6, 0x49aaba73, - 0x49a91f13, 0x49ab1dc9, 0x49a98140, 0x49ab811e, 0x49a9e36c, 0x49abe473, 0x49aa4599, 0x49ac47c8, - 0x49aaa7c6, 0x49acab1d, 0x49ab09f2, 0x49ad0e73, 0x49ab6c1f, 0x49ad71c8, 0x49abce4c, 0x49add51d, - 0x49ac3079, 0x49ae3872, 0x49ac92a5, 0x49ae9bc7, 0x49acf4d2, 0x49aeff1d, 0x49ad56ff, 0x49af6272, - 0x49adb92c, 0x49afc5c7, 0x49ae1b58, 0x49b0291c, 0x49ae7d85, 0x49b08c71, 0x49aedfb2, 0x49b0efc7, - 0x49af41df, 0x49b1531c, 0x49afa40b, 0x49b1b671, 0x49b00638, 0x49b219c6, 0x49b06865, 0x49b27d1b, - 0x49b0ca92, 0x49b2e071, 0x49b12cbe, 0x49b343c6, 0x49b18eeb, 0x49b3a71b, 0x49b1f118, 0x49b40a70, - 0x49b25345, 0x49b46dc6, 0x49b2b571, 0x49b4d11b, 0x49b3179e, 0x49b53470, 0x49b379cb, 0x49b597c5, - 0x49b3dbf8, 0x49b5fb1a, 0x49b43e24, 0x49b65e70, 0x49b4a051, 0x49b6c1c5, 0x49b5027e, 0x49b7251a, - 0x49b564aa, 0x49b7886f, 0x49b5c6d7, 0x49b7ebc4, 0x49b62904, 0x49b84f1a, 0x49b68b31, 0x49b8b26f, - 0x49b6ed5d, 0x49b915c4, 0x49b74f8a, 0x49b97919, 0x49b7b1b7, 0x49b9dc6e, 0x49b813e4, 0x49ba3fc4, - 0x49b87610, 0x49baa319, 0x49b8d83d, 0x49bb066e, 0x49b93a6a, 0x49bb69c3, 0x49b99c97, 0x49bbcd18, - 0x49b9fec3, 0x49bc306e, 0x49ba60f0, 0x49bc93c3, 0x49bac31d, 0x49bcf718, 0x49bb254a, 0x49bd5a6d, - 0x49bb8776, 0x49bdbdc2, 0x49bbe9a3, 0x49be2118, 0x49bc4bd0, 0x49be846d, 0x49bcadfd, 0x49bee7c2, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbd8c4d2d, 0xbf7be5bb, 0xbd144cb1, 0xbf622da0, 0xbb7d74f4, 0xbecf26fc, 0x3ce944a0, 0x3e7d91f3, - 0xbd8356e7, 0x3f3635ad, 0xbd0258ad, 0x3f7e6521, 0x3a07d6eb, 0x3f599c64, 0x3d0696d3, 0x3eaf3a2f, - 0xbd74bff5, 0xbe9fd34f, 0xbce0c80b, 0xbf41e10b, 0x3ba0b01f, 0xbf7fbe3e, 0x3d188aac, 0xbf500f6c, - 0xbd62d0e9, 0xbe8e82ad, 0xbcbcdda1, 0x3ec024c2, 0x3c18324b, 0x3f4cac20, 0x3d2a7dc5, 0x3f7fef82, - 0xbd50e0be, 0x3f4591c4, 0xbc98f248, 0x3e5a4ca0, 0x3c600bc7, 0xbedf97ee, 0x3d3c7007, 0xbf568a72, - 0xbd3eef8d, 0xbf7ef8b5, 0xbc6a0c5d, 0xbf3a2f90, 0x3c93f214, 0xbe16975e, 0xbd989fe0, 0x3ec4a0f2, - 0xbd2cfd6b, 0x3f5f7095, 0xbc223303, 0x3f7cdaf4, 0x3cb7dd8a, 0x3f2df5fa, 0xbd8faa90, 0x3da467d0, - 0xbd1b0a6e, 0xbee3f1de, 0xbbb4b1ba, 0xbf67543d, 0x3cdbc819, 0xbf7998b2, 0xbd86b48a, 0xbf20f327, - 0xbd0916ae, 0xbc5715a0, 0xba93f225, 0x3f011d8d, 0x3cffb192, 0x3f6e2c4c, 0xbd7b7bb6, 0x3f7535b4, - 0xbcee4484, 0x3f133624, 0x3b5571ac, 0xbd5d8304, 0x3d11cce5, 0xbf0facce, 0xbd698d1b, 0xbf73f0d5, - 0xbcca5a7e, 0xbf6fb70c, 0x3bfa6dae, 0xbf04ced6, 0x3d23c048, 0x3df7e598, 0xbd579d59, 0x3f1d95db, - 0xbca66f7a, 0x3f789b2d, 0x3c4510a6, 0x3f692317, 0x3d35b2de, 0x3eeb9bca, 0xbd45ac88, 0xbd821d64, - 0xbc8283a3, 0xbf2ac89d, 0x3c8674be, 0xbf7c25ee, 0x3d47a48e, 0xbf618170, 0xbd33babd, 0xbecc895b, - 0xbc3d2e51, 0x3e059155, 0x3caa607f, 0x3f3735ce, 0xbd9307d9, 0x3f7e8d00, 0xbd21c810, 0x3f58daeb, - 0xbbeaa8da, 0x3eac8a50, 0x3cce4b6a, 0xbe497976, 0xbd8a1216, 0xbf42cf0f, 0xbd0fd497, 0xbf7fcd9a, - 0xbb35e7d3, 0xbf4f398a, 0x3cf23551, 0xbe8bc3ac, 0xbd811ba5, 0x3e863c42, 0xbcfbc0d2, 0x3f4d86f4, - 0x3ad305e6, 0x3f7fe649, 0x3d0b0f03, 0x3f44a872, 0xbd704924, 0x3e54b6b5, 0xbcd7d738, 0xbea72081, - 0x3bc4769a, 0xbf575118, 0x3d1d02af, 0xbf7ed6f3, 0xbd5e59ce, 0xbf3933da, 0xbcb3ec8e, 0xbe10f000, - 0x3c2a1561, 0x3ec7436a, 0x3d2ef594, 0x3f602228, 0xbd4c6960, 0x3f7ca0cf, 0xbc900101, 0x3f2ce904, - 0x3c71ee9f, 0x3e4b3834, 0x3d40e79d, 0xbee67fd1, 0xbd3a77f0, 0xbf67eff0, 0xbc58297d, 0xbf79466d, - 0x3c9ce356, 0xbf1fd628, 0xbd966507, 0xbe07551e, 0xbd288596, 0x3f0258ca, 0xbc104fe8, 0x3f6eb16a, - 0x3cc0ce97, 0x3f74cbae, 0xbd8d6f89, 0x3f120a65, 0xbd169267, 0x3d85aaf5, 0xbb90eb39, 0xbf10dae2, - 0x3ce4b8e5, 0xbf745ec5, 0xbd847958, 0xbf6f35c1, 0xbd049e7a, 0xbf0395b2, 0xb81af629, 0x3afbbcc7, - 0x3d045109, 0x3f1eb568, 0xbd770502, 0x3f78f16f, 0xbce553cb, 0x3f688b1c, 0x3b8e7f62, 0x3ee9118d, - 0x3d1644f9, 0xbd8d844e, 0xbd65161b, 0xbf2bd856, 0xbcc16982, 0xbf7c641f, 0x3c0f19ff, 0xbf60d375, - 0x3d28382b, 0xbf017fe1, 0xbd532614, 0x3e0b3afa, 0xbc9d7e45, 0x3f383479, 0x3c56f398, 0x3f7eb2d6, - 0x3d3a2a8a, 0x3f5817b9, 0xbd413502, 0x3ee4bdd1, 0xbc732483, 0xbe4f12bd, 0x3c8f6611, 0xbf43bb85, - 0xbd99c21c, 0xbf7fdaeb, 0xbd2f42fd, 0xbf4e6203, 0xbc2b4b49, 0xbec57343, 0x3cb351a1, 0x3e88fd7a, - 0xbd90cce3, 0x3f4e6025, 0xbd1d501b, 0x3f7fdb06, 0xbbc6e270, 0x3f43bd8e, 0x3cd73c4f, 0x3ea5444b, - 0xbd87d6f4, 0xbea9d31d, 0xbd0b5c73, 0xbf581608, 0xbadcb547, 0xbf7eb328, 0x3cfb25ee, 0xbf3836aa, - 0xbd7dc0b4, 0xbe845625, 0xbcf2d036, 0x3ec9e44c, 0x3b311023, 0x3f60d1f2, 0x3d0f8728, 0x3f7c64a6, - 0xbd6bd23f, 0x3f2bdaac, 0xbccee654, 0x3e459dd0, 0x3be83d05, 0xbee90bee, 0x3d217aa5, 0xbf6889ca, -] )) ), - -################ chunk 20480 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x49bd1029, 0x49bf4b17, 0x49bd7256, 0x49bfae6d, 0x49bdd483, 0x49c011c2, 0x49be36b0, 0x49c07517, - 0x49be98dc, 0x49c0d86c, 0x49befb09, 0x49c13bc1, 0x49bf5d36, 0x49c19f17, 0x49bfbf62, 0x49c2026c, - 0x49c0218f, 0x49c265c1, 0x49c083bc, 0x49c2c916, 0x49c0e5e9, 0x49c32c6b, 0x49c14815, 0x49c38fc1, - 0x49c1aa42, 0x49c3f316, 0x49c20c6f, 0x49c4566b, 0x49c26e9c, 0x49c4b9c0, 0x49c2d0c8, 0x49c51d15, - 0x49c332f5, 0x49c5806b, 0x49c39522, 0x49c5e3c0, 0x49c3f74f, 0x49c64715, 0x49c4597b, 0x49c6aa6a, - 0x49c4bba8, 0x49c70dbf, 0x49c51dd5, 0x49c77115, 0x49c58002, 0x49c7d46a, 0x49c5e22e, 0x49c837bf, - 0x49c6445b, 0x49c89b14, 0x49c6a688, 0x49c8fe6a, 0x49c708b5, 0x49c961bf, 0x49c76ae1, 0x49c9c514, - 0x49c7cd0e, 0x49ca2869, 0x49c82f3b, 0x49ca8bbe, 0x49c89168, 0x49caef14, 0x49c8f394, 0x49cb5269, - 0x49c955c1, 0x49cbb5be, 0x49c9b7ee, 0x49cc1913, 0x49ca1a1a, 0x49cc7c68, 0x49ca7c47, 0x49ccdfbe, - 0x49cade74, 0x49cd4313, 0x49cb40a1, 0x49cda668, 0x49cba2cd, 0x49ce09bd, 0x49cc04fa, 0x49ce6d12, - 0x49cc6727, 0x49ced068, 0x49ccc954, 0x49cf33bd, 0x49cd2b80, 0x49cf9712, 0x49cd8dad, 0x49cffa67, - 0x49cdefda, 0x49d05dbc, 0x49ce5207, 0x49d0c112, 0x49ceb433, 0x49d12467, 0x49cf1660, 0x49d187bc, - 0x49cf788d, 0x49d1eb11, 0x49cfdaba, 0x49d24e66, 0x49d03ce6, 0x49d2b1bc, 0x49d09f13, 0x49d31511, - 0x49d10140, 0x49d37866, 0x49d1636d, 0x49d3dbbb, 0x49d1c599, 0x49d43f11, 0x49d227c6, 0x49d4a266, - 0x49d289f3, 0x49d505bb, 0x49d2ec20, 0x49d56910, 0x49d34e4c, 0x49d5cc65, 0x49d3b079, 0x49d62fbb, - 0x49d412a6, 0x49d69310, 0x49d474d2, 0x49d6f665, 0x49d4d6ff, 0x49d759ba, 0x49d5392c, 0x49d7bd0f, - 0x49d59b59, 0x49d82065, 0x49d5fd85, 0x49d883ba, 0x49d65fb2, 0x49d8e70f, 0x49d6c1df, 0x49d94a64, - 0x49d7240c, 0x49d9adb9, 0x49d78638, 0x49da110f, 0x49d7e865, 0x49da7464, 0x49d84a92, 0x49dad7b9, - 0x49d8acbf, 0x49db3b0e, 0x49d90eeb, 0x49db9e63, 0x49d97118, 0x49dc01b9, 0x49d9d345, 0x49dc650e, - 0x49da3572, 0x49dcc863, 0x49da979e, 0x49dd2bb8, 0x49daf9cb, 0x49dd8f0e, 0x49db5bf8, 0x49ddf263, - 0x49dbbe25, 0x49de55b8, 0x49dc2051, 0x49deb90d, 0x49dc827e, 0x49df1c62, 0x49dce4ab, 0x49df7fb8, - 0x49dd46d8, 0x49dfe30d, 0x49dda904, 0x49e04662, 0x49de0b31, 0x49e0a9b7, 0x49de6d5e, 0x49e10d0c, - 0x49decf8b, 0x49e17062, 0x49df31b7, 0x49e1d3b7, 0x49df93e4, 0x49e2370c, 0x49dff611, 0x49e29a61, - 0x49e0583d, 0x49e2fdb6, 0x49e0ba6a, 0x49e3610c, 0x49e11c97, 0x49e3c461, 0x49e17ec4, 0x49e427b6, - 0x49e1e0f0, 0x49e48b0b, 0x49e2431d, 0x49e4ee60, 0x49e2a54a, 0x49e551b6, 0x49e30777, 0x49e5b50b, - 0x49e369a3, 0x49e61860, 0x49e3cbd0, 0x49e67bb5, 0x49e42dfd, 0x49e6df0a, 0x49e4902a, 0x49e74260, - 0x49e4f256, 0x49e7a5b5, 0x49e55483, 0x49e8090a, 0x49e5b6b0, 0x49e86c5f, 0x49e618dd, 0x49e8cfb5, - 0x49e67b09, 0x49e9330a, 0x49e6dd36, 0x49e9965f, 0x49e73f63, 0x49e9f9b4, 0x49e7a190, 0x49ea5d09, - 0x49e803bc, 0x49eac05f, 0x49e865e9, 0x49eb23b4, 0x49e8c816, 0x49eb8709, 0x49e92a43, 0x49ebea5e, - 0x49e98c6f, 0x49ec4db3, 0x49e9ee9c, 0x49ecb109, 0x49ea50c9, 0x49ed145e, 0x49eab2f5, 0x49ed77b3, - 0x49eb1522, 0x49eddb08, 0x49eb774f, 0x49ee3e5d, 0x49ebd97c, 0x49eea1b3, 0x49ec3ba8, 0x49ef0508, - 0x49ec9dd5, 0x49ef685d, 0x49ed0002, 0x49efcbb2, 0x49ed622f, 0x49f02f07, 0x49edc45b, 0x49f0925d, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbd59e2a2, 0xbf78f22b, 0xbcaafb6d, 0xbf3685a2, 0x3c3bf86a, 0xbe01aabd, 0x3d336d55, 0x3f0392fd, - 0xbd47f1f2, 0x3f6f34a2, 0xbc870faf, 0x3f745fb5, 0x3c81e8b2, 0x3f2a0cc2, 0xbd9d1f14, 0x3d7486a3, - 0xbd360045, 0xbf1207ce, 0xbc46468c, 0xbf74cac2, 0x3ca5d48c, 0xbf6eb28e, 0xbd942a23, 0xbf1ccf2c, - 0xbd240db4, 0x3bf5c452, 0xbbfcd982, 0x3f1fd3b1, 0x3cc9bf94, 0x3f7945b5, 0xbd8b3478, 0x3f67f146, - 0xbd121a53, 0x3f0edc2f, 0xbb5a495b, 0xbd98ea17, 0x3ceda99e, 0xbf2ce6b0, 0xbd823e1c, 0xbf7ca04c, - 0xbd00263b, 0xbf6023ae, 0x3a8a42c3, 0xbf0043ef, 0x3d08c93e, 0x3e10e382, 0xbd728e3a, 0x3f3931ac, - 0xbcdc6301, 0x3f7ed6a6, 0x3bb245e3, 0x3f66e7fb, 0x3d1abd01, 0x3ee22e9d, 0xbd609f09, 0xbe54aa5d, - 0xbcb87877, 0xbf44a66c, 0x3c20fd1b, 0xbf7fe633, 0x3d2cb001, 0xbf5ef54c, 0xbd4eaebd, 0xbec2cfb5, - 0xbc948d04, 0x3e8bbd9a, 0x3c68d679, 0x3f4f37b0, 0xbda07bf1, 0x3f7fcdb9, 0xbd3cbd6d, 0x3f5600b1, - 0xbc6141ac, 0x3ea28f72, 0x3c985759, 0xbeac845f, 0xbd978749, 0xbf58d93e, 0xbd2acb2f, 0xbf7e8d55, - 0xbc196834, 0xbf4c1488, 0x3cbc42b5, 0xbe819322, 0xbd8e91e2, 0x3ecc8392, 0xbd18d81a, 0x3f617ff2, - 0xbba31bf6, 0x3f7c267a, 0x3ce02d24, 0x3f413c49, 0xbd859bc8, 0x3e4001da, 0xbd06e443, 0xbeeb9630, - 0xba1b35b0, 0xbf6921ca, 0x3d020b3c, 0xbf789bee, 0xbd794a09, 0xbf358481, 0xbce9df86, 0xbdf7fea6, - 0x3b789d45, 0x3f04cc23, 0x3d13ff42, 0x3f6fb5f1, 0xbd675b49, 0x3f7bb85e, 0xbcc5f55f, 0x3f28fabe, - 0x3c0601af, 0x3d5db56a, 0x3d25f28e, 0xbf133390, 0xbd556b65, 0xbf7534cc, 0xbca20a3f, 0xbf78050a, - 0x3c4ddb64, 0xbf1bad81, 0xbda3d8b2, 0x3c564bbe, 0xbd437a74, 0x3f20f0b3, 0xbc7c3ca4, 0x3f7997ff, - 0x3c8ada0b, 0x3f7332cd, 0xbd9ae454, 0x3f0dac2e, 0xbd31888c, 0xbda44ea8, 0xbc34638c, 0xbf2df3aa, - 0x3caec5b4, 0xbf7cda76, 0xbd91ef34, 0xbf6d473a, 0xbd1f95c5, 0xbefe0dee, 0xbbd91321, 0x3e168ae3, - 0x3cd2b082, 0x3f3a2d66, 0xbd88f95b, 0x3f7ef86d, 0xbd0da234, 0x3f66492c, 0xbb12bc33, 0x3edf9d9b, - 0x3cf69a46, 0xbe5a404c, 0xbd8002d6, 0xbf458fc3, 0xbcf75be3, 0xbf7d388e, 0x3b0cae96, 0xbf5e40b7, - 0x3d0d4169, 0xbec02a9b, 0xbd6e175f, 0x3e8e7c9e, 0xbcd37225, 0x3f500d95, 0x3bd60c57, 0x3f7f2d19, - 0x3d1f34fe, 0x3f553729, 0xbd5c27e6, 0x3e9fd94e, 0xbcaf875d, 0xbeaf3441, 0x3c32e02a, 0xbf599aba, - 0x3d3127c9, 0xbf7ffa74, 0xbd4a3757, 0xbf4b36f4, 0xbc8b9bb7, 0xbe7d9e2d, 0x3c7ab948, 0x3ecf2137, - 0xbd9e4144, 0x3f622c25, 0xbd3845ca, 0x3f7f9fb0, 0xbc4f5ec3, 0x3f404baa, 0x3ca14895, 0x3e3a645c, - 0xbd954c6b, 0xbeee1e91, 0xbd265354, 0xbf69b7ed, 0xbc078513, 0xbf7e1d37, 0x3cc533ba, 0xbf3481ee, - 0xbd8c56d7, 0xbdeca5d8, 0xbd14600c, 0x3f06043b, 0xbb7eaadf, 0x3f703557, 0x3ce91de7, 0x3f7b74c8, - 0xbd836091, 0x3f27e762, 0xbd026c09, 0x3d46e26d, 0x3a02ff3a, 0xbf145e25, 0x3d068377, 0xbf6ab275, - 0xbd74d34b, 0xbf77a976, 0xbce0eec5, 0xbf1a8a9a, 0x3ba0152a, 0x3c98d9cf, 0x3d187751, 0x3f220c6d, - 0xbd62e440, 0x3f710929, 0xbcbd045c, 0x3f72bfa5, 0x3c17e4d1, 0x3f0c7b0c, 0x3d2a6a6b, 0xbdafb1ea, - 0xbd50f417, 0xbf2eff40, 0xbc991904, 0xbf764909, 0x3c5fbe4e, 0xbf6cbd04, 0xbda19e17, 0xbefb91f7, - 0xbd3f02e6, 0x3e1c3110, 0xbc6a59d6, 0x3f3b27a3, 0x3c93cb58, 0x3f7a6c01, 0xbd98a988, 0x3f65a887, - 0xbd2d10c5, 0x3edd0ad1, 0xbc22807d, 0xbe5fd47d, 0x3cb7b6cf, 0xbf467785, 0xbd8fb439, 0xbf7d6d48, -] )) ), - -################ chunk 20992 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x49ee2688, 0x49f0f5b2, 0x49ee88b5, 0x49f15907, 0x49eeeae2, 0x49f1bc5c, 0x49ef4d0e, 0x49f21fb2, - 0x49efaf3b, 0x49f28307, 0x49f01168, 0x49f2e65c, 0x49f07395, 0x49f349b1, 0x49f0d5c1, 0x49f3ad06, - 0x49f137ee, 0x49f4105c, 0x49f19a1b, 0x49f473b1, 0x49f1fc48, 0x49f4d706, 0x49f25e74, 0x49f53a5b, - 0x49f2c0a1, 0x49f59db0, 0x49f322ce, 0x49f60106, 0x49f384fb, 0x49f6645b, 0x49f3e727, 0x49f6c7b0, - 0x49f44954, 0x49f72b05, 0x49f4ab81, 0x49f78e5a, 0x49f50dad, 0x49f7f1b0, 0x49f56fda, 0x49f85505, - 0x49f5d207, 0x49f8b85a, 0x49f63434, 0x49f91baf, 0x49f69660, 0x49f97f04, 0x49f6f88d, 0x49f9e25a, - 0x49f75aba, 0x49fa45af, 0x49f7bce7, 0x49faa904, 0x49f81f13, 0x49fb0c59, 0x49f88140, 0x49fb6fae, - 0x49f8e36d, 0x49fbd304, 0x49f9459a, 0x49fc3659, 0x49f9a7c6, 0x49fc99ae, 0x49fa09f3, 0x49fcfd03, - 0x49fa6c20, 0x49fd6059, 0x49face4d, 0x49fdc3ae, 0x49fb3079, 0x49fe2703, 0x49fb92a6, 0x49fe8a58, - 0x49fbf4d3, 0x49feedad, 0x49fc5700, 0x49ff5103, 0x49fcb92c, 0x49ffb458, 0x49fd1b59, 0x4a000bd6, - 0x49fd7d86, 0x4a003d81, 0x49fddfb3, 0x4a006f2c, 0x49fe41df, 0x4a00a0d6, 0x49fea40c, 0x4a00d281, - 0x49ff0639, 0x4a01042c, 0x49ff6865, 0x4a0135d6, 0x49ffca92, 0x4a016781, 0x4a00165f, 0x4a01992b, - 0x4a004776, 0x4a01cad6, 0x4a00788c, 0x4a01fc81, 0x4a00a9a3, 0x4a022e2b, 0x4a00dab9, 0x4a025fd6, - 0x4a010bcf, 0x4a029180, 0x4a013ce6, 0x4a02c32b, 0x4a016dfc, 0x4a02f4d6, 0x4a019f12, 0x4a032680, - 0x4a01d029, 0x4a03582b, 0x4a02013f, 0x4a0389d5, 0x4a023256, 0x4a03bb80, 0x4a02636c, 0x4a03ed2b, - 0x4a029482, 0x4a041ed5, 0x4a02c599, 0x4a045080, 0x4a02f6af, 0x4a04822a, 0x4a0327c5, 0x4a04b3d5, - 0x4a0358dc, 0x4a04e580, 0x4a0389f2, 0x4a05172a, 0x4a03bb09, 0x4a0548d5, 0x4a03ec1f, 0x4a057a7f, - 0x4a041d35, 0x4a05ac2a, 0x4a044e4c, 0x4a05ddd5, 0x4a047f62, 0x4a060f7f, 0x4a04b078, 0x4a06412a, - 0x4a04e18f, 0x4a0672d4, 0x4a0512a5, 0x4a06a47f, 0x4a0543bb, 0x4a06d62a, 0x4a0574d2, 0x4a0707d4, - 0x4a05a5e8, 0x4a07397f, 0x4a05d6ff, 0x4a076b29, 0x4a060815, 0x4a079cd4, 0x4a06392b, 0x4a07ce7f, - 0x4a066a42, 0x4a080029, 0x4a069b58, 0x4a0831d4, 0x4a06cc6e, 0x4a08637e, 0x4a06fd85, 0x4a089529, - 0x4a072e9b, 0x4a08c6d4, 0x4a075fb2, 0x4a08f87e, 0x4a0790c8, 0x4a092a29, 0x4a07c1de, 0x4a095bd3, - 0x4a07f2f5, 0x4a098d7e, 0x4a08240b, 0x4a09bf29, 0x4a085521, 0x4a09f0d3, 0x4a088638, 0x4a0a227e, - 0x4a08b74e, 0x4a0a5428, 0x4a08e865, 0x4a0a85d3, 0x4a09197b, 0x4a0ab77e, 0x4a094a91, 0x4a0ae928, - 0x4a097ba8, 0x4a0b1ad3, 0x4a09acbe, 0x4a0b4c7e, 0x4a09ddd4, 0x4a0b7e28, 0x4a0a0eeb, 0x4a0bafd3, - 0x4a0a4001, 0x4a0be17d, 0x4a0a7117, 0x4a0c1328, 0x4a0aa22e, 0x4a0c44d3, 0x4a0ad344, 0x4a0c767d, - 0x4a0b045b, 0x4a0ca828, 0x4a0b3571, 0x4a0cd9d2, 0x4a0b6687, 0x4a0d0b7d, 0x4a0b979e, 0x4a0d3d28, - 0x4a0bc8b4, 0x4a0d6ed2, 0x4a0bf9ca, 0x4a0da07d, 0x4a0c2ae1, 0x4a0dd227, 0x4a0c5bf7, 0x4a0e03d2, - 0x4a0c8d0e, 0x4a0e357d, 0x4a0cbe24, 0x4a0e6727, 0x4a0cef3a, 0x4a0e98d2, 0x4a0d2051, 0x4a0eca7c, - 0x4a0d5167, 0x4a0efc27, 0x4a0d827d, 0x4a0f2dd2, 0x4a0db394, 0x4a0f5f7c, 0x4a0de4aa, 0x4a0f9127, - 0x4a0e15c1, 0x4a0fc2d1, 0x4a0e46d7, 0x4a0ff47c, 0x4a0e77ed, 0x4a102627, 0x4a0ea904, 0x4a1057d1, - 0x4a0eda1a, 0x4a10897c, 0x4a0f0b30, 0x4a10bb26, 0x4a0f3c47, 0x4a10ecd1, 0x4a0f6d5d, 0x4a111e7c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbd1b1dc9, 0xbf5d8a5d, 0xbbb54caf, 0xbebd83f8, 0x3cdba15f, 0x3e913a7e, 0xbd86be34, 0x3f3ccce4, - 0xbd092a0a, 0x3f7f4965, 0xba965dfe, 0x3f546bed, 0x3cff8ada, 0x3e9d21e3, 0xbd7b8f0c, 0xbeb1e2bd, - 0xbcee6b3d, 0xbf47fd36, 0x3b543bc0, 0xbf7ffe31, 0x3d11b989, 0xbf4a57c1, 0xbd69a072, 0xbe781411, - 0xbcca8139, 0x3ed1bd35, 0x3bf9d2b9, 0x3f52462e, 0x3d23acee, 0x3f7f8ada, 0xbd57b0b1, 0x3f3f5983, - 0xbca69635, 0x3e34c561, 0x3c44c32c, 0xbef0a50c, 0xbda4face, 0xbf5b9be7, 0xbd45bfe1, 0xbf7defe6, - 0xbc82aa60, 0xbf337dea, 0x3c864e02, 0xbde14b28, 0xbd9c068a, 0x3f073b41, 0xbd33ce17, 0x3f63f394, - 0xbc3d7bcb, 0x3f7b2f31, 0x3caa39c4, 0x3f26d2ae, 0xbd931182, 0x3d300dda, 0xbd21db6b, 0xbf15878c, - 0xbbeb43cf, 0xbf6b4390, 0x3cce24b0, 0xbf774be9, 0xbd8a1bc0, 0xbf196677, 0xbd0fe7f3, 0x3cc68c87, - 0xbb371dbf, 0x3f09489b, 0x3cf20e98, 0x3f718363, 0xbd812550, 0x3f724a8e, 0xbcfbe78b, 0x3f0b48cb, - 0x3ad09a0d, 0xbdbb13c5, 0x3d0afba7, 0xbf177d86, 0xbd705c7a, 0xbf76abd5, 0xbcd7fdf2, 0xbf5e09a9, - 0x3bc3dba4, 0xbef913ff, 0x3d1cef53, 0x3d0a0b0c, 0xbd5e6d25, 0x3f3c2063, 0xbcb41349, 0x3f7ab6ec, - 0x3c29c7e7, 0x3f717f6e, 0xbda85767, 0x3eda7645, 0xbd4c7cb9, 0xbdce614a, 0xbe1186a6, 0xbf475db3, - 0x3c71a126, 0xbf7d9ffd, 0xbd9f6370, 0xbf6b3edb, 0x3da2864d, 0xbebadbd3, 0xbc5876f6, 0x3e2b6728, - 0xbdd8689e, 0x3f51b463, 0x3d52c55b, 0x3f7f63a8, 0xbd2898f0, 0x3f63ee25, 0xbe08a13e, 0x3e9a6938, - 0x3cc0a7dc, 0xbe6ed763, 0xbd8d7933, 0xbf5b187d, 0x3db46cd0, 0xbf7fffe3, 0xbb91862f, 0xbf5b95c4, - 0xbdc6899d, 0xbe7287fb, 0x3d76a455, 0x3e9899a9, 0xbd04b1d6, 0x3f637f23, 0xbdff724c, 0x3f7f73fa, - 0x3d043dad, 0x3f523f5f, 0xbd771857, 0x3e2f24f6, 0x3dc64fc7, 0xbeb9171a, 0x3b8de46c, 0xbf6ade9d, - 0xbdb4a6b3, 0xbf7dc08f, 0x3d8d3f3a, 0xbf47f5c2, 0xbcc1903d, 0xbdd5eeab, 0xbded9d13, 0x3ed8be6d, - 0x3d2824d1, 0x3f712e64, 0xbd53396c, 0x3f7ae799, 0xbe1331f2, 0x3f3cc4d4, 0x3c56a61e, 0x3d1937e0, - 0xbda2c03a, 0xbef76b06, 0x3d9f2981, 0xbf76672c, 0xbc7371fc, 0xbf76ec63, 0xbddbc32c, 0xbf30b988, - 0x3d4c08a5, 0x3cf43daa, 0xbd2f5657, 0x3f0a7cb3, 0xbe0a4d11, 0x3f7a82e9, 0x3cb32ae6, 0x3f71d389, - 0xbd90d68c, 0x3f23e1cd, 0x3db110a5, 0xbdc67423, 0xbbc77d65, 0xbf18a3b0, 0xbdc9e4f0, 0xbf7d7cdb, - 0x3d6fe874, 0xbf6ba2ef, 0xbd0b6fcf, 0xbf164c7c, 0xbe016576, 0x3e2779a4, 0x3cfaff36, 0x3f261a1a, - 0xbd7dd409, 0x3f7f5191, 0x3dc2f44d, 0x3f6461c0, 0x3b2fda37, 0x3f08094e, 0xbdb802bb, 0xbe6af77a, - 0x3d89e1c5, 0xbf32d05e, 0xbccf0d0e, 0xbf77ac7c, 0xbdf0f69f, 0xbf5c185f, 0x3d21674a, 0xbef25184, - 0xbd59f5fa, 0x3e96b2c0, 0xbe14dd25, 0x3f3eb7c7, 0x3c3baaf0, 0x3f7b7705, 0xbda61ce7, 0x3f52d063, - 0x3d9bcc99, 0x3ed3781b, 0xbc87366b, 0xbeb73b70, 0xbddf1d92, 0xbf49c291, 0x3d454bcb, 0xbf7e1ea9, - 0xbd36139f, 0xbf489487, 0xbe0bf8cb, 0xbeb3aa11, 0x3ca5add0, 0x3ed6f028, 0xbd9433cc, 0x3f53e3f5, - 0x3dadb45b, 0x3f7fa055, 0xbbfd7477, 0x3f3d70a3, 0xbdcd4020, 0x3e930c30, 0x3d692c69, 0xbef5ac3c, - 0xbd122daf, 0xbf5d103b, 0xbe0311b0, 0xbf7ffa4b, 0x3ced82e5, 0xbf31719a, 0xbd8247c7, 0xbe63886a, - 0x3dbf98b1, 0x3f09a60f, 0x3a87d6ea, 0x3f653cc7, 0xbdbb5ea3, 0x3f7f2c24, 0x3d868438, 0x3f24a54d, - 0xbcdc89bb, 0x3e1ff13d, 0xbdf45001, 0xbf17d6c4, 0x3d1aa9a6, 0xbf6c6024, 0xbd60b261, 0xbf7d36cd, -] )) ), - -################ chunk 21504 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4a0f9e73, 0x4a115026, 0x4a0fcf8a, 0x4a1181d1, 0x4a1000a0, 0x4a11b37b, 0x4a1031b7, 0x4a11e526, - 0x4a1062cd, 0x4a1216d1, 0x4a1093e3, 0x4a12487b, 0x4a10c4fa, 0x4a127a26, 0x4a10f610, 0x4a12abd0, - 0x4a112726, 0x4a12dd7b, 0x4a11583d, 0x4a130f26, 0x4a118953, 0x4a1340d0, 0x4a11ba6a, 0x4a13727b, - 0x4a11eb80, 0x4a13a425, 0x4a121c96, 0x4a13d5d0, 0x4a124dad, 0x4a14077b, 0x4a127ec3, 0x4a143925, - 0x4a12afd9, 0x4a146ad0, 0x4a12e0f0, 0x4a149c7a, 0x4a131206, 0x4a14ce25, 0x4a13431d, 0x4a14ffd0, - 0x4a137433, 0x4a15317a, 0x4a13a549, 0x4a156325, 0x4a13d660, 0x4a1594d0, 0x4a140776, 0x4a15c67a, - 0x4a14388c, 0x4a15f825, 0x4a1469a3, 0x4a1629cf, 0x4a149ab9, 0x4a165b7a, 0x4a14cbcf, 0x4a168d25, - 0x4a14fce6, 0x4a16becf, 0x4a152dfc, 0x4a16f07a, 0x4a155f13, 0x4a172224, 0x4a159029, 0x4a1753cf, - 0x4a15c13f, 0x4a17857a, 0x4a15f256, 0x4a17b724, 0x4a16236c, 0x4a17e8cf, 0x4a165482, 0x4a181a79, - 0x4a168599, 0x4a184c24, 0x4a16b6af, 0x4a187dcf, 0x4a16e7c6, 0x4a18af79, 0x4a1718dc, 0x4a18e124, - 0x4a1749f2, 0x4a1912ce, 0x4a177b09, 0x4a194479, 0x4a17ac1f, 0x4a197624, 0x4a17dd35, 0x4a19a7ce, - 0x4a180e4c, 0x4a19d979, 0x4a183f62, 0x4a1a0b23, 0x4a187079, 0x4a1a3cce, 0x4a18a18f, 0x4a1a6e79, - 0x4a18d2a5, 0x4a1aa023, 0x4a1903bc, 0x4a1ad1ce, 0x4a1934d2, 0x4a1b0378, 0x4a1965e8, 0x4a1b3523, - 0x4a1996ff, 0x4a1b66ce, 0x4a19c815, 0x4a1b9878, 0x4a19f92c, 0x4a1bca23, 0x4a1a2a42, 0x4a1bfbcd, - 0x4a1a5b58, 0x4a1c2d78, 0x4a1a8c6f, 0x4a1c5f23, 0x4a1abd85, 0x4a1c90cd, 0x4a1aee9b, 0x4a1cc278, - 0x4a1b1fb2, 0x4a1cf422, 0x4a1b50c8, 0x4a1d25cd, 0x4a1b81de, 0x4a1d5778, 0x4a1bb2f5, 0x4a1d8922, - 0x4a1be40b, 0x4a1dbacd, 0x4a1c1522, 0x4a1dec77, 0x4a1c4638, 0x4a1e1e22, 0x4a1c774e, 0x4a1e4fcd, - 0x4a1ca865, 0x4a1e8177, 0x4a1cd97b, 0x4a1eb322, 0x4a1d0a91, 0x4a1ee4cc, 0x4a1d3ba8, 0x4a1f1677, - 0x4a1d6cbe, 0x4a1f4822, 0x4a1d9dd5, 0x4a1f79cc, 0x4a1dceeb, 0x4a1fab77, 0x4a1e0001, 0x4a1fdd22, - 0x4a1e3118, 0x4a200ecc, 0x4a1e622e, 0x4a204077, 0x4a1e9344, 0x4a207221, 0x4a1ec45b, 0x4a20a3cc, - 0x4a1ef571, 0x4a20d577, 0x4a1f2688, 0x4a210721, 0x4a1f579e, 0x4a2138cc, 0x4a1f88b4, 0x4a216a76, - 0x4a1fb9cb, 0x4a219c21, 0x4a1feae1, 0x4a21cdcc, 0x4a201bf7, 0x4a21ff76, 0x4a204d0e, 0x4a223121, - 0x4a207e24, 0x4a2262cb, 0x4a20af3a, 0x4a229476, 0x4a20e051, 0x4a22c621, 0x4a211167, 0x4a22f7cb, - 0x4a21427e, 0x4a232976, 0x4a217394, 0x4a235b20, 0x4a21a4aa, 0x4a238ccb, 0x4a21d5c1, 0x4a23be76, - 0x4a2206d7, 0x4a23f020, 0x4a2237ed, 0x4a2421cb, 0x4a226904, 0x4a245375, 0x4a229a1a, 0x4a248520, - 0x4a22cb31, 0x4a24b6cb, 0x4a22fc47, 0x4a24e875, 0x4a232d5d, 0x4a251a20, 0x4a235e74, 0x4a254bca, - 0x4a238f8a, 0x4a257d75, 0x4a23c0a0, 0x4a25af20, 0x4a23f1b7, 0x4a25e0ca, 0x4a2422cd, 0x4a261275, - 0x4a2453e4, 0x4a26441f, 0x4a2484fa, 0x4a2675ca, 0x4a24b610, 0x4a26a775, 0x4a24e727, 0x4a26d91f, - 0x4a25183d, 0x4a270aca, 0x4a254953, 0x4a273c74, 0x4a257a6a, 0x4a276e1f, 0x4a25ab80, 0x4a279fca, - 0x4a25dc96, 0x4a27d174, 0x4a260dad, 0x4a28031f, 0x4a263ec3, 0x4a2834c9, 0x4a266fda, 0x4a286674, - 0x4a26a0f0, 0x4a28981f, 0x4a26d206, 0x4a28c9c9, 0x4a27031d, 0x4a28fb74, 0x4a273433, 0x4a292d1e, - 0x4a276549, 0x4a295ec9, 0x4a279660, 0x4a299074, 0x4a27c776, 0x4a29c21e, 0x4a27f88d, 0x4a29f3c9, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbe16883c, 0xbf171a88, 0x3c20afa1, 0xbdb74214, 0xbda97976, 0x3f2557d3, 0x3d986f95, 0x3f727211, - 0xbc94b3c0, 0x3f7a1c8b, 0xbde277d1, 0x3f08e0f8, 0x3d3e8ece, 0x3cb736be, 0xbd3cd0c7, 0xbf32199e, - 0xbe0da46d, 0xbf776b86, 0x3c98309d, 0xbf75e0f4, 0xbd9790f2, 0xbef4121f, 0x3daa57f2, 0x3d37b762, - 0xbc19b5ae, 0x3f3e0d61, 0xbdd09b2b, 0x3f7b46c4, 0x3d627035, 0x3f7088ee, 0xbd18eb75, 0x3ed547f7, - 0xbe04bdd3, 0xbde51acf, 0x3ce0066a, 0xbf492549, 0xbd85a572, 0xbf7dff55, 0x3dbc3cf4, 0xbf6a1aa7, - 0xba200d62, 0xbeb58716, 0xbdbeba6a, 0x3e36a872, 0x3d832693, 0x3f2903b6, 0xbcea0640, 0x3f7f9212, - 0xbdf7a937, 0x3f629d90, 0x3d13ebe7, 0x3e94f436, 0xbd676ea0, 0xbe79f030, 0xbe18333a, 0xbf358cec, - 0x3c05b435, 0xbf7ffd2a, 0xbdacd5e7, 0xbf5a1a52, 0x3d951277, 0xbe676a0d, 0xbca230fa, 0x3e9e0b67, - 0xbde5d1e8, 0x3f41441d, 0x3d37d1af, 0x3f7f4020, 0xbd438dcd, 0x3f509ac7, 0xbe0f4ff5, 0x3e23dffb, - 0x3c8ab34f, 0xbebe67e1, 0xbd9aedfd, 0xbf4c1bbc, 0x3da6fb6a, 0xbf7d5bd0, 0xbc34b106, 0xbf4629ec, - 0xbdd3f612, 0xbdbf30ad, 0x3d5bb3d8, 0x3edde819, 0xbd1fa920, 0x3f56073e, 0xbe0669dd, 0x3f7a526a, - 0x3cd289c7, 0x3f3ad3d3, 0xbd890305, 0x3cd710e1, 0x3db8e114, 0xbefc679c, 0xbb13f21f, 0xbf5efb29, - 0xbdc2160f, 0xbf762770, 0x3d7f91ae, 0xbf2ea59b, 0xbcf7829c, 0x3d27ccde, 0xbdfb0241, 0x3f0ce192, - 0x3d0d2e0d, 0x3f66ed22, 0xbd6e2ab5, 0x3f70dfb6, 0x3dcac31a, 0x3f21ad5b, 0x3bd57161, 0xbddd3008, - 0xbdb0323a, 0xbf1aec5d, 0x3d91b53d, 0xbf6dd3f8, 0xbcafae18, 0xbf6a8157, 0xbde92bd5, 0xbf13fa13, - 0x3d31146f, 0x3e32bce1, 0xbd4a4ab0, 0x3f2843f0, 0xbe10fb63, 0x3f73a7ae, 0x3c7a6bcf, 0x3f6313b2, - 0xbd9e4aec, 0x3f059b9d, 0x3da39ec5, 0xbe7612fa, 0xbc4fac3d, 0xbf34d8dd, 0xbdd750d2, 0xbf786189, - 0x3d54f754, 0xbf5a9f5c, 0xbd2666ae, 0xbeed4530, 0xbe0815d0, 0x3e9c2635, 0x3cc50cff, 0x3f409c96, - 0xbd8c6080, 0x3f7bfc0e, 0x3db58514, 0x3f512e20, 0xbb7fe0cb, 0x3ece40ac, 0xbdc57191, 0xbe01da19, - 0x3d78d608, 0xbf4b817e, 0xbd027f66, 0xbf7e7315, 0xbdfe5b1e, 0xbf46cae8, 0x3d06701b, 0xbeae4d90, - 0xbd74e6a1, 0x3e45ccaa, 0x3dc767cf, 0x3f557afb, 0x3b9f7a34, 0x3f7fc3c2, 0xbdb38e6d, 0x3f3b81ba, - 0x3d8e57ea, 0x3e8d90d2, 0xbcbd2b16, 0xbe846d35, 0xbdec859a, 0xbf5e7d84, 0x3d2a5710, 0xbf7fec91, - 0xbd51076f, 0xbf2f5fa2, 0xbe12a6b8, 0xbe58609f, 0x3c5f70d5, 0x3ea55ae3, 0xbda1a7bf, 0x3f667eab, - 0x3da04203, 0x3f7eed51, 0xbc6aa74f, 0x3f2272ab, 0xbddaab6c, 0x3e14a54c, 0x3d4e3aab, 0xbec58949, - 0xbd2d241f, 0xbf6d7530, 0xbe09c1ab, 0xbf7cc72b, 0x3cb79014, 0xbf14c9c9, 0xbd8fbde2, 0xbda07c09, - 0x3db228f3, 0x3ee4d32c, 0xbbb5e7a5, 0x3f735903, 0xbdc8ccf0, 0x3f797c9a, 0x3d721a35, 0x3f0674c7, - 0xbd093d66, 0x3c379e9e, 0xbe00d9e7, 0xbf018a2d, 0x3cff6421, 0xbf782354, 0xbd7ba261, 0xbf75116e, - 0x3dc40c62, 0xbeef0878, 0x3b5305d4, 0x3d655ddd, 0xbdb6ea80, 0x3f1014ea, 0x3d8afa7e, 0x3f7bce9a, - 0xbccaa7f3, 0x3f6f8ac2, 0xbdefdf34, 0x3ed012dd, 0x3d239993, 0xbdfbcd06, 0xbd57c409, 0xbf1df8fa, - 0xbe1451f3, 0xbf7e5694, 0x3c4475b2, 0xbf68eefc, 0xbda50475, 0xbeb02c8f, 0x3d9ce524, 0x3e41e3ea, - 0xbc82d11c, 0x3f2b264c, 0xbdde05df, 0x3f7fb856, 0x3d477ddc, 0x3f6145c1, 0xbd33e171, 0x3e8f7a74, - 0xbe0b6d6d, 0xbe828083, 0x3caa1309, 0xbf378da1, 0xbd931b2b, 0xbf7ff247, 0x3daeccb3, 0xbf5897ed, -] )) ), - -################ chunk 22016 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4a2829a3, 0x4a2a2574, 0x4a285ab9, 0x4a2a571e, 0x4a288bd0, 0x4a2a88c9, 0x4a28bce6, 0x4a2aba73, - 0x4a28edfc, 0x4a2aec1e, 0x4a291f13, 0x4a2b1dc9, 0x4a295029, 0x4a2b4f73, 0x4a298140, 0x4a2b811e, - 0x4a29b256, 0x4a2bb2c8, 0x4a29e36c, 0x4a2be473, 0x4a2a1483, 0x4a2c161e, 0x4a2a4599, 0x4a2c47c8, - 0x4a2a76af, 0x4a2c7973, 0x4a2aa7c6, 0x4a2cab1d, 0x4a2ad8dc, 0x4a2cdcc8, 0x4a2b09f2, 0x4a2d0e73, - 0x4a2b3b09, 0x4a2d401d, 0x4a2b6c1f, 0x4a2d71c8, 0x4a2b9d36, 0x4a2da372, 0x4a2bce4c, 0x4a2dd51d, - 0x4a2bff62, 0x4a2e06c8, 0x4a2c3079, 0x4a2e3872, 0x4a2c618f, 0x4a2e6a1d, 0x4a2c92a5, 0x4a2e9bc7, - 0x4a2cc3bc, 0x4a2ecd72, 0x4a2cf4d2, 0x4a2eff1d, 0x4a2d25e9, 0x4a2f30c7, 0x4a2d56ff, 0x4a2f6272, - 0x4a2d8815, 0x4a2f941c, 0x4a2db92c, 0x4a2fc5c7, 0x4a2dea42, 0x4a2ff772, 0x4a2e1b58, 0x4a30291c, - 0x4a2e4c6f, 0x4a305ac7, 0x4a2e7d85, 0x4a308c71, 0x4a2eae9c, 0x4a30be1c, 0x4a2edfb2, 0x4a30efc7, - 0x4a2f10c8, 0x4a312171, 0x4a2f41df, 0x4a31531c, 0x4a2f72f5, 0x4a3184c6, 0x4a2fa40b, 0x4a31b671, - 0x4a2fd522, 0x4a31e81c, 0x4a300638, 0x4a3219c6, 0x4a30374e, 0x4a324b71, 0x4a306865, 0x4a327d1b, - 0x4a30997b, 0x4a32aec6, 0x4a30ca92, 0x4a32e071, 0x4a30fba8, 0x4a33121b, 0x4a312cbe, 0x4a3343c6, - 0x4a315dd5, 0x4a337570, 0x4a318eeb, 0x4a33a71b, 0x4a31c001, 0x4a33d8c6, 0x4a31f118, 0x4a340a70, - 0x4a32222e, 0x4a343c1b, 0x4a325345, 0x4a346dc6, 0x4a32845b, 0x4a349f70, 0x4a32b571, 0x4a34d11b, - 0x4a32e688, 0x4a3502c5, 0x4a33179e, 0x4a353470, 0x4a3348b4, 0x4a35661b, 0x4a3379cb, 0x4a3597c5, - 0x4a33aae1, 0x4a35c970, 0x4a33dbf8, 0x4a35fb1a, 0x4a340d0e, 0x4a362cc5, 0x4a343e24, 0x4a365e70, - 0x4a346f3b, 0x4a36901a, 0x4a34a051, 0x4a36c1c5, 0x4a34d167, 0x4a36f36f, 0x4a35027e, 0x4a37251a, - 0x4a353394, 0x4a3756c5, 0x4a3564aa, 0x4a37886f, 0x4a3595c1, 0x4a37ba1a, 0x4a35c6d7, 0x4a37ebc4, - 0x4a35f7ee, 0x4a381d6f, 0x4a362904, 0x4a384f1a, 0x4a365a1a, 0x4a3880c4, 0x4a368b31, 0x4a38b26f, - 0x4a36bc47, 0x4a38e419, 0x4a36ed5d, 0x4a3915c4, 0x4a371e74, 0x4a39476f, 0x4a374f8a, 0x4a397919, - 0x4a3780a1, 0x4a39aac4, 0x4a37b1b7, 0x4a39dc6e, 0x4a37e2cd, 0x4a3a0e19, 0x4a3813e4, 0x4a3a3fc4, - 0x4a3844fa, 0x4a3a716e, 0x4a387610, 0x4a3aa319, 0x4a38a727, 0x4a3ad4c3, 0x4a38d83d, 0x4a3b066e, - 0x4a390954, 0x4a3b3819, 0x4a393a6a, 0x4a3b69c3, 0x4a396b80, 0x4a3b9b6e, 0x4a399c97, 0x4a3bcd18, - 0x4a39cdad, 0x4a3bfec3, 0x4a39fec3, 0x4a3c306e, 0x4a3a2fda, 0x4a3c6218, 0x4a3a60f0, 0x4a3c93c3, - 0x4a3a9206, 0x4a3cc56d, 0x4a3ac31d, 0x4a3cf718, 0x4a3af433, 0x4a3d28c3, 0x4a3b254a, 0x4a3d5a6d, - 0x4a3b5660, 0x4a3d8c18, 0x4a3b8776, 0x4a3dbdc2, 0x4a3bb88d, 0x4a3def6d, 0x4a3be9a3, 0x4a3e2118, - 0x4a3c1ab9, 0x4a3e52c2, 0x4a3c4bd0, 0x4a3e846d, 0x4a3c7ce6, 0x4a3eb618, 0x4a3cadfd, 0x4a3ee7c2, - 0x4a3cdf13, 0x4a3f196d, 0x4a3d1029, 0x4a3f4b17, 0x4a3d4140, 0x4a3f7cc2, 0x4a3d7256, 0x4a3fae6d, - 0x4a3da36c, 0x4a3fe017, 0x4a3dd483, 0x4a4011c2, 0x4a3e0599, 0x4a40436c, 0x4a3e36b0, 0x4a407517, - 0x4a3e67c6, 0x4a40a6c2, 0x4a3e98dc, 0x4a40d86c, 0x4a3ec9f3, 0x4a410a17, 0x4a3efb09, 0x4a413bc1, - 0x4a3f2c1f, 0x4a416d6c, 0x4a3f5d36, 0x4a419f17, 0x4a3f8e4c, 0x4a41d0c1, 0x4a3fbf62, 0x4a42026c, - 0x49bfbf63, 0x49bfbf63, 0x49bfbf63, 0x47f12065, 0x49712065, 0x489965e8, 0x4884ba86, 0x490cebfb, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbbebdec4, 0xbee66a80, 0xbdcc282c, 0x3ea3781a, 0x3d6b5e38, 0x3f4320a0, 0xbd0ffb4f, 0x3f7f0423, - 0xbe028629, 0x3f4eef8a, 0x3cf1e7de, 0x3ec72d6c, 0xbd812efa, 0xbec3b297, 0x3dc0b0d1, 0xbf4dd1e6, - 0x3ace2e35, 0xbf7ceefd, 0xbdba4673, 0xbf4457c4, 0x3d879cf9, 0xbea709f0, 0xbcd824ac, 0x3ee30ab1, - 0xbdf338a3, 0x3f579514, 0x3d1cdbf8, 0x3f79b540, 0xbd5e807d, 0x3f38dcde, 0xbe15fd14, 0x3e862538, - 0x3c297a6d, 0xbf00ae13, 0xbda8610e, 0xbf605ede, 0x3d998829, 0xbf755aa5, 0xbc904e79, 0xbf2c8c1d, - 0xbde1602b, 0xbe494aa5, 0x3d40c0eb, 0x3f0f41f3, 0xbd3a9ea4, 0x3f68251b, 0xbe0d1917, 0x3f6fe436, - 0x3c9c95df, 0x3f1f73c2, 0xbd967859, 0x3e0561ff, 0x3dab7054, 0xbf1d3019, 0xbc10eadc, 0xbf6edecc, - 0xbdcf8343, 0xbf695846, 0x3d64a211, 0xbf11a2f2, 0xbd16b91d, 0xbd81be17, 0xbe043253, 0x3f2a686a, - 0x3ce46b71, 0x3f748429, 0xbd848cad, 0x3f61be66, 0x3dbd551e, 0x3f0329aa, 0xb89af629, 0xbb7bbca9, - 0xbdbda244, 0xbf36db99, 0x3d843f5b, 0xbf790eab, 0xbce5a13e, 0xbf591f62, 0xbdf691e8, 0xbee8314c, - 0x3d161e42, 0x3d9170c8, 0xbd653cc9, 0x3f427b41, 0xbe17a819, 0x3f7c7910, 0x3c0e7f0a, 0x3f4f8532, - 0xbdabbd89, 0x3ec902aa, 0x3d962b13, 0xbe0d2db6, 0xbc9dcbbc, 0xbf4d39ee, 0xbde4ba4f, 0xbf7ebf65, - 0x3d3a03d7, 0xbf44faf3, 0xbd415bb5, 0xbea8eb81, 0xbe0ec4a7, 0x3e50ffb6, 0x3c8f1899, 0x3f570b33, - 0xbd99d56c, 0x3f7fdf08, 0x3da813d6, 0x3f5f6ac1, 0xbc2be63d, 0x3e8810f0, 0xbdd2de35, 0xbe89eff9, - 0x3d5de5c1, 0xbf5fe3b4, 0xbd1d76d1, 0xbf7fd6ad, 0xbe05de65, 0xbf5683ee, 0x3cd6eedb, 0xbe4d31ee, - 0xbd87ea48, 0x3eaac085, 0x3db9f94a, 0x3f67b936, 0xbae18cf8, 0x3f7ea65e, 0xbdc0fdf4, 0x3f4ca4f4, - 0x3d80e1a6, 0x3e09549e, 0xbcf31da8, 0xbecacb8b, 0xbdf9eb00, 0xbf6e82a9, 0x3d0f6071, 0xbf7c4f79, - 0xbd6bf8ec, 0xbf41d93f, 0xbe195304, 0xbd89b0e0, 0x3be7071b, 0x3ee9ebf8, 0xbdaf19e6, 0x3f743833, - 0x3d92cde3, 0x3f78d4b5, 0xbcab48e4, 0x3f362d4a, 0xbde8144a, 0x3849e5fe, 0x3d3346a1, 0xbf03fee6, - 0xbd4818a3, 0xbf78d33a, 0xbe10701e, 0xbf743a18, 0x3c819b3a, 0xbf29ae98, 0xbd9d3265, 0x3d897e84, - 0x3da4b73a, 0x3f126f1e, 0xbc46e17f, 0x3f7c4e68, 0xbdd63902, 0x3f6e84f4, 0x3d57294a, 0x3f1c6b9b, - 0xbd243469, 0xbe093b9b, 0xbe078a60, 0xbf2035f0, 0x3cc9721f, 0xbf7ea5b8, 0xbd8b47cb, 0xbf67bbe5, - 0x3db69d54, 0xbf0e73ab, 0xbb5cb533, 0x3e4d1934, 0xbdc45981, 0x3f2d436e, 0x3d7b07b6, 0x3f7fd674, - 0xbd004cf3, 0x3f5fe6c3, 0xbdfd43ec, 0x3effade3, 0x3d08a286, 0xbe8804c5, 0xbd72b4e6, 0xbf39887d, - 0xbe1afdd4, 0xbf7fdf3b, 0x3bb10ff8, 0xbf570e9f, 0xbdb27623, 0xbee14caa, 0x3d8f7098, 0x3ea8df98, - 0xbcb8c5ed, 0x3f44f6eb, 0xbdeb6e1c, 0x3f7ec004, 0x3d2c894c, 0x3f4d3db3, 0xbd4ed56e, 0x3ec1e6d0, - 0xbe121b7c, 0xbec8f70f, 0x3c683b87, 0xbf4f8180, 0xbda08f41, 0xbf7f1970, 0x3da15a82, 0xbf427f5b, - 0xbc61dc9e, 0xbea1a0a8, 0xbdd993a9, 0x3ee8260d, 0x3d506cac, 0x3f591c0a, 0xbd2af1e4, 0x3f7ff6e4, - 0xbe093643, 0x3f36e003, 0x3cbbf53f, 0x3e809f87, 0xbd8ea535, 0xbf03243f, 0x3db3413e, 0xbf61bb6c, - 0xbba451e1, 0xbf7fac3f, 0xbdc7b4ec, 0xbf2a6d1f, 0x3d744bf2, 0xbe3e1337, 0xbd070afc, 0x3f119dc2, - 0xbe004e56, 0x3f6955ad, 0x3d01e484, 0x3f7e39d5, 0xbd7970b4, 0x3f1d3514, 0xbe1ca888, 0x3df416fd, - 0x3d455f24, 0x3d455f24, 0x3d455f24, 0xbf7fa83d, 0x3ecdfeac, 0xbc7ba1b2, 0xbf739cf1, 0xbf7df5d7, -] )) ), - -################ chunk 22528 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x49536e96, 0x492ca22c, 0x4996b43f, 0x4b16b43f, 0x4a3fbf63, 0x4a25e927, 0x4ab026f9, 0x4b04251e, - 0x4ad7cab8, 0x4b3c614f, 0x4cbc614f, 0x4befaf3b, 0x4bcf6371, 0x4c5c30b8, 0x4ca52e66, 0x4c86deb3, - 0x4ceb79a3, 0x4e6b79a3, 0x4d95cd85, 0x4d819e27, 0x4e099e73, 0x4e4e79ff, 0x4e28965f, 0x4e932c06, - 0x50132c06, 0x4f3b40e6, 0x4f2205b0, 0x4fac060f, 0x50010c3f, 0x4fd2bbf7, 0x5037f707, 0x51b7f707, - 0x50ea1120, 0x50ca871c, 0x51570793, 0x51a14f4f, 0x5183b57b, 0x51e5f4c9, 0x5365f4c9, 0x52924ab4, - 0x527d28e4, 0x530664bc, 0x5349a323, 0x5324a2d9, 0x538fb8fe, 0x550fb8fe, 0x5436dd61, 0x541e398e, - 0x54a7fdeb, 0x54fc0bec, 0x54cdcb90, 0x5533a73d, 0x56b3a73d, 0x55e494b9, 0x55c5c7f2, 0x5651fd66, - 0x569d8773, 0x56809f3a, 0x56e0910c, 0x5860910c, 0x578edcf4, 0x577739ee, 0x58033e60, 0x5844e950, - 0x5820c708, 0x588c5aa8, 0x5a0c5aa8, 0x59329431, 0x591a8435, 0x59a40df8, 0x59f623a4, 0x59c8f8ca, - 0x5a2f7151, 0x5baf7152, 0x5adf393d, 0x5ac12542, 0x5b4d1175, 0x5b99d647, 0x5b7b36fd, 0xc39d1463, - 0xc39d1463, 0xc39d1463, 0xc39d1463, 0xc39d1463, 0xc41d1463, 0xc41d1463, 0xc41d1463, 0xc41d1463, - 0xc41d1463, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc49d1463, 0xc49d1463, - 0xc49d1463, 0xc49d1463, 0xc49d1463, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, - 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc50971d6, 0xc50971d6, 0xc50971d6, - 0xc50971d6, 0xc50971d6, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc530b6ef, - 0xc530b6ef, 0xc530b6ef, 0xc530b6ef, 0xc530b6ef, 0xc544597c, 0xc544597c, 0xc544597c, 0xc544597c, - 0xc544597c, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc56b9e94, 0xc56b9e94, - 0xc56b9e94, 0xc56b9e94, 0xc56b9e94, 0xc57f4121, 0xc57f4121, 0xc57f4121, 0xc57f4121, 0xc57f4121, - 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc593431d, 0xc593431d, 0xc593431d, - 0xc593431d, 0xc593431d, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc5a6e5a9, - 0xc5a6e5a9, 0xc5a6e5a9, 0xc5a6e5a9, 0xc5a6e5a9, 0xc5b0b6ef, 0xc5b0b6ef, 0xc5b0b6ef, 0xc5b0b6ef, - 0xc5b0b6ef, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5c4597c, 0xc5c4597c, - 0xc5c4597c, 0xc5c4597c, 0xc5c4597c, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, - 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5e1cd4e, 0xc5e1cd4e, 0xc5e1cd4e, - 0xc5e1cd4e, 0xc5e1cd4e, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5f56fda, - 0xc5f56fda, 0xc5f56fda, 0xc5f56fda, 0xc5f56fda, 0xc5ff4121, 0xc5ff4121, 0xc5ff4121, 0xc5ff4121, - 0xc5ff4121, 0xc6048933, 0xc6048933, 0xc6048933, 0xc6048933, 0xc6048933, 0xc60971d6, 0xc60971d6, - 0xc60971d6, 0xc60971d6, 0xc60971d6, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, - 0xc613431d, 0xc613431d, 0xc613431d, 0xc613431d, 0xc613431d, 0xc6182bc0, 0xc6182bc0, 0xc6182bc0, - 0xc6182bc0, 0xc6182bc0, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc621fd06, - 0xc621fd06, 0xc621fd06, 0xc621fd06, 0xc621fd06, 0xc626e5a9, 0xc626e5a9, 0xc626e5a9, 0xc626e5a9, - 0xc626e5a9, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc630b6ef, 0xc630b6ef, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7b3e83, 0xbe5c9741, 0xbef65816, 0xbf4455e0, 0x3dc52472, 0xbe12024a, 0x3f7f6b42, 0x3f7e75a4, - 0x3ee80b7b, 0xbf594820, 0xbf77b7d8, 0xbf02b78e, 0xbf4d5423, 0xbf3a610d, 0xbe72976f, 0x3f7ffd81, - 0xbf75dd9c, 0xbf45cec3, 0xbf7a474e, 0x3ede42ac, 0xbf748448, 0xbe28ec64, 0xbf35a361, 0xbf12c078, - 0xbf7c4061, 0xbf503ce1, 0xbf7d76c3, 0xbf0e8fe6, 0x3f4d7284, 0x3f2af506, 0x3dca436d, 0xbf361963, - 0x3dab52dd, 0x3f7ca583, 0x3e5d2995, 0x3ed47e82, 0x3e6cbc8e, 0xbf772fca, 0x3f5c4bf7, 0xbf3e344f, - 0x3f4cbd45, 0x3f490e5f, 0xbf04755a, 0xbf05d1b6, 0xbf74ba3b, 0xbf301fe5, 0xbf5e019f, 0xbf7e590e, - 0x3ec37c6e, 0xbf21b960, 0x3f4acedc, 0xbbb1ad31, 0xbd319f27, 0xbf48f0a8, 0xbf7eca4a, 0x3ed9aab5, - 0xbf721601, 0x3e8db267, 0xbf2a5017, 0x3ee36307, 0x3ef60685, 0xbf00710c, 0x3f57293e, 0xbf5fe2d4, - 0xbf59a073, 0x3f7d7614, 0x3f674440, 0xbf748f96, 0xbf0f1011, 0xbf0748c5, 0x3f7071ae, 0x3f2c0f98, - 0xbf6029c8, 0xbf760032, 0xbe432c52, 0x3ca94731, 0x3f6e31d4, 0xbf3f156a, 0xbf297a30, 0xb6c55799, - 0xb6c55799, 0xb6c55799, 0xb6c55799, 0xb6c55799, 0xb7455799, 0xb7455799, 0xb7455799, 0xb7455799, - 0xb7455799, 0x3757fc9b, 0x3757fc9b, 0x3757fc9b, 0x3757fc9b, 0x3757fc9b, 0xb7c55799, 0xb7c55799, - 0xb7c55799, 0xb7c55799, 0xb7c55799, 0xb87b56bf, 0xb87b56bf, 0xb87b56bf, 0xb87b56bf, 0xb87b56bf, - 0x37d7fc9b, 0x37d7fc9b, 0x37d7fc9b, 0x37d7fc9b, 0x37d7fc9b, 0x38e9a9ad, 0x38e9a9ad, 0x38e9a9ad, - 0x38e9a9ad, 0x38e9a9ad, 0xb8455799, 0xb8455799, 0xb8455799, 0xb8455799, 0xb8455799, 0x3821fd74, - 0x3821fd74, 0x3821fd74, 0x3821fd74, 0x3821fd74, 0xb8fb56bf, 0xb8fb56bf, 0xb8fb56bf, 0xb8fb56bf, - 0xb8fb56bf, 0xb80f5872, 0xb80f5872, 0xb80f5872, 0xb80f5872, 0xb80f5872, 0x3857fc9b, 0x3857fc9b, - 0x3857fc9b, 0x3857fc9b, 0x3857fc9b, 0xb8e0572c, 0xb8e0572c, 0xb8e0572c, 0xb8e0572c, 0xb8e0572c, - 0x3969a9ad, 0x3969a9ad, 0x3969a9ad, 0x3969a9ad, 0x3969a9ad, 0xb93c810f, 0xb93c810f, 0xb93c810f, - 0xb93c810f, 0xb93c810f, 0xb8c55799, 0xb8c55799, 0xb8c55799, 0xb8c55799, 0xb8c55799, 0xb70d6891, - 0xb70d6891, 0xb70d6891, 0xb70d6891, 0xb70d6891, 0x38a1fd74, 0x38a1fd74, 0x38a1fd74, 0x38a1fd74, - 0x38a1fd74, 0x392ad3fd, 0x392ad3fd, 0x392ad3fd, 0x392ad3fd, 0x392ad3fd, 0xb97b56bf, 0xb97b56bf, - 0xb97b56bf, 0xb97b56bf, 0xb97b56bf, 0xb921817c, 0xb921817c, 0xb921817c, 0xb921817c, 0xb921817c, - 0xb88f5872, 0xb88f5872, 0xb88f5872, 0xb88f5872, 0xb88f5872, 0x37914852, 0x37914852, 0x37914852, - 0x37914852, 0x37914852, 0x38d7fc9b, 0x38d7fc9b, 0x38d7fc9b, 0x38d7fc9b, 0x38d7fc9b, 0x3945d391, - 0x3945d391, 0x3945d391, 0x3945d391, 0x3945d391, 0xb960572c, 0xb960572c, 0xb960572c, 0xb960572c, - 0xb960572c, 0x39bcbf0b, 0x39bcbf0b, 0x39bcbf0b, 0x39bcbf0b, 0x39bcbf0b, 0x39e9a9ad, 0x39e9a9ad, - 0x39e9a9ad, 0x39e9a9ad, 0x39e9a9ad, 0xb9e96bb1, 0xb9e96bb1, 0xb9e96bb1, 0xb9e96bb1, 0xb9e96bb1, - 0xb9bc810f, 0xb9bc810f, 0xb9bc810f, 0xb9bc810f, 0xb9bc810f, 0xb98f966e, 0xb98f966e, 0xb98f966e, - 0xb98f966e, 0xb98f966e, 0xb9455799, 0xb9455799, 0xb9455799, 0xb9455799, 0xb9455799, 0xb8d704ab, - 0xb8d704ab, 0xb8d704ab, 0xb8d704ab, 0xb8d704ab, 0xb78d6891, 0xb78d6891, 0xb78d6891, 0xb78d6891, - 0xb78d6891, 0x38905062, 0x38905062, 0x38905062, 0x38905062, 0x38905062, 0x3921fd74, 0x3921fd74, -] )) ), - -################ chunk 23040 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0xc630b6ef, 0xc630b6ef, 0xc630b6ef, 0xc6359f92, 0xc6359f92, 0xc6359f92, 0xc6359f92, 0xc6359f92, - 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63f70d8, 0xc63f70d8, 0xc63f70d8, - 0xc63f70d8, 0xc63f70d8, 0xc644597c, 0xc644597c, 0xc644597c, 0xc644597c, 0xc644597c, 0xc649421f, - 0xc649421f, 0xc649421f, 0xc649421f, 0xc649421f, 0xc64e2ac2, 0xc64e2ac2, 0xc64e2ac2, 0xc64e2ac2, - 0xc64e2ac2, 0xc6531365, 0xc6531365, 0xc6531365, 0xc6531365, 0xc6531365, 0xc657fc08, 0xc657fc08, - 0xc657fc08, 0xc657fc08, 0xc657fc08, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, - 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc666b5f1, 0xc666b5f1, 0xc666b5f1, - 0xc666b5f1, 0xc666b5f1, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc6708737, - 0xc6708737, 0xc6708737, 0xc6708737, 0xc6708737, 0xc6756fda, 0xc6756fda, 0xc6756fda, 0xc6756fda, - 0xc6756fda, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67f4121, 0xc67f4121, - 0xc67f4121, 0xc67f4121, 0xc67f4121, 0xc68214e2, 0xc68214e2, 0xc68214e2, 0xc68214e2, 0xc68214e2, - 0xc6848933, 0xc6848933, 0xc6848933, 0xc6848933, 0xc6848933, 0xc686fd85, 0xc686fd85, 0xc686fd85, - 0xc686fd85, 0xc686fd85, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68be628, - 0xc68be628, 0xc68be628, 0xc68be628, 0xc68be628, 0xc68e5a7a, 0xc68e5a7a, 0xc68e5a7a, 0xc68e5a7a, - 0xc68e5a7a, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc693431d, 0xc693431d, - 0xc693431d, 0xc693431d, 0xc693431d, 0xc695b76e, 0xc695b76e, 0xc695b76e, 0xc695b76e, 0xc695b76e, - 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc69aa011, 0xc69aa011, 0xc69aa011, - 0xc69aa011, 0xc69aa011, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69f88b4, - 0xc69f88b4, 0xc69f88b4, 0xc69f88b4, 0xc69f88b4, 0xc6a1fd06, 0xc6a1fd06, 0xc6a1fd06, 0xc6a1fd06, - 0xc6a1fd06, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a6e5a9, 0xc6a6e5a9, - 0xc6a6e5a9, 0xc6a6e5a9, 0xc6a6e5a9, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, - 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6ae429e, 0xc6ae429e, 0xc6ae429e, - 0xc6ae429e, 0xc6ae429e, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b32b41, - 0xc6b32b41, 0xc6b32b41, 0xc6b32b41, 0xc6b32b41, 0xc6b59f92, 0xc6b59f92, 0xc6b59f92, 0xc6b59f92, - 0xc6b59f92, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6ba8835, 0xc6ba8835, - 0xc6ba8835, 0xc6ba8835, 0xc6ba8835, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, - 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6c1e52a, 0xc6c1e52a, 0xc6c1e52a, - 0xc6c1e52a, 0xc6c1e52a, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c6cdcd, - 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c9421f, 0xc6c9421f, 0xc6c9421f, 0xc6c9421f, - 0xc6c9421f, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6ce2ac2, 0xc6ce2ac2, - 0xc6ce2ac2, 0xc6ce2ac2, 0xc6ce2ac2, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, - 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d587b6, 0xc6d587b6, 0xc6d587b6, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3921fd74, 0x3921fd74, 0x3921fd74, 0x397bd2b7, 0x397bd2b7, 0x397bd2b7, 0x397bd2b7, 0x397bd2b7, - 0x39aad3fd, 0x39aad3fd, 0x39aad3fd, 0x39aad3fd, 0x39aad3fd, 0x39d7be9f, 0x39d7be9f, 0x39d7be9f, - 0x39d7be9f, 0x39d7be9f, 0xb9fb56bf, 0xb9fb56bf, 0xb9fb56bf, 0xb9fb56bf, 0xb9fb56bf, 0xb9ce6c1d, - 0xb9ce6c1d, 0xb9ce6c1d, 0xb9ce6c1d, 0xb9ce6c1d, 0xb9a1817c, 0xb9a1817c, 0xb9a1817c, 0xb9a1817c, - 0xb9a1817c, 0xb9692db5, 0xb9692db5, 0xb9692db5, 0xb9692db5, 0xb9692db5, 0xb90f5872, 0xb90f5872, - 0xb90f5872, 0xb90f5872, 0xb90f5872, 0xb8560cbb, 0xb8560cbb, 0xb8560cbb, 0xb8560cbb, 0xb8560cbb, - 0x38114852, 0x38114852, 0x38114852, 0x38114852, 0x38114852, 0x38fc4eb0, 0x38fc4eb0, 0x38fc4eb0, - 0x38fc4eb0, 0x38fc4eb0, 0x3957fc9b, 0x3957fc9b, 0x3957fc9b, 0x3957fc9b, 0x3957fc9b, 0x3998e8ef, - 0x3998e8ef, 0x3998e8ef, 0x3998e8ef, 0x3998e8ef, 0x39c5d390, 0x39c5d390, 0x39c5d390, 0x39c5d390, - 0x39c5d390, 0x39f2be32, 0x39f2be32, 0x39f2be32, 0x39f2be32, 0x39f2be32, 0xb9e0572c, 0xb9e0572c, - 0xb9e0572c, 0xb9e0572c, 0xb9e0572c, 0xb9b36c8a, 0xb9b36c8a, 0xb9b36c8a, 0xb9b36c8a, 0xb9b36c8a, - 0x3a3cbf0b, 0x3a3cbf0b, 0x3a3cbf0b, 0x3a3cbf0b, 0x3a3cbf0b, 0xb9332e8e, 0xb9332e8e, 0xb9332e8e, - 0xb9332e8e, 0xb9332e8e, 0x3a69a9ab, 0x3a69a9ab, 0x3a69a9ab, 0x3a69a9ab, 0x3a69a9ab, 0x34f7f042, - 0x34f7f042, 0x34f7f042, 0x34f7f042, 0x34f7f042, 0xba696baf, 0xba696baf, 0xba696baf, 0xba696baf, - 0xba696baf, 0x3934267f, 0x3934267f, 0x3934267f, 0x3934267f, 0x3934267f, 0xba3c810e, 0xba3c810e, - 0xba3c810e, 0xba3c810e, 0xba3c810e, 0x39b3e882, 0x39b3e882, 0x39b3e882, 0x39b3e882, 0x39b3e882, - 0xba0f966d, 0xba0f966d, 0xba0f966d, 0xba0f966d, 0xba0f966d, 0x3a06dee2, 0x3a06dee2, 0x3a06dee2, - 0x3a06dee2, 0x3a06dee2, 0xb9c55798, 0xb9c55798, 0xb9c55798, 0xb9c55798, 0xb9c55798, 0x3a33c984, - 0x3a33c984, 0x3a33c984, 0x3a33c984, 0x3a33c984, 0xb95704ab, 0xb95704ab, 0xb95704ab, 0xb95704ab, - 0xb95704ab, 0x3a60b424, 0x3a60b424, 0x3a60b424, 0x3a60b424, 0x3a60b424, 0xb80d6891, 0xb80d6891, - 0xb80d6891, 0xb80d6891, 0xb80d6891, 0xba726136, 0xba726136, 0xba726136, 0xba726136, 0xba726136, - 0x39105062, 0x39105062, 0x39105062, 0x39105062, 0x39105062, 0xba457695, 0xba457695, 0xba457695, - 0xba457695, 0xba457695, 0x39a1fd74, 0x39a1fd74, 0x39a1fd74, 0x39a1fd74, 0x39a1fd74, 0xba188bf4, - 0xba188bf4, 0xba188bf4, 0xba188bf4, 0xba188bf4, 0x39fbd2b7, 0x39fbd2b7, 0x39fbd2b7, 0x39fbd2b7, - 0x39fbd2b7, 0xb9d742a6, 0xb9d742a6, 0xb9d742a6, 0xb9d742a6, 0xb9d742a6, 0x3a2ad3fd, 0x3a2ad3fd, - 0x3a2ad3fd, 0x3a2ad3fd, 0x3a2ad3fd, 0xb97adac7, 0xb97adac7, 0xb97adac7, 0xb97adac7, 0xb97adac7, - 0x3a57be9d, 0x3a57be9d, 0x3a57be9d, 0x3a57be9d, 0x3a57be9d, 0xb88e6082, 0xb88e6082, 0xb88e6082, - 0xb88e6082, 0xb88e6082, 0xba7b56bd, 0xba7b56bd, 0xba7b56bd, 0xba7b56bd, 0xba7b56bd, 0x38d8f48b, - 0x38d8f48b, 0x38d8f48b, 0x38d8f48b, 0x38d8f48b, 0xba4e6c1c, 0xba4e6c1c, 0xba4e6c1c, 0xba4e6c1c, - 0xba4e6c1c, 0x39901266, 0x39901266, 0x39901266, 0x39901266, 0x39901266, 0xba21817b, 0xba21817b, - 0xba21817b, 0xba21817b, 0xba21817b, 0x39e9e7a9, 0x39e9e7a9, 0x39e9e7a9, 0x39e9e7a9, 0x39e9e7a9, - 0xb9e92db5, 0xb9e92db5, 0xb9e92db5, 0xb9e92db5, 0xb9e92db5, 0x3a21de76, 0x3a21de76, 0x3a21de76, -] )) ), - -################ chunk 23552 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0xc6d587b6, 0xc6d587b6, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6da7059, - 0xc6da7059, 0xc6da7059, 0xc6da7059, 0xc6da7059, 0xc6dce4ab, 0xc6dce4ab, 0xc6dce4ab, 0xc6dce4ab, - 0xc6dce4ab, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6e1cd4e, 0xc6e1cd4e, - 0xc6e1cd4e, 0xc6e1cd4e, 0xc6e1cd4e, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, - 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e92a43, 0xc6e92a43, 0xc6e92a43, - 0xc6e92a43, 0xc6e92a43, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6ee12e6, - 0xc6ee12e6, 0xc6ee12e6, 0xc6ee12e6, 0xc6ee12e6, 0xc6f08737, 0xc6f08737, 0xc6f08737, 0xc6f08737, - 0xc6f08737, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f56fda, 0xc6f56fda, - 0xc6f56fda, 0xc6f56fda, 0xc6f56fda, 0xc6f7e42c, 0x59800000, 0x59800000, 0x59800000, 0x5a000000, - 0x5a000000, 0x59329431, 0x591a8435, 0x58a0c708, 0x40c90fdb, 0x41490fdb, 0x41c90fdb, 0x493fbf56, - 0x4aefaf3a, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x441d1463, 0x441d1463, - 0x441d1463, 0x441d1463, 0x441d1463, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, - 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x44c4597c, 0x44c4597c, 0x44c4597c, - 0x44c4597c, 0x44c4597c, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x450971d6, - 0x450971d6, 0x450971d6, 0x450971d6, 0x450971d6, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, - 0x451d1463, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4544597c, 0x4544597c, - 0x4544597c, 0x4544597c, 0x4544597c, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, - 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x457f4121, 0x457f4121, 0x457f4121, - 0x457f4121, 0x457f4121, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x4593431d, - 0x4593431d, 0x4593431d, 0x4593431d, 0x4593431d, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, - 0x459d1463, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45b0b6ef, 0x45b0b6ef, - 0x45b0b6ef, 0x45b0b6ef, 0x45b0b6ef, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, - 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, - 0x45ce2ac2, 0x45ce2ac2, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45e1cd4e, - 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, - 0x45eb9e94, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45ff4121, 0x45ff4121, - 0x45ff4121, 0x45ff4121, 0x45ff4121, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x46048933, - 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, - 0x460e5a7a, 0x460e5a7a, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x46182bc0, - 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, - 0x461d1463, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4626e5a9, 0x4626e5a9, - 0x4626e5a9, 0x4626e5a9, 0x4626e5a9, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3a21de76, 0x3a21de76, 0xb98f5872, 0xb98f5872, 0xb98f5872, 0xb98f5872, 0xb98f5872, 0x3a4ec916, - 0x3a4ec916, 0x3a4ec916, 0x3a4ec916, 0x3a4ec916, 0xb8d60cbb, 0xb8d60cbb, 0xb8d60cbb, 0xb8d60cbb, - 0xb8d60cbb, 0x3a7bb3b7, 0x3a7bb3b7, 0x3a7bb3b7, 0x3a7bb3b7, 0x3a7bb3b7, 0x38914852, 0x38914852, - 0x38914852, 0x38914852, 0x38914852, 0xba5761a3, 0xba5761a3, 0xba5761a3, 0xba5761a3, 0xba5761a3, - 0x397c4eaf, 0x397c4eaf, 0x397c4eaf, 0x397c4eaf, 0x397c4eaf, 0xba2a7702, 0xba2a7702, 0xba2a7702, - 0xba2a7702, 0xba2a7702, 0x39d7fc9b, 0x39d7fc9b, 0x39d7fc9b, 0x39d7fc9b, 0x39d7fc9b, 0xb9fb18c3, - 0xb9fb18c3, 0xb9fb18c3, 0xb9fb18c3, 0xb9fb18c3, 0x3a18e8ef, 0x3a18e8ef, 0x3a18e8ef, 0x3a18e8ef, - 0x3a18e8ef, 0xb9a14380, 0xb9a14380, 0xb9a14380, 0xb9a14380, 0xb9a14380, 0x3a45d390, 0x3a45d390, - 0x3a45d390, 0x3a45d390, 0x3a45d390, 0xb90edc7a, 0x3f5fccb5, 0x3f5fccb5, 0x3f5fccb5, 0xbf595336, - 0xbf595336, 0xbf748f96, 0xbf0f1011, 0xbf6535eb, 0x343bbd2e, 0x34bbbd2e, 0x353bbd2e, 0xbf358fbb, - 0xbf17a45b, 0x36c55799, 0x36c55799, 0x36c55799, 0x36c55799, 0x36c55799, 0x37455799, 0x37455799, - 0x37455799, 0x37455799, 0x37455799, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, 0xb757fc9b, - 0x37c55799, 0x37c55799, 0x37c55799, 0x37c55799, 0x37c55799, 0x387b56bf, 0x387b56bf, 0x387b56bf, - 0x387b56bf, 0x387b56bf, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb7d7fc9b, 0xb8e9a9ad, - 0xb8e9a9ad, 0xb8e9a9ad, 0xb8e9a9ad, 0xb8e9a9ad, 0x38455799, 0x38455799, 0x38455799, 0x38455799, - 0x38455799, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0xb821fd74, 0x38fb56bf, 0x38fb56bf, - 0x38fb56bf, 0x38fb56bf, 0x38fb56bf, 0x380f5872, 0x380f5872, 0x380f5872, 0x380f5872, 0x380f5872, - 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0xb857fc9b, 0x38e0572c, 0x38e0572c, 0x38e0572c, - 0x38e0572c, 0x38e0572c, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0xb969a9ad, 0x393c810f, - 0x393c810f, 0x393c810f, 0x393c810f, 0x393c810f, 0x38c55799, 0x38c55799, 0x38c55799, 0x38c55799, - 0x38c55799, 0x370d6891, 0x370d6891, 0x370d6891, 0x370d6891, 0x370d6891, 0xb8a1fd74, 0xb8a1fd74, - 0xb8a1fd74, 0xb8a1fd74, 0xb8a1fd74, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, 0xb92ad3fd, - 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x397b56bf, 0x3921817c, 0x3921817c, 0x3921817c, - 0x3921817c, 0x3921817c, 0x388f5872, 0x388f5872, 0x388f5872, 0x388f5872, 0x388f5872, 0xb7914852, - 0xb7914852, 0xb7914852, 0xb7914852, 0xb7914852, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, 0xb8d7fc9b, - 0xb8d7fc9b, 0xb945d391, 0xb945d391, 0xb945d391, 0xb945d391, 0xb945d391, 0x3960572c, 0x3960572c, - 0x3960572c, 0x3960572c, 0x3960572c, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, 0xb9bcbf0b, - 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0xb9e9a9ad, 0x39e96bb1, 0x39e96bb1, 0x39e96bb1, - 0x39e96bb1, 0x39e96bb1, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x39bc810f, 0x398f966e, - 0x398f966e, 0x398f966e, 0x398f966e, 0x398f966e, 0x39455799, 0x39455799, 0x39455799, 0x39455799, - 0x39455799, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x38d704ab, 0x378d6891, 0x378d6891, - 0x378d6891, 0x378d6891, 0x378d6891, 0xb8905062, 0xb8905062, 0xb8905062, 0xb8905062, 0xb8905062, -] )) ), -] -cos_float64_t = [ - -################ chunk 0 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5434d, 0x4073a28c59d54329, 0x4083a28c59d5433b, 0x4083a28c59d5433b, 0x4083a28c59d5433b, - 0x4083a28c59d54344, 0x4083a28c59d54332, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4e1, 0x408d73d286bfe4d0, 0x4093a28c59d5433b, - 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433f, 0x4093a28c59d54337, 0x40988b2f704a940a, 0x40988b2f704a940a, 0x40988b2f704a940a, 0x40988b2f704a940e, - 0x40988b2f704a9405, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4dd, 0x409d73d286bfe4d4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, - 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad6, 0x40a12e3ace9a9ad1, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433d, 0x40a3a28c59d54339, - 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba5, 0x40a616dde50feba0, 0x40a88b2f704a940a, 0x40a88b2f704a940a, 0x40a88b2f704a940a, - 0x40a88b2f704a940c, 0x40a88b2f704a9408, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c73, 0x40aaff80fb853c6f, 0x40ad73d286bfe4d8, - 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4db, 0x40ad73d286bfe4d6, 0x40afe82411fa8d40, 0x40afe82411fa8d40, 0x40afe82411fa8d40, 0x40afe82411fa8d42, - 0x40afe82411fa8d3e, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad5, 0x40b12e3ace9a9ad2, 0x40b268639437ef07, 0x40b268639437ef07, - 0x40b268639437ef07, 0x40b268639437ef08, 0x40b268639437ef06, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433c, 0x40b3a28c59d5433a, - 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f729770, 0x40b4dcb51f72976e, 0x40b616dde50feba2, 0x40b616dde50feba2, 0x40b616dde50feba2, - 0x40b616dde50feba3, 0x40b616dde50feba1, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd7, 0x40b75106aaad3fd5, 0x40b88b2f704a940a, - 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940b, 0x40b88b2f704a9409, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, 0x40b9c55835e7e83e, - 0x40b9c55835e7e83c, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c72, 0x40baff80fb853c70, 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, - 0x40bc39a9c12290a5, 0x40bc39a9c12290a6, 0x40bc39a9c12290a4, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4da, 0x40bd73d286bfe4d7, - 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390d, 0x40beadfb4c5d390b, 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, - 0x40bfe82411fa8d41, 0x40bfe82411fa8d3f, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0b9, 0x40c12e3ace9a9ad4, - 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad3, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, 0x40c1cb4f316944ee, - 0x40c1cb4f316944ed, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef08, 0x40c268639437ef07, 0x40c30577f7069921, 0x40c30577f7069921, - 0x40c30577f7069921, 0x40c30577f7069922, 0x40c30577f7069921, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433c, 0x40c3a28c59d5433a, - 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed54, 0x40c4dcb51f72976f, 0x40c4dcb51f72976f, 0x40c4dcb51f72976f, - 0x40c4dcb51f72976f, 0x40c4dcb51f72976e, 0x40c579c982414188, 0x40c579c982414188, 0x40c579c982414188, 0x40c579c982414189, 0x40c579c982414188, 0x40c616dde50feba2, - 0x40c616dde50feba2, 0x40c616dde50feba2, 0x40c616dde50feba3, 0x40c616dde50feba2, 0x40c6b3f247de95bc, 0x40c6b3f247de95bc, 0x40c6b3f247de95bc, 0x40c6b3f247de95bd, - 0x40c6b3f247de95bc, 0x40c75106aaad3fd6, 0x40c75106aaad3fd6, 0x40c75106aaad3fd6, 0x40c75106aaad3fd7, 0x40c75106aaad3fd5, 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9f0, - 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9f0, 0x40c7ee1b0d7be9ef, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a940a, 0x40c88b2f704a9409, - 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e24, 0x40c92843d3193e23, 0x40c9c55835e7e83d, 0x40c9c55835e7e83d, 0x40c9c55835e7e83d, - 0x40c9c55835e7e83e, 0x40c9c55835e7e83d, 0x40ca626c98b69257, 0x40ca626c98b69257, 0x40ca626c98b69257, 0x40ca626c98b69258, 0x40ca626c98b69257, 0x40caff80fb853c71, - 0x40caff80fb853c71, 0x40caff80fb853c71, 0x40caff80fb853c72, 0x40caff80fb853c71, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, 0x40cb9c955e53e68b, - 0x40cb9c955e53e68a, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a5, 0x40cc39a9c12290a4, 0x40ccd6be23f13abf, 0x40ccd6be23f13abf, - 0x40ccd6be23f13abf, 0x40ccd6be23f13abf, 0x40ccd6be23f13abe, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d8, 0x40cd73d286bfe4d9, 0x40cd73d286bfe4d8, - 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef2, 0x40ce10e6e98e8ef3, 0x40ce10e6e98e8ef2, 0x40ceadfb4c5d390c, 0x40ceadfb4c5d390c, 0x40ceadfb4c5d390c, - 0x40ceadfb4c5d390d, 0x40ceadfb4c5d390c, 0x40cf4b0faf2be326, 0x40cf4b0faf2be326, 0x40cf4b0faf2be326, 0x40cf4b0faf2be327, 0x40cf4b0faf2be325, 0x40cfe82411fa8d40, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 512 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40cfe82411fa8d40, 0x40cfe82411fa8d40, 0x40cfe82411fa8d40, 0x40cfe82411fa8d3f, 0x40d0429c3a649bad, 0x40d0429c3a649bad, 0x40d0429c3a649bad, 0x40d0429c3a649bad, - 0x40d0429c3a649bad, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0ba, 0x40d091266bcbf0b9, 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c7, - 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c7, 0x40d0dfb09d3345c6, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad4, 0x40d12e3ace9a9ad3, - 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe1, 0x40d17cc50001efe0, 0x40d1cb4f316944ed, 0x40d1cb4f316944ed, 0x40d1cb4f316944ed, - 0x40d1cb4f316944ee, 0x40d1cb4f316944ed, 0x40d219d962d099fa, 0x40d219d962d099fa, 0x40d219d962d099fa, 0x40d219d962d099fb, 0x40d219d962d099fa, 0x40d268639437ef07, - 0x40d268639437ef07, 0x40d268639437ef07, 0x40d268639437ef08, 0x40d268639437ef07, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, 0x40d2b6edc59f4414, - 0x40d2b6edc59f4414, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d30577f7069921, 0x40d35402286dee2e, 0x40d35402286dee2e, - 0x40d35402286dee2e, 0x40d35402286dee2e, 0x40d35402286dee2e, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, 0x40d3a28c59d5433b, - 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d3f1168b3c9848, 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, - 0x40d43fa0bca3ed55, 0x40d43fa0bca3ed55, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4262, 0x40d48e2aee0b4261, 0x40d4dcb51f72976f, - 0x40d4dcb51f72976f, 0x40d4dcb51f72976f, 0x40d4dcb51f72976f, 0x40d4dcb51f72976e, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, - 0x40d52b3f50d9ec7b, 0x40d579c982414188, 0x40d579c982414188, 0x40d579c982414188, 0x40d579c982414189, 0x40d579c982414188, 0x40d5c853b3a89695, 0x40d5c853b3a89695, - 0x40d5c853b3a89695, 0x40d5c853b3a89696, 0x40d5c853b3a89695, 0x40d616dde50feba2, 0x40d616dde50feba2, 0x40d616dde50feba2, 0x40d616dde50feba3, 0x40d616dde50feba2, - 0x40d66568167740af, 0x40d66568167740af, 0x40d66568167740af, 0x40d66568167740b0, 0x40d66568167740af, 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, - 0x40d6b3f247de95bc, 0x40d6b3f247de95bc, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d7027c7945eac9, 0x40d75106aaad3fd6, - 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d75106aaad3fd6, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, 0x40d79f90dc1494e3, - 0x40d79f90dc1494e3, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d7ee1b0d7be9f0, 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, - 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, 0x40d83ca53ee33efd, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a940a, 0x40d88b2f704a9409, - 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e917, 0x40d8d9b9a1b1e916, 0x40d92843d3193e24, 0x40d92843d3193e24, 0x40d92843d3193e24, - 0x40d92843d3193e24, 0x40d92843d3193e23, 0x40d976ce04809330, 0x40d976ce04809330, 0x40d976ce04809330, 0x40d976ce04809331, 0x40d976ce04809330, 0x40d9c55835e7e83d, - 0x40d9c55835e7e83d, 0x40d9c55835e7e83d, 0x40d9c55835e7e83e, 0x40d9c55835e7e83d, 0x40da13e2674f3d4a, 0x40da13e2674f3d4a, 0x40da13e2674f3d4a, 0x40da13e2674f3d4b, - 0x40da13e2674f3d4a, 0x40da626c98b69257, 0x40da626c98b69257, 0x40da626c98b69257, 0x40da626c98b69258, 0x40da626c98b69257, 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, - 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, 0x40dab0f6ca1de764, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, 0x40daff80fb853c71, - 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db4e0b2cec917e, 0x40db9c955e53e68b, 0x40db9c955e53e68b, 0x40db9c955e53e68b, - 0x40db9c955e53e68b, 0x40db9c955e53e68b, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dbeb1f8fbb3b98, 0x40dc39a9c12290a5, - 0x40dc39a9c12290a5, 0x40dc39a9c12290a5, 0x40dc39a9c12290a5, 0x40dc39a9c12290a4, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, 0x40dc8833f289e5b2, - 0x40dc8833f289e5b1, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abf, 0x40dcd6be23f13abe, 0x40dd254855588fcc, 0x40dd254855588fcc, - 0x40dd254855588fcc, 0x40dd254855588fcc, 0x40dd254855588fcb, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d8, 0x40dd73d286bfe4d9, 0x40dd73d286bfe4d8, - 0x40ddc25cb82739e5, 0x40ddc25cb82739e5, 0x40ddc25cb82739e5, 0x40ddc25cb82739e6, 0x40ddc25cb82739e5, 0x40de10e6e98e8ef2, 0x40de10e6e98e8ef2, 0x40de10e6e98e8ef2, - 0x40de10e6e98e8ef3, 0x40de10e6e98e8ef2, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40de5f711af5e3ff, 0x40deadfb4c5d390c, - 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40deadfb4c5d390c, 0x40defc857dc48e19, 0x40defc857dc48e19, 0x40defc857dc48e19, 0x40defc857dc48e19, - 0x40defc857dc48e19, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df4b0faf2be326, 0x40df9999e0933833, 0x40df9999e0933833, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 1024 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40df9999e0933833, 0x40df9999e0933833, 0x40df9999e0933833, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, 0x40dfe82411fa8d40, - 0x40e01b5721b0f126, 0x40e01b5721b0f126, 0x40e01b5721b0f126, 0x40e01b5721b0f127, 0x40e01b5721b0f126, 0x40e0429c3a649bad, 0x40e0429c3a649bad, 0x40e0429c3a649bad, - 0x40e0429c3a649bad, 0x40e0429c3a649bad, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e069e153184633, 0x40e091266bcbf0ba, - 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e091266bcbf0ba, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, 0x40e0b86b847f9b40, - 0x40e0b86b847f9b40, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e0dfb09d3345c7, 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, - 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, 0x40e106f5b5e6f04d, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad4, 0x40e12e3ace9a9ad3, - 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e1557fe74e455a, 0x40e17cc50001efe1, 0x40e17cc50001efe1, 0x40e17cc50001efe1, - 0x40e17cc50001efe1, 0x40e17cc50001efe0, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1a40a18b59a67, 0x40e1cb4f316944ed, - 0x40e1cb4f316944ed, 0x40e1cb4f316944ed, 0x40e1cb4f316944ee, 0x40e1cb4f316944ed, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, 0x40e1f2944a1cef74, - 0x40e1f2944a1cef74, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e219d962d099fa, 0x40e2411e7b844481, 0x40e2411e7b844481, - 0x40e2411e7b844481, 0x40e2411e7b844481, 0x40e2411e7b844481, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, 0x40e268639437ef07, - 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e28fa8aceb998e, 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, - 0x40e2b6edc59f4414, 0x40e2b6edc59f4414, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e2de32de52ee9b, 0x40e30577f7069921, - 0x40e30577f7069921, 0x40e30577f7069921, 0x40e30577f7069921, 0x40e30577f7069921, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, 0x40e32cbd0fba43a8, - 0x40e32cbd0fba43a7, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e35402286dee2e, 0x40e37b47412198b5, 0x40e37b47412198b5, - 0x40e37b47412198b5, 0x40e37b47412198b5, 0x40e37b47412198b4, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, 0x40e3a28c59d5433b, - 0x40e3c9d17288edc1, 0x40e3c9d17288edc1, 0x40e3c9d17288edc1, 0x40e3c9d17288edc2, 0x40e3c9d17288edc1, 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, - 0x40e3f1168b3c9848, 0x40e3f1168b3c9848, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e4185ba3f042ce, 0x40e43fa0bca3ed55, - 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e43fa0bca3ed55, 0x40e466e5d55797db, 0x40e466e5d55797db, 0x40e466e5d55797db, 0x40e466e5d55797db, - 0x40e466e5d55797db, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e48e2aee0b4262, 0x40e4b57006beece8, 0x40e4b57006beece8, - 0x40e4b57006beece8, 0x40e4b57006beece8, 0x40e4b57006beece8, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, 0x40e4dcb51f72976f, - 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e503fa382641f5, 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7c, - 0x40e52b3f50d9ec7c, 0x40e52b3f50d9ec7b, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e55284698d9702, 0x40e579c982414188, - 0x40e579c982414188, 0x40e579c982414188, 0x40e579c982414189, 0x40e579c982414188, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, 0x40e5a10e9af4ec0f, - 0x40e5a10e9af4ec0f, 0x40e5c853b3a89695, 0x40e5c853b3a89695, 0x40e5c853b3a89695, 0x40e5c853b3a89696, 0x40e5c853b3a89695, 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, - 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, 0x40e5ef98cc5c411c, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, 0x40e616dde50feba2, - 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e63e22fdc39629, 0x40e66568167740af, 0x40e66568167740af, 0x40e66568167740af, - 0x40e66568167740af, 0x40e66568167740af, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e68cad2f2aeb36, 0x40e6b3f247de95bc, - 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6b3f247de95bc, 0x40e6db3760924043, 0x40e6db3760924043, 0x40e6db3760924043, 0x40e6db3760924043, - 0x40e6db3760924043, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e7027c7945eac9, 0x40e729c191f99550, 0x40e729c191f99550, - 0x40e729c191f99550, 0x40e729c191f99550, 0x40e729c191f9954f, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, 0x40e75106aaad3fd6, - 0x40e7784bc360ea5c, 0x40e7784bc360ea5c, 0x40e7784bc360ea5c, 0x40e7784bc360ea5d, 0x40e7784bc360ea5c, 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 1536 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40e79f90dc1494e3, 0x40e79f90dc1494e3, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f69, 0x40e7c6d5f4c83f6a, 0x40e7c6d5f4c83f69, 0x40e7ee1b0d7be9f0, - 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e7ee1b0d7be9f0, 0x40e81560262f9476, 0x40e81560262f9476, 0x40e81560262f9476, 0x40e81560262f9476, - 0x40e81560262f9476, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e83ca53ee33efd, 0x40e863ea5796e983, 0x40e863ea5796e983, - 0x40e863ea5796e983, 0x40e863ea5796e983, 0x40e863ea5796e983, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, 0x40e88b2f704a940a, - 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8b27488fe3e90, 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e917, - 0x40e8d9b9a1b1e917, 0x40e8d9b9a1b1e916, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e900feba65939d, 0x40e92843d3193e24, - 0x40e92843d3193e24, 0x40e92843d3193e24, 0x40e92843d3193e24, 0x40e92843d3193e23, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, 0x40e94f88ebcce8aa, - 0x40e94f88ebcce8aa, 0x40e976ce04809330, 0x40e976ce04809330, 0x40e976ce04809330, 0x40e976ce04809331, 0x40e976ce04809330, 0x40e99e131d343db7, 0x40e99e131d343db7, - 0x40e99e131d343db7, 0x40e99e131d343db7, 0x40e99e131d343db7, 0x40e9c55835e7e83d, 0x40e9c55835e7e83d, 0x40e9c55835e7e83d, 0x40e9c55835e7e83e, 0x40e9c55835e7e83d, - 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40e9ec9d4e9b92c4, 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, - 0x40ea13e2674f3d4a, 0x40ea13e2674f3d4a, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea3b278002e7d1, 0x40ea626c98b69257, - 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea626c98b69257, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, 0x40ea89b1b16a3cde, - 0x40ea89b1b16a3cde, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40eab0f6ca1de764, 0x40ead83be2d191eb, 0x40ead83be2d191eb, - 0x40ead83be2d191eb, 0x40ead83be2d191eb, 0x40ead83be2d191ea, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, 0x40eaff80fb853c71, - 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f8, 0x40eb26c61438e6f7, 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, - 0x40eb4e0b2cec917e, 0x40eb4e0b2cec917e, 0x40eb755045a03c04, 0x40eb755045a03c04, 0x40eb755045a03c04, 0x40eb755045a03c05, 0x40eb755045a03c04, 0x40eb9c955e53e68b, - 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40eb9c955e53e68b, 0x40ebc3da77079111, 0x40ebc3da77079111, 0x40ebc3da77079111, 0x40ebc3da77079112, - 0x40ebc3da77079111, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ebeb1f8fbb3b98, 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, - 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, 0x40ec1264a86ee61e, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, 0x40ec39a9c12290a5, - 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec60eed9d63b2b, 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, - 0x40ec8833f289e5b2, 0x40ec8833f289e5b2, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecaf790b3d9038, 0x40ecd6be23f13abf, - 0x40ecd6be23f13abf, 0x40ecd6be23f13abf, 0x40ecd6be23f13abf, 0x40ecd6be23f13abe, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, 0x40ecfe033ca4e545, - 0x40ecfe033ca4e545, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcc, 0x40ed254855588fcb, 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, - 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, 0x40ed4c8d6e0c3a52, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d8, 0x40ed73d286bfe4d9, 0x40ed73d286bfe4d8, - 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40ed9b179f738f5f, 0x40edc25cb82739e5, 0x40edc25cb82739e5, 0x40edc25cb82739e5, - 0x40edc25cb82739e6, 0x40edc25cb82739e5, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ede9a1d0dae46c, 0x40ee10e6e98e8ef2, - 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee10e6e98e8ef2, 0x40ee382c02423979, 0x40ee382c02423979, 0x40ee382c02423979, 0x40ee382c02423979, - 0x40ee382c02423979, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee5f711af5e3ff, 0x40ee86b633a98e86, 0x40ee86b633a98e86, - 0x40ee86b633a98e86, 0x40ee86b633a98e86, 0x40ee86b633a98e86, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, 0x40eeadfb4c5d390c, - 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e393, 0x40eed5406510e392, 0x40eefc857dc48e19, 0x40eefc857dc48e19, 0x40eefc857dc48e19, - 0x40eefc857dc48e19, 0x40eefc857dc48e19, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca967838a0, 0x40ef23ca9678389f, 0x40ef4b0faf2be326, - 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef4b0faf2be326, 0x40ef7254c7df8dac, 0x40ef7254c7df8dac, 0x40ef7254c7df8dac, 0x40ef7254c7df8dad, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 2048 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40ef7254c7df8dac, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40efc0def946e2b9, 0x40efc0def946e2b9, - 0x40efc0def946e2b9, 0x40efc0def946e2b9, 0x40efc0def946e2b9, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, 0x40efe82411fa8d40, - 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f007b495571be3, 0x40f01b5721b0f126, 0x40f01b5721b0f126, 0x40f01b5721b0f126, - 0x40f01b5721b0f126, 0x40f01b5721b0f126, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f02ef9ae0ac66a, 0x40f0429c3a649bad, - 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0429c3a649bad, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, 0x40f0563ec6be70f0, - 0x40f0563ec6be70f0, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f069e153184633, 0x40f07d83df721b77, 0x40f07d83df721b77, - 0x40f07d83df721b77, 0x40f07d83df721b77, 0x40f07d83df721b76, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, 0x40f091266bcbf0ba, - 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0a4c8f825c5fd, 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, - 0x40f0b86b847f9b40, 0x40f0b86b847f9b40, 0x40f0cc0e10d97083, 0x40f0cc0e10d97083, 0x40f0cc0e10d97083, 0x40f0cc0e10d97084, 0x40f0cc0e10d97083, 0x40f0dfb09d3345c7, - 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0dfb09d3345c7, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, 0x40f0f353298d1b0a, - 0x40f0f353298d1b0a, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f106f5b5e6f04d, 0x40f11a984240c590, 0x40f11a984240c590, - 0x40f11a984240c590, 0x40f11a984240c590, 0x40f11a984240c590, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, 0x40f12e3ace9a9ad4, - 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f141dd5af47017, 0x40f1557fe74e455a, 0x40f1557fe74e455a, 0x40f1557fe74e455a, - 0x40f1557fe74e455a, 0x40f1557fe74e455a, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f1692273a81a9d, 0x40f17cc50001efe1, - 0x40f17cc50001efe1, 0x40f17cc50001efe1, 0x40f17cc50001efe1, 0x40f17cc50001efe0, 0x40f190678c5bc524, 0x40f190678c5bc524, 0x40f190678c5bc524, 0x40f190678c5bc524, - 0x40f190678c5bc524, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1a40a18b59a67, 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, - 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, 0x40f1b7aca50f6faa, 0x40f1cb4f316944ed, 0x40f1cb4f316944ed, 0x40f1cb4f316944ed, 0x40f1cb4f316944ee, 0x40f1cb4f316944ed, - 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1def1bdc31a31, 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, - 0x40f1f2944a1cef74, 0x40f1f2944a1cef74, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f20636d676c4b7, 0x40f219d962d099fa, - 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f219d962d099fa, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, 0x40f22d7bef2a6f3e, - 0x40f22d7bef2a6f3e, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f2411e7b844481, 0x40f254c107de19c4, 0x40f254c107de19c4, - 0x40f254c107de19c4, 0x40f254c107de19c4, 0x40f254c107de19c4, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, 0x40f268639437ef07, - 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44b, 0x40f27c062091c44a, 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, - 0x40f28fa8aceb998e, 0x40f28fa8aceb998e, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2a34b39456ed1, 0x40f2b6edc59f4414, - 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2b6edc59f4414, 0x40f2ca9051f91957, 0x40f2ca9051f91957, 0x40f2ca9051f91957, 0x40f2ca9051f91958, - 0x40f2ca9051f91957, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2de32de52ee9b, 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, - 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, 0x40f2f1d56aacc3de, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, 0x40f30577f7069921, - 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f3191a83606e64, 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, - 0x40f32cbd0fba43a8, 0x40f32cbd0fba43a8, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f3405f9c1418eb, 0x40f35402286dee2e, - 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f35402286dee2e, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, 0x40f367a4b4c7c371, - 0x40f367a4b4c7c371, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b5, 0x40f37b47412198b4, 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, - 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, 0x40f38ee9cd7b6df8, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, 0x40f3a28c59d5433b, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 2560 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3b62ee62f187e, 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, - 0x40f3c9d17288edc1, 0x40f3c9d17288edc1, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3dd73fee2c305, 0x40f3f1168b3c9848, - 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f3f1168b3c9848, 0x40f404b917966d8b, 0x40f404b917966d8b, 0x40f404b917966d8b, 0x40f404b917966d8b, - 0x40f404b917966d8b, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f4185ba3f042ce, 0x40f42bfe304a1812, 0x40f42bfe304a1812, - 0x40f42bfe304a1812, 0x40f42bfe304a1812, 0x40f42bfe304a1812, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, 0x40f43fa0bca3ed55, - 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f4534348fdc298, 0x40f466e5d55797db, 0x40f466e5d55797db, 0x40f466e5d55797db, - 0x40f466e5d55797db, 0x40f466e5d55797db, 0x40f47a8861b16d1e, 0x40f47a8861b16d1e, 0x40f47a8861b16d1e, 0x40f47a8861b16d1f, 0x40f47a8861b16d1e, 0x40f48e2aee0b4262, - 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f48e2aee0b4262, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, 0x40f4a1cd7a6517a5, - 0x40f4a1cd7a6517a5, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4b57006beece8, 0x40f4c9129318c22b, 0x40f4c9129318c22b, - 0x40f4c9129318c22b, 0x40f4c9129318c22b, 0x40f4c9129318c22b, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, 0x40f4dcb51f72976f, - 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f4f057abcc6cb2, 0x40f503fa382641f5, 0x40f503fa382641f5, 0x40f503fa382641f5, - 0x40f503fa382641f5, 0x40f503fa382641f5, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f5179cc4801738, 0x40f52b3f50d9ec7c, - 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f52b3f50d9ec7c, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, 0x40f53ee1dd33c1bf, - 0x40f53ee1dd33c1bf, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f55284698d9702, 0x40f56626f5e76c45, 0x40f56626f5e76c45, - 0x40f56626f5e76c45, 0x40f56626f5e76c45, 0x40f56626f5e76c45, 0x40f579c982414188, 0x40f579c982414188, 0x40f579c982414188, 0x40f579c982414189, 0x40f579c982414188, - 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f58d6c0e9b16cc, 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, - 0x40f5a10e9af4ec0f, 0x40f5a10e9af4ec0f, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5b4b1274ec152, 0x40f5c853b3a89695, - 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5c853b3a89695, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, 0x40f5dbf640026bd9, - 0x40f5dbf640026bd9, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f5ef98cc5c411c, 0x40f6033b58b6165f, 0x40f6033b58b6165f, - 0x40f6033b58b6165f, 0x40f6033b58b6165f, 0x40f6033b58b6165f, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, 0x40f616dde50feba2, - 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e6, 0x40f62a807169c0e5, 0x40f63e22fdc39629, 0x40f63e22fdc39629, 0x40f63e22fdc39629, - 0x40f63e22fdc39629, 0x40f63e22fdc39629, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f651c58a1d6b6c, 0x40f66568167740af, - 0x40f66568167740af, 0x40f66568167740af, 0x40f66568167740af, 0x40f66568167740af, 0x40f6790aa2d115f2, 0x40f6790aa2d115f2, 0x40f6790aa2d115f2, 0x40f6790aa2d115f3, - 0x40f6790aa2d115f2, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f68cad2f2aeb36, 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, - 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, 0x40f6a04fbb84c079, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, 0x40f6b3f247de95bc, - 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6c794d4386aff, 0x40f6db3760924043, 0x40f6db3760924043, 0x40f6db3760924043, - 0x40f6db3760924043, 0x40f6db3760924043, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f6eed9ecec1586, 0x40f7027c7945eac9, - 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7027c7945eac9, 0x40f7161f059fc00c, 0x40f7161f059fc00c, 0x40f7161f059fc00c, 0x40f7161f059fc00c, - 0x40f7161f059fc00c, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f99550, 0x40f729c191f9954f, 0x40f73d641e536a93, 0x40f73d641e536a93, - 0x40f73d641e536a93, 0x40f73d641e536a93, 0x40f73d641e536a93, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, 0x40f75106aaad3fd6, - 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f764a937071519, 0x40f7784bc360ea5c, 0x40f7784bc360ea5c, 0x40f7784bc360ea5c, - 0x40f7784bc360ea5d, 0x40f7784bc360ea5c, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f78bee4fbabfa0, 0x40f79f90dc1494e3, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 3072 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f79f90dc1494e3, 0x40f7b333686e6a26, 0x40f7b333686e6a26, 0x40f7b333686e6a26, 0x40f7b333686e6a26, - 0x40f7b333686e6a26, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7c6d5f4c83f69, 0x40f7da78812214ad, 0x40f7da78812214ad, - 0x40f7da78812214ad, 0x40f7da78812214ad, 0x40f7da78812214ad, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, 0x40f7ee1b0d7be9f0, - 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f801bd99d5bf33, 0x40f81560262f9476, 0x40f81560262f9476, 0x40f81560262f9476, - 0x40f81560262f9476, 0x40f81560262f9476, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969ba, 0x40f82902b28969b9, 0x40f83ca53ee33efd, - 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f83ca53ee33efd, 0x40f85047cb3d1440, 0x40f85047cb3d1440, 0x40f85047cb3d1440, 0x40f85047cb3d1440, - 0x40f85047cb3d1440, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f863ea5796e983, 0x40f8778ce3f0bec6, 0x40f8778ce3f0bec6, - 0x40f8778ce3f0bec6, 0x40f8778ce3f0bec7, 0x40f8778ce3f0bec6, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, 0x40f88b2f704a940a, - 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f89ed1fca4694d, 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, - 0x40f8b27488fe3e90, 0x40f8b27488fe3e90, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8c617155813d3, 0x40f8d9b9a1b1e917, - 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8d9b9a1b1e917, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, 0x40f8ed5c2e0bbe5a, - 0x40f8ed5c2e0bbe5a, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f900feba65939d, 0x40f914a146bf68e0, 0x40f914a146bf68e0, - 0x40f914a146bf68e0, 0x40f914a146bf68e0, 0x40f914a146bf68e0, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e24, 0x40f92843d3193e23, - 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f93be65f731367, 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, - 0x40f94f88ebcce8aa, 0x40f94f88ebcce8aa, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f9632b7826bded, 0x40f976ce04809330, - 0x40f976ce04809330, 0x40f976ce04809330, 0x40f976ce04809331, 0x40f976ce04809330, 0x40f98a7090da6874, 0x40f98a7090da6874, 0x40f98a7090da6874, 0x40f98a7090da6874, - 0x40f98a7090da6874, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f99e131d343db7, 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, - 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, 0x40f9b1b5a98e12fa, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, 0x40f9c55835e7e83d, - 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9d8fac241bd81, 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, - 0x40f9ec9d4e9b92c4, 0x40f9ec9d4e9b92c4, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa003fdaf56807, 0x40fa13e2674f3d4a, - 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa13e2674f3d4a, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, 0x40fa2784f3a9128e, - 0x40fa2784f3a9128d, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa3b278002e7d1, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, - 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, 0x40fa626c98b69257, - 0x40fa760f2510679a, 0x40fa760f2510679a, 0x40fa760f2510679a, 0x40fa760f2510679b, 0x40fa760f2510679a, 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, - 0x40fa89b1b16a3cde, 0x40fa89b1b16a3cde, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fa9d543dc41221, 0x40fab0f6ca1de764, - 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fab0f6ca1de764, 0x40fac4995677bca7, 0x40fac4995677bca7, 0x40fac4995677bca7, 0x40fac4995677bca7, - 0x40fac4995677bca7, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40fad83be2d191eb, 0x40faebde6f2b672e, 0x40faebde6f2b672e, - 0x40faebde6f2b672e, 0x40faebde6f2b672e, 0x40faebde6f2b672e, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, 0x40faff80fb853c71, - 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb132387df11b4, 0x40fb26c61438e6f8, 0x40fb26c61438e6f8, 0x40fb26c61438e6f8, - 0x40fb26c61438e6f8, 0x40fb26c61438e6f7, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb3a68a092bc3b, 0x40fb4e0b2cec917e, - 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb4e0b2cec917e, 0x40fb61adb94666c1, 0x40fb61adb94666c1, 0x40fb61adb94666c1, 0x40fb61adb94666c1, - 0x40fb61adb94666c1, 0x40fb755045a03c04, 0x40fb755045a03c04, 0x40fb755045a03c04, 0x40fb755045a03c05, 0x40fb755045a03c04, 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 3584 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, 0x40fb88f2d1fa1148, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, 0x40fb9c955e53e68b, - 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbb037eaadbbce, 0x40fbc3da77079111, 0x40fbc3da77079111, 0x40fbc3da77079111, - 0x40fbc3da77079111, 0x40fbc3da77079111, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbd77d03616655, 0x40fbeb1f8fbb3b98, - 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbeb1f8fbb3b98, 0x40fbfec21c1510db, 0x40fbfec21c1510db, 0x40fbfec21c1510db, 0x40fbfec21c1510db, - 0x40fbfec21c1510db, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc1264a86ee61e, 0x40fc260734c8bb62, 0x40fc260734c8bb62, - 0x40fc260734c8bb62, 0x40fc260734c8bb62, 0x40fc260734c8bb61, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, 0x40fc39a9c12290a5, - 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc4d4c4d7c65e8, 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, - 0x40fc60eed9d63b2b, 0x40fc60eed9d63b2b, 0x40fc74916630106e, 0x40fc74916630106e, 0x40fc74916630106e, 0x40fc74916630106f, 0x40fc74916630106e, 0x40fc8833f289e5b2, - 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc8833f289e5b2, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, 0x40fc9bd67ee3baf5, - 0x40fc9bd67ee3baf5, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcaf790b3d9038, 0x40fcc31b9797657b, 0x40fcc31b9797657b, - 0x40fcc31b9797657b, 0x40fcc31b9797657b, 0x40fcc31b9797657b, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, 0x40fcd6be23f13abf, - 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcea60b04b1002, 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, - 0x40fcfe033ca4e545, 0x40fcfe033ca4e545, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd11a5c8feba88, 0x40fd254855588fcc, - 0x40fd254855588fcc, 0x40fd254855588fcc, 0x40fd254855588fcc, 0x40fd254855588fcb, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, 0x40fd38eae1b2650f, - 0x40fd38eae1b2650f, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd4c8d6e0c3a52, 0x40fd602ffa660f95, 0x40fd602ffa660f95, - 0x40fd602ffa660f95, 0x40fd602ffa660f95, 0x40fd602ffa660f95, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d8, 0x40fd73d286bfe4d9, 0x40fd73d286bfe4d8, - 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd87751319ba1c, 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, - 0x40fd9b179f738f5f, 0x40fd9b179f738f5f, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdaeba2bcd64a2, 0x40fdc25cb82739e5, - 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdc25cb82739e5, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, 0x40fdd5ff44810f29, - 0x40fdd5ff44810f29, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fde9a1d0dae46c, 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, - 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, 0x40fdfd445d34b9af, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, 0x40fe10e6e98e8ef2, - 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86436, 0x40fe248975e86435, 0x40fe382c02423979, 0x40fe382c02423979, 0x40fe382c02423979, - 0x40fe382c02423979, 0x40fe382c02423979, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe4bce8e9c0ebc, 0x40fe5f711af5e3ff, - 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe5f711af5e3ff, 0x40fe7313a74fb942, 0x40fe7313a74fb942, 0x40fe7313a74fb942, 0x40fe7313a74fb943, - 0x40fe7313a74fb942, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe86b633a98e86, 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, - 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, 0x40fe9a58c00363c9, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, 0x40feadfb4c5d390c, - 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fec19dd8b70e4f, 0x40fed5406510e393, 0x40fed5406510e393, 0x40fed5406510e393, - 0x40fed5406510e393, 0x40fed5406510e393, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fee8e2f16ab8d6, 0x40fefc857dc48e19, - 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40fefc857dc48e19, 0x40ff10280a1e635c, 0x40ff10280a1e635c, 0x40ff10280a1e635c, 0x40ff10280a1e635c, - 0x40ff10280a1e635c, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca967838a0, 0x40ff23ca9678389f, 0x40ff376d22d20de3, 0x40ff376d22d20de3, - 0x40ff376d22d20de3, 0x40ff376d22d20de3, 0x40ff376d22d20de3, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, 0x40ff4b0faf2be326, - 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff5eb23b85b869, 0x40ff7254c7df8dac, 0x40ff7254c7df8dac, 0x40ff7254c7df8dac, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 4096 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40ff7254c7df8dad, 0x40ff7254c7df8dac, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff85f7543962f0, 0x40ff9999e0933833, - 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ff9999e0933833, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, 0x40ffad3c6ced0d76, - 0x40ffad3c6ced0d76, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffc0def946e2b9, 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, - 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, 0x40ffd48185a0b7fd, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, 0x40ffe82411fa8d40, - 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x40fffbc69e546283, 0x410007b495571be3, 0x410007b495571be3, 0x410007b495571be3, - 0x410007b495571be3, 0x410007b495571be3, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001185db840685, 0x41001b5721b0f126, - 0x41001b5721b0f126, 0x41001b5721b0f126, 0x41001b5721b0f126, 0x41001b5721b0f126, 0x4100252867dddbc8, 0x4100252867dddbc8, 0x4100252867dddbc8, 0x4100252867dddbc8, - 0x4100252867dddbc8, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x41002ef9ae0ac66a, 0x410038caf437b10b, 0x410038caf437b10b, - 0x410038caf437b10b, 0x410038caf437b10b, 0x410038caf437b10b, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, 0x4100429c3a649bad, - 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x41004c6d8091864e, 0x4100563ec6be70f0, 0x4100563ec6be70f0, 0x4100563ec6be70f0, - 0x4100563ec6be70f0, 0x4100563ec6be70f0, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410060100ceb5b92, 0x410069e153184633, - 0x410069e153184633, 0x410069e153184633, 0x410069e153184633, 0x410069e153184633, 0x410073b2994530d5, 0x410073b2994530d5, 0x410073b2994530d5, 0x410073b2994530d5, - 0x410073b2994530d5, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b77, 0x41007d83df721b76, 0x41008755259f0618, 0x41008755259f0618, - 0x41008755259f0618, 0x41008755259f0618, 0x41008755259f0618, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, 0x410091266bcbf0ba, - 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x41009af7b1f8db5b, 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, - 0x4100a4c8f825c5fd, 0x4100a4c8f825c5fd, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100ae9a3e52b09f, 0x4100b86b847f9b40, - 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100b86b847f9b40, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, 0x4100c23ccaac85e2, - 0x4100c23ccaac85e2, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100cc0e10d97083, 0x4100d5df57065b25, 0x4100d5df57065b25, - 0x4100d5df57065b25, 0x4100d5df57065b25, 0x4100d5df57065b25, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, 0x4100dfb09d3345c7, - 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100e981e3603068, 0x4100f353298d1b0a, 0x4100f353298d1b0a, 0x4100f353298d1b0a, - 0x4100f353298d1b0a, 0x4100f353298d1b0a, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ac, 0x4100fd246fba05ab, 0x410106f5b5e6f04d, - 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410106f5b5e6f04d, 0x410110c6fc13daef, 0x410110c6fc13daef, 0x410110c6fc13daef, 0x410110c6fc13daef, - 0x410110c6fc13daef, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41011a984240c590, 0x41012469886db032, 0x41012469886db032, - 0x41012469886db032, 0x41012469886db032, 0x41012469886db032, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, 0x41012e3ace9a9ad4, - 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x4101380c14c78575, 0x410141dd5af47017, 0x410141dd5af47017, 0x410141dd5af47017, - 0x410141dd5af47017, 0x410141dd5af47017, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x41014baea1215ab8, 0x4101557fe74e455a, - 0x4101557fe74e455a, 0x4101557fe74e455a, 0x4101557fe74e455a, 0x4101557fe74e455a, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, 0x41015f512d7b2ffc, - 0x41015f512d7b2ffc, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x4101692273a81a9d, 0x410172f3b9d5053f, 0x410172f3b9d5053f, - 0x410172f3b9d5053f, 0x410172f3b9d5053f, 0x410172f3b9d5053f, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe1, 0x41017cc50001efe0, - 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x41018696462eda82, 0x410190678c5bc524, 0x410190678c5bc524, 0x410190678c5bc524, - 0x410190678c5bc524, 0x410190678c5bc524, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x41019a38d288afc5, 0x4101a40a18b59a67, - 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101a40a18b59a67, 0x4101addb5ee28509, 0x4101addb5ee28509, 0x4101addb5ee28509, 0x4101addb5ee28509, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 4608 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4101addb5ee28509, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101b7aca50f6faa, 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, - 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, 0x4101c17deb3c5a4c, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, 0x4101cb4f316944ed, - 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101d52077962f8f, 0x4101def1bdc31a31, 0x4101def1bdc31a31, 0x4101def1bdc31a31, - 0x4101def1bdc31a31, 0x4101def1bdc31a31, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101e8c303f004d2, 0x4101f2944a1cef74, - 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101f2944a1cef74, 0x4101fc659049da16, 0x4101fc659049da16, 0x4101fc659049da16, 0x4101fc659049da16, - 0x4101fc659049da15, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x41020636d676c4b7, 0x410210081ca3af59, 0x410210081ca3af59, - 0x410210081ca3af59, 0x410210081ca3af59, 0x410210081ca3af59, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, 0x410219d962d099fa, - 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x410223aaa8fd849c, 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, - 0x41022d7bef2a6f3e, 0x41022d7bef2a6f3e, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102374d355759df, 0x4102411e7b844481, - 0x4102411e7b844481, 0x4102411e7b844481, 0x4102411e7b844481, 0x4102411e7b844481, 0x41024aefc1b12f22, 0x41024aefc1b12f22, 0x41024aefc1b12f22, 0x41024aefc1b12f22, - 0x41024aefc1b12f22, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x410254c107de19c4, 0x41025e924e0b0466, 0x41025e924e0b0466, - 0x41025e924e0b0466, 0x41025e924e0b0466, 0x41025e924e0b0466, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, - 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027234da64d9a9, 0x41027c062091c44b, 0x41027c062091c44b, 0x41027c062091c44b, - 0x41027c062091c44b, 0x41027c062091c44a, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x410285d766beaeec, 0x41028fa8aceb998e, - 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41028fa8aceb998e, 0x41029979f318842f, 0x41029979f318842f, 0x41029979f318842f, 0x41029979f318842f, - 0x41029979f318842f, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102a34b39456ed1, 0x4102ad1c7f725973, 0x4102ad1c7f725973, - 0x4102ad1c7f725973, 0x4102ad1c7f725973, 0x4102ad1c7f725973, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, 0x4102b6edc59f4414, - 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102c0bf0bcc2eb6, 0x4102ca9051f91957, 0x4102ca9051f91957, 0x4102ca9051f91957, - 0x4102ca9051f91957, 0x4102ca9051f91957, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102d461982603f9, 0x4102de32de52ee9b, - 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102de32de52ee9b, 0x4102e804247fd93c, 0x4102e804247fd93c, 0x4102e804247fd93c, 0x4102e804247fd93c, - 0x4102e804247fd93c, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102f1d56aacc3de, 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae80, - 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae80, 0x4102fba6b0d9ae7f, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, 0x41030577f7069921, - 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x41030f493d3383c3, 0x4103191a83606e64, 0x4103191a83606e64, 0x4103191a83606e64, - 0x4103191a83606e64, 0x4103191a83606e64, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x410322ebc98d5906, 0x41032cbd0fba43a8, - 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x41032cbd0fba43a8, 0x4103368e55e72e49, 0x4103368e55e72e49, 0x4103368e55e72e49, 0x4103368e55e72e49, - 0x4103368e55e72e49, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x4103405f9c1418eb, 0x41034a30e241038c, 0x41034a30e241038c, - 0x41034a30e241038c, 0x41034a30e241038c, 0x41034a30e241038c, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, 0x41035402286dee2e, - 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x41035dd36e9ad8d0, 0x410367a4b4c7c371, 0x410367a4b4c7c371, 0x410367a4b4c7c371, - 0x410367a4b4c7c371, 0x410367a4b4c7c371, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037175faf4ae13, 0x41037b47412198b5, - 0x41037b47412198b5, 0x41037b47412198b5, 0x41037b47412198b5, 0x41037b47412198b4, 0x41038518874e8356, 0x41038518874e8356, 0x41038518874e8356, 0x41038518874e8356, - 0x41038518874e8356, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x41038ee9cd7b6df8, 0x410398bb13a85899, 0x410398bb13a85899, - 0x410398bb13a85899, 0x410398bb13a85899, 0x410398bb13a85899, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, 0x4103a28c59d5433b, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 5120 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103ac5da0022ddd, 0x4103b62ee62f187e, 0x4103b62ee62f187e, 0x4103b62ee62f187e, - 0x4103b62ee62f187e, 0x4103b62ee62f187e, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c0002c5c0320, 0x4103c9d17288edc1, - 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103c9d17288edc1, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, 0x4103d3a2b8b5d863, - 0x4103d3a2b8b5d863, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103dd73fee2c305, 0x4103e745450fada6, 0x4103e745450fada6, - 0x4103e745450fada6, 0x4103e745450fada6, 0x4103e745450fada6, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, 0x4103f1168b3c9848, - 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982ea, 0x4103fae7d16982e9, 0x410404b917966d8b, 0x410404b917966d8b, 0x410404b917966d8b, - 0x410404b917966d8b, 0x410404b917966d8b, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x41040e8a5dc3582d, 0x4104185ba3f042ce, - 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104185ba3f042ce, 0x4104222cea1d2d70, 0x4104222cea1d2d70, 0x4104222cea1d2d70, 0x4104222cea1d2d70, - 0x4104222cea1d2d70, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x41042bfe304a1812, 0x410435cf767702b3, 0x410435cf767702b3, - 0x410435cf767702b3, 0x410435cf767702b3, 0x410435cf767702b3, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, 0x41043fa0bca3ed55, - 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104497202d0d7f6, 0x4104534348fdc298, 0x4104534348fdc298, 0x4104534348fdc298, - 0x4104534348fdc298, 0x4104534348fdc298, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x41045d148f2aad3a, 0x410466e5d55797db, - 0x410466e5d55797db, 0x410466e5d55797db, 0x410466e5d55797db, 0x410466e5d55797db, 0x410470b71b84827d, 0x410470b71b84827d, 0x410470b71b84827d, 0x410470b71b84827d, - 0x410470b71b84827d, 0x41047a8861b16d1e, 0x41047a8861b16d1e, 0x41047a8861b16d1e, 0x41047a8861b16d1f, 0x41047a8861b16d1e, 0x41048459a7de57c0, 0x41048459a7de57c0, - 0x41048459a7de57c0, 0x41048459a7de57c0, 0x41048459a7de57c0, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, 0x41048e2aee0b4262, - 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x410497fc34382d03, 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, - 0x4104a1cd7a6517a5, 0x4104a1cd7a6517a5, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104ab9ec0920247, 0x4104b57006beece8, - 0x4104b57006beece8, 0x4104b57006beece8, 0x4104b57006beece8, 0x4104b57006beece8, 0x4104bf414cebd78a, 0x4104bf414cebd78a, 0x4104bf414cebd78a, 0x4104bf414cebd78a, - 0x4104bf414cebd78a, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104c9129318c22b, 0x4104d2e3d945accd, 0x4104d2e3d945accd, - 0x4104d2e3d945accd, 0x4104d2e3d945accd, 0x4104d2e3d945accd, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, 0x4104dcb51f72976f, - 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104e686659f8210, 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, - 0x4104f057abcc6cb2, 0x4104f057abcc6cb2, 0x4104fa28f1f95753, 0x4104fa28f1f95753, 0x4104fa28f1f95753, 0x4104fa28f1f95754, 0x4104fa28f1f95753, 0x410503fa382641f5, - 0x410503fa382641f5, 0x410503fa382641f5, 0x410503fa382641f5, 0x410503fa382641f5, 0x41050dcb7e532c97, 0x41050dcb7e532c97, 0x41050dcb7e532c97, 0x41050dcb7e532c97, - 0x41050dcb7e532c97, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105179cc4801738, 0x4105216e0aad01da, 0x4105216e0aad01da, - 0x4105216e0aad01da, 0x4105216e0aad01da, 0x4105216e0aad01da, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, 0x41052b3f50d9ec7c, - 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x410535109706d71d, 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, - 0x41053ee1dd33c1bf, 0x41053ee1dd33c1bf, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x410548b32360ac60, 0x41055284698d9702, - 0x41055284698d9702, 0x41055284698d9702, 0x41055284698d9702, 0x41055284698d9702, 0x41055c55afba81a4, 0x41055c55afba81a4, 0x41055c55afba81a4, 0x41055c55afba81a4, - 0x41055c55afba81a4, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056626f5e76c45, 0x41056ff83c1456e7, 0x41056ff83c1456e7, - 0x41056ff83c1456e7, 0x41056ff83c1456e7, 0x41056ff83c1456e7, 0x410579c982414188, 0x410579c982414188, 0x410579c982414188, 0x410579c982414189, 0x410579c982414188, - 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x4105839ac86e2c2a, 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, - 0x41058d6c0e9b16cc, 0x41058d6c0e9b16cc, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105973d54c8016d, 0x4105a10e9af4ec0f, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 5632 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105a10e9af4ec0f, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, 0x4105aadfe121d6b1, - 0x4105aadfe121d6b1, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105b4b1274ec152, 0x4105be826d7babf4, 0x4105be826d7babf4, - 0x4105be826d7babf4, 0x4105be826d7babf4, 0x4105be826d7babf4, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, 0x4105c853b3a89695, - 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105d224f9d58137, 0x4105dbf640026bd9, 0x4105dbf640026bd9, 0x4105dbf640026bd9, - 0x4105dbf640026bd9, 0x4105dbf640026bd9, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105e5c7862f567a, 0x4105ef98cc5c411c, - 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105ef98cc5c411c, 0x4105f96a12892bbd, 0x4105f96a12892bbd, 0x4105f96a12892bbd, 0x4105f96a12892bbe, - 0x4105f96a12892bbd, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x4106033b58b6165f, 0x41060d0c9ee30101, 0x41060d0c9ee30101, - 0x41060d0c9ee30101, 0x41060d0c9ee30101, 0x41060d0c9ee30101, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, 0x410616dde50feba2, - 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x410620af2b3cd644, 0x41062a807169c0e6, 0x41062a807169c0e6, 0x41062a807169c0e6, - 0x41062a807169c0e6, 0x41062a807169c0e6, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063451b796ab87, 0x41063e22fdc39629, - 0x41063e22fdc39629, 0x41063e22fdc39629, 0x41063e22fdc39629, 0x41063e22fdc39629, 0x410647f443f080ca, 0x410647f443f080ca, 0x410647f443f080ca, 0x410647f443f080ca, - 0x410647f443f080ca, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x410651c58a1d6b6c, 0x41065b96d04a560e, 0x41065b96d04a560e, - 0x41065b96d04a560e, 0x41065b96d04a560e, 0x41065b96d04a560e, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, 0x41066568167740af, - 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x41066f395ca42b51, 0x4106790aa2d115f2, 0x4106790aa2d115f2, 0x4106790aa2d115f2, - 0x4106790aa2d115f3, 0x4106790aa2d115f2, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x410682dbe8fe0094, 0x41068cad2f2aeb36, - 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x41068cad2f2aeb36, 0x4106967e7557d5d7, 0x4106967e7557d5d7, 0x4106967e7557d5d7, 0x4106967e7557d5d7, - 0x4106967e7557d5d7, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106a04fbb84c079, 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, - 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, 0x4106aa2101b1ab1b, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, 0x4106b3f247de95bc, - 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106bdc38e0b805e, 0x4106c794d4386aff, 0x4106c794d4386aff, 0x4106c794d4386aff, - 0x4106c794d4386aff, 0x4106c794d4386aff, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106d1661a6555a1, 0x4106db3760924043, - 0x4106db3760924043, 0x4106db3760924043, 0x4106db3760924043, 0x4106db3760924043, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, 0x4106e508a6bf2ae4, - 0x4106e508a6bf2ae4, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106eed9ecec1586, 0x4106f8ab33190027, 0x4106f8ab33190027, - 0x4106f8ab33190027, 0x4106f8ab33190028, 0x4106f8ab33190027, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, 0x4107027c7945eac9, - 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x41070c4dbf72d56b, 0x4107161f059fc00c, 0x4107161f059fc00c, 0x4107161f059fc00c, - 0x4107161f059fc00c, 0x4107161f059fc00c, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x41071ff04bccaaae, 0x410729c191f99550, - 0x410729c191f99550, 0x410729c191f99550, 0x410729c191f99550, 0x410729c191f99550, 0x41073392d8267ff1, 0x41073392d8267ff1, 0x41073392d8267ff1, 0x41073392d8267ff1, - 0x41073392d8267ff1, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x41073d641e536a93, 0x4107473564805534, 0x4107473564805534, - 0x4107473564805534, 0x4107473564805534, 0x4107473564805534, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, 0x41075106aaad3fd6, - 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x41075ad7f0da2a78, 0x410764a937071519, 0x410764a937071519, 0x410764a937071519, - 0x410764a937071519, 0x410764a937071519, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x41076e7a7d33ffbb, 0x4107784bc360ea5c, - 0x4107784bc360ea5c, 0x4107784bc360ea5c, 0x4107784bc360ea5d, 0x4107784bc360ea5c, 0x4107821d098dd4fe, 0x4107821d098dd4fe, 0x4107821d098dd4fe, 0x4107821d098dd4fe, - 0x4107821d098dd4fe, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x41078bee4fbabfa0, 0x410795bf95e7aa41, 0x410795bf95e7aa41, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 6144 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x410795bf95e7aa41, 0x410795bf95e7aa41, 0x410795bf95e7aa41, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, 0x41079f90dc1494e3, - 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107a96222417f85, 0x4107b333686e6a26, 0x4107b333686e6a26, 0x4107b333686e6a26, - 0x4107b333686e6a26, 0x4107b333686e6a26, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107bd04ae9b54c8, 0x4107c6d5f4c83f69, - 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107c6d5f4c83f69, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, 0x4107d0a73af52a0b, - 0x4107d0a73af52a0b, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107da78812214ad, 0x4107e449c74eff4e, 0x4107e449c74eff4e, - 0x4107e449c74eff4e, 0x4107e449c74eff4e, 0x4107e449c74eff4e, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, 0x4107ee1b0d7be9f0, - 0x4107f7ec53a8d491, 0x4107f7ec53a8d491, 0x4107f7ec53a8d491, 0x4107f7ec53a8d492, 0x4107f7ec53a8d491, 0x410801bd99d5bf33, 0x410801bd99d5bf33, 0x410801bd99d5bf33, - 0x410801bd99d5bf33, 0x410801bd99d5bf33, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41080b8ee002a9d5, 0x41081560262f9476, - 0x41081560262f9476, 0x41081560262f9476, 0x41081560262f9476, 0x41081560262f9476, 0x41081f316c5c7f18, 0x41081f316c5c7f18, 0x41081f316c5c7f18, 0x41081f316c5c7f18, - 0x41081f316c5c7f18, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x41082902b28969ba, 0x410832d3f8b6545b, 0x410832d3f8b6545b, - 0x410832d3f8b6545b, 0x410832d3f8b6545b, 0x410832d3f8b6545b, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, 0x41083ca53ee33efd, - 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x410846768510299e, 0x41085047cb3d1440, 0x41085047cb3d1440, 0x41085047cb3d1440, - 0x41085047cb3d1440, 0x41085047cb3d1440, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x41085a191169fee2, 0x410863ea5796e983, - 0x410863ea5796e983, 0x410863ea5796e983, 0x410863ea5796e983, 0x410863ea5796e983, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, 0x41086dbb9dc3d425, - 0x41086dbb9dc3d425, 0x4108778ce3f0bec6, 0x4108778ce3f0bec6, 0x4108778ce3f0bec6, 0x4108778ce3f0bec7, 0x4108778ce3f0bec6, 0x4108815e2a1da968, 0x4108815e2a1da968, - 0x4108815e2a1da968, 0x4108815e2a1da968, 0x4108815e2a1da968, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, 0x41088b2f704a940a, - 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089500b6777eab, 0x41089ed1fca4694d, 0x41089ed1fca4694d, 0x41089ed1fca4694d, - 0x41089ed1fca4694d, 0x41089ed1fca4694d, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108a8a342d153ef, 0x4108b27488fe3e90, - 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108b27488fe3e90, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, 0x4108bc45cf2b2932, - 0x4108bc45cf2b2932, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108c617155813d3, 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, - 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, 0x4108cfe85b84fe75, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, 0x4108d9b9a1b1e917, - 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108e38ae7ded3b8, 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, - 0x4108ed5c2e0bbe5a, 0x4108ed5c2e0bbe5a, 0x4108f72d7438a8fb, 0x4108f72d7438a8fb, 0x4108f72d7438a8fb, 0x4108f72d7438a8fc, 0x4108f72d7438a8fb, 0x410900feba65939d, - 0x410900feba65939d, 0x410900feba65939d, 0x410900feba65939d, 0x410900feba65939d, 0x41090ad000927e3f, 0x41090ad000927e3f, 0x41090ad000927e3f, 0x41090ad000927e3f, - 0x41090ad000927e3f, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x410914a146bf68e0, 0x41091e728cec5382, 0x41091e728cec5382, - 0x41091e728cec5382, 0x41091e728cec5382, 0x41091e728cec5382, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, 0x41092843d3193e24, - 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093215194628c5, 0x41093be65f731367, 0x41093be65f731367, 0x41093be65f731367, - 0x41093be65f731367, 0x41093be65f731367, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x410945b7a59ffe08, 0x41094f88ebcce8aa, - 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x41094f88ebcce8aa, 0x4109595a31f9d34c, 0x4109595a31f9d34c, 0x4109595a31f9d34c, 0x4109595a31f9d34c, - 0x4109595a31f9d34c, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x4109632b7826bded, 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, - 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, 0x41096cfcbe53a88f, 0x410976ce04809330, 0x410976ce04809330, 0x410976ce04809330, 0x410976ce04809331, 0x410976ce04809330, - 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x4109809f4aad7dd2, 0x41098a7090da6874, 0x41098a7090da6874, 0x41098a7090da6874, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 6656 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x41098a7090da6874, 0x41098a7090da6874, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099441d7075315, 0x41099e131d343db7, - 0x41099e131d343db7, 0x41099e131d343db7, 0x41099e131d343db7, 0x41099e131d343db7, 0x4109a7e463612859, 0x4109a7e463612859, 0x4109a7e463612859, 0x4109a7e463612859, - 0x4109a7e463612859, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109b1b5a98e12fa, 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, - 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, 0x4109bb86efbafd9c, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, 0x4109c55835e7e83d, - 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109cf297c14d2df, 0x4109d8fac241bd81, 0x4109d8fac241bd81, 0x4109d8fac241bd81, - 0x4109d8fac241bd81, 0x4109d8fac241bd81, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109e2cc086ea822, 0x4109ec9d4e9b92c4, - 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109ec9d4e9b92c4, 0x4109f66e94c87d65, 0x4109f66e94c87d65, 0x4109f66e94c87d65, 0x4109f66e94c87d66, - 0x4109f66e94c87d65, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a003fdaf56807, 0x410a0a11212252a9, 0x410a0a11212252a9, - 0x410a0a11212252a9, 0x410a0a11212252a9, 0x410a0a11212252a9, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, 0x410a13e2674f3d4a, - 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a1db3ad7c27ec, 0x410a2784f3a9128e, 0x410a2784f3a9128e, 0x410a2784f3a9128e, - 0x410a2784f3a9128e, 0x410a2784f3a9128e, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a315639d5fd2f, 0x410a3b278002e7d1, - 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a3b278002e7d1, 0x410a44f8c62fd272, 0x410a44f8c62fd272, 0x410a44f8c62fd272, 0x410a44f8c62fd272, - 0x410a44f8c62fd272, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a4eca0c5cbd14, 0x410a589b5289a7b6, 0x410a589b5289a7b6, - 0x410a589b5289a7b6, 0x410a589b5289a7b6, 0x410a589b5289a7b6, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, 0x410a626c98b69257, - 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a6c3ddee37cf9, 0x410a760f2510679a, 0x410a760f2510679a, 0x410a760f2510679a, - 0x410a760f2510679a, 0x410a760f2510679a, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a7fe06b3d523c, 0x410a89b1b16a3cde, - 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a89b1b16a3cde, 0x410a9382f797277f, 0x410a9382f797277f, 0x410a9382f797277f, 0x410a9382f797277f, - 0x410a9382f797277f, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410a9d543dc41221, 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, - 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, 0x410aa72583f0fcc3, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, 0x410ab0f6ca1de764, - 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410abac8104ad206, 0x410ac4995677bca7, 0x410ac4995677bca7, 0x410ac4995677bca7, - 0x410ac4995677bca7, 0x410ac4995677bca7, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ace6a9ca4a749, 0x410ad83be2d191eb, - 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ad83be2d191eb, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, 0x410ae20d28fe7c8c, - 0x410ae20d28fe7c8c, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410aebde6f2b672e, 0x410af5afb55851cf, 0x410af5afb55851cf, - 0x410af5afb55851cf, 0x410af5afb55851cf, 0x410af5afb55851cf, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, 0x410aff80fb853c71, - 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b095241b22713, 0x410b132387df11b4, 0x410b132387df11b4, 0x410b132387df11b4, - 0x410b132387df11b4, 0x410b132387df11b4, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b1cf4ce0bfc56, 0x410b26c61438e6f8, - 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b26c61438e6f8, 0x410b30975a65d199, 0x410b30975a65d199, 0x410b30975a65d199, 0x410b30975a65d199, - 0x410b30975a65d199, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b3a68a092bc3b, 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, - 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, 0x410b4439e6bfa6dc, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, 0x410b4e0b2cec917e, - 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b57dc73197c20, 0x410b61adb94666c1, 0x410b61adb94666c1, 0x410b61adb94666c1, - 0x410b61adb94666c1, 0x410b61adb94666c1, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b6b7eff735163, 0x410b755045a03c04, - 0x410b755045a03c04, 0x410b755045a03c04, 0x410b755045a03c04, 0x410b755045a03c04, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, 0x410b7f218bcd26a6, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 7168 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x410b7f218bcd26a6, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b88f2d1fa1148, 0x410b92c41826fbe9, 0x410b92c41826fbe9, - 0x410b92c41826fbe9, 0x410b92c41826fbe9, 0x410b92c41826fbe9, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, 0x410b9c955e53e68b, - 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410ba666a480d12d, 0x410bb037eaadbbce, 0x410bb037eaadbbce, 0x410bb037eaadbbce, - 0x410bb037eaadbbce, 0x410bb037eaadbbce, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bba0930daa670, 0x410bc3da77079111, - 0x410bc3da77079111, 0x410bc3da77079111, 0x410bc3da77079111, 0x410bc3da77079111, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, 0x410bcdabbd347bb3, - 0x410bcdabbd347bb3, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410bd77d03616655, 0x410be14e498e50f6, 0x410be14e498e50f6, - 0x410be14e498e50f6, 0x410be14e498e50f6, 0x410be14e498e50f6, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, 0x410beb1f8fbb3b98, - 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bf4f0d5e82639, 0x410bfec21c1510db, 0x410bfec21c1510db, 0x410bfec21c1510db, - 0x410bfec21c1510db, 0x410bfec21c1510db, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c08936241fb7d, 0x410c1264a86ee61e, - 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1264a86ee61e, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, 0x410c1c35ee9bd0c0, - 0x410c1c35ee9bd0c0, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb62, 0x410c260734c8bb61, 0x410c2fd87af5a603, 0x410c2fd87af5a603, - 0x410c2fd87af5a603, 0x410c2fd87af5a603, 0x410c2fd87af5a603, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, 0x410c39a9c12290a5, - 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c437b074f7b46, 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, - 0x410c4d4c4d7c65e8, 0x410c4d4c4d7c65e8, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c571d93a9508a, 0x410c60eed9d63b2b, - 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c60eed9d63b2b, 0x410c6ac0200325cd, 0x410c6ac0200325cd, 0x410c6ac0200325cd, 0x410c6ac0200325cd, - 0x410c6ac0200325cd, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c74916630106e, 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, - 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, 0x410c7e62ac5cfb10, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, 0x410c8833f289e5b2, - 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c920538b6d053, 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, - 0x410c9bd67ee3baf5, 0x410c9bd67ee3baf5, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a597, 0x410ca5a7c510a596, 0x410caf790b3d9038, - 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410caf790b3d9038, 0x410cb94a516a7ada, 0x410cb94a516a7ada, 0x410cb94a516a7ada, 0x410cb94a516a7ada, - 0x410cb94a516a7ada, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cc31b9797657b, 0x410cccecddc4501d, 0x410cccecddc4501d, - 0x410cccecddc4501d, 0x410cccecddc4501d, 0x410cccecddc4501d, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, 0x410cd6be23f13abf, - 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410ce08f6a1e2560, 0x410cea60b04b1002, 0x410cea60b04b1002, 0x410cea60b04b1002, - 0x410cea60b04b1002, 0x410cea60b04b1002, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cf431f677faa3, 0x410cfe033ca4e545, - 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410cfe033ca4e545, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, 0x410d07d482d1cfe7, - 0x410d07d482d1cfe7, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d11a5c8feba88, 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, - 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, 0x410d1b770f2ba52a, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcc, 0x410d254855588fcb, - 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d2f199b857a6d, 0x410d38eae1b2650f, 0x410d38eae1b2650f, 0x410d38eae1b2650f, - 0x410d38eae1b2650f, 0x410d38eae1b2650f, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d42bc27df4fb0, 0x410d4c8d6e0c3a52, - 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d4c8d6e0c3a52, 0x410d565eb43924f4, 0x410d565eb43924f4, 0x410d565eb43924f4, 0x410d565eb43924f4, - 0x410d565eb43924f4, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d602ffa660f95, 0x410d6a014092fa37, 0x410d6a014092fa37, - 0x410d6a014092fa37, 0x410d6a014092fa37, 0x410d6a014092fa37, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, 0x410d73d286bfe4d8, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 7680 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d7da3cceccf7a, 0x410d87751319ba1c, 0x410d87751319ba1c, 0x410d87751319ba1c, - 0x410d87751319ba1c, 0x410d87751319ba1c, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d91465946a4bd, 0x410d9b179f738f5f, - 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410d9b179f738f5f, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, 0x410da4e8e5a07a01, - 0x410da4e8e5a07a00, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410daeba2bcd64a2, 0x410db88b71fa4f44, 0x410db88b71fa4f44, - 0x410db88b71fa4f44, 0x410db88b71fa4f44, 0x410db88b71fa4f44, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, 0x410dc25cb82739e5, - 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dcc2dfe542487, 0x410dd5ff44810f29, 0x410dd5ff44810f29, 0x410dd5ff44810f29, - 0x410dd5ff44810f29, 0x410dd5ff44810f29, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410ddfd08aadf9ca, 0x410de9a1d0dae46c, - 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410de9a1d0dae46c, 0x410df3731707cf0d, 0x410df3731707cf0d, 0x410df3731707cf0d, 0x410df3731707cf0d, - 0x410df3731707cf0d, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410dfd445d34b9af, 0x410e0715a361a451, 0x410e0715a361a451, - 0x410e0715a361a451, 0x410e0715a361a451, 0x410e0715a361a451, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, 0x410e10e6e98e8ef2, - 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e1ab82fbb7994, 0x410e248975e86436, 0x410e248975e86436, 0x410e248975e86436, - 0x410e248975e86436, 0x410e248975e86435, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e2e5abc154ed7, 0x410e382c02423979, - 0x410e382c02423979, 0x410e382c02423979, 0x410e382c02423979, 0x410e382c02423979, 0x410e41fd486f241a, 0x410e41fd486f241a, 0x410e41fd486f241a, 0x410e41fd486f241a, - 0x410e41fd486f241a, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e4bce8e9c0ebc, 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, - 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, 0x410e559fd4c8f95e, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, 0x410e5f711af5e3ff, - 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e69426122cea1, 0x410e7313a74fb942, 0x410e7313a74fb942, 0x410e7313a74fb942, - 0x410e7313a74fb942, 0x410e7313a74fb942, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e7ce4ed7ca3e4, 0x410e86b633a98e86, - 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e86b633a98e86, 0x410e908779d67927, 0x410e908779d67927, 0x410e908779d67927, 0x410e908779d67927, - 0x410e908779d67927, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410e9a58c00363c9, 0x410ea42a06304e6b, 0x410ea42a06304e6b, - 0x410ea42a06304e6b, 0x410ea42a06304e6b, 0x410ea42a06304e6a, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, 0x410eadfb4c5d390c, - 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410eb7cc928a23ae, 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, - 0x410ec19dd8b70e4f, 0x410ec19dd8b70e4f, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ecb6f1ee3f8f1, 0x410ed5406510e393, - 0x410ed5406510e393, 0x410ed5406510e393, 0x410ed5406510e393, 0x410ed5406510e393, 0x410edf11ab3dce34, 0x410edf11ab3dce34, 0x410edf11ab3dce34, 0x410edf11ab3dce34, - 0x410edf11ab3dce34, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ee8e2f16ab8d6, 0x410ef2b43797a377, 0x410ef2b43797a377, - 0x410ef2b43797a377, 0x410ef2b43797a377, 0x410ef2b43797a377, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, 0x410efc857dc48e19, - 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f0656c3f178bb, 0x410f10280a1e635c, 0x410f10280a1e635c, 0x410f10280a1e635c, - 0x410f10280a1e635c, 0x410f10280a1e635c, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f19f9504b4dfe, 0x410f23ca967838a0, - 0x410f23ca967838a0, 0x410f23ca967838a0, 0x410f23ca967838a0, 0x410f23ca9678389f, 0x410f2d9bdca52341, 0x410f2d9bdca52341, 0x410f2d9bdca52341, 0x410f2d9bdca52341, - 0x410f2d9bdca52341, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f376d22d20de3, 0x410f413e68fef884, 0x410f413e68fef884, - 0x410f413e68fef884, 0x410f413e68fef884, 0x410f413e68fef884, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, 0x410f4b0faf2be326, - 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f54e0f558cdc8, 0x410f5eb23b85b869, 0x410f5eb23b85b869, 0x410f5eb23b85b869, - 0x410f5eb23b85b869, 0x410f5eb23b85b869, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f688381b2a30b, 0x410f7254c7df8dac, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 8192 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7254c7df8dac, 0x410f7c260e0c784e, 0x410f7c260e0c784e, 0x410f7c260e0c784e, 0x410f7c260e0c784e, - 0x410f7c260e0c784e, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f85f7543962f0, 0x410f8fc89a664d91, 0x410f8fc89a664d91, - 0x410f8fc89a664d91, 0x410f8fc89a664d91, 0x410f8fc89a664d91, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, 0x410f9999e0933833, - 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d5, 0x410fa36b26c022d4, 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, - 0x410fad3c6ced0d76, 0x410fad3c6ced0d76, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fb70db319f818, 0x410fc0def946e2b9, - 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fc0def946e2b9, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, 0x410fcab03f73cd5b, - 0x410fcab03f73cd5b, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fd48185a0b7fd, 0x410fde52cbcda29e, 0x410fde52cbcda29e, - 0x410fde52cbcda29e, 0x410fde52cbcda29e, 0x410fde52cbcda29e, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, 0x410fe82411fa8d40, - 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ff1f5582777e1, 0x410ffbc69e546283, 0x410ffbc69e546283, 0x410ffbc69e546283, - 0x410ffbc69e546283, 0x410ffbc69e546283, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411002cbf240a692, 0x411007b495571be3, - 0x411007b495571be3, 0x411007b495571be3, 0x411007b495571be3, 0x411007b495571be3, 0x41100c9d386d9134, 0x41100c9d386d9134, 0x41100c9d386d9134, 0x41100c9d386d9134, - 0x41100c9d386d9134, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x41101185db840685, 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, - 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, 0x4110166e7e9a7bd6, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, 0x41101b5721b0f126, - 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110203fc4c76677, 0x4110252867dddbc8, 0x4110252867dddbc8, 0x4110252867dddbc8, - 0x4110252867dddbc8, 0x4110252867dddbc8, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102a110af45119, 0x41102ef9ae0ac66a, - 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x41102ef9ae0ac66a, 0x411033e251213bba, 0x411033e251213bba, 0x411033e251213bba, 0x411033e251213bba, - 0x411033e251213bba, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x411038caf437b10b, 0x41103db3974e265c, 0x41103db3974e265c, - 0x41103db3974e265c, 0x41103db3974e265c, 0x41103db3974e265c, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, 0x4110429c3a649bad, - 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104784dd7b10fe, 0x41104c6d8091864e, 0x41104c6d8091864e, 0x41104c6d8091864e, - 0x41104c6d8091864e, 0x41104c6d8091864e, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110515623a7fb9f, 0x4110563ec6be70f0, - 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x4110563ec6be70f0, 0x41105b2769d4e641, 0x41105b2769d4e641, 0x41105b2769d4e641, 0x41105b2769d4e641, - 0x41105b2769d4e641, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411060100ceb5b92, 0x411064f8b001d0e2, 0x411064f8b001d0e2, - 0x411064f8b001d0e2, 0x411064f8b001d0e3, 0x411064f8b001d0e2, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, 0x411069e153184633, - 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x41106ec9f62ebb84, 0x411073b2994530d5, 0x411073b2994530d5, 0x411073b2994530d5, - 0x411073b2994530d5, 0x411073b2994530d5, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x4110789b3c5ba626, 0x41107d83df721b77, - 0x41107d83df721b77, 0x41107d83df721b77, 0x41107d83df721b77, 0x41107d83df721b77, 0x4110826c828890c7, 0x4110826c828890c7, 0x4110826c828890c7, 0x4110826c828890c7, - 0x4110826c828890c7, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108755259f0618, 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, - 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, 0x41108c3dc8b57b69, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, 0x411091266bcbf0ba, - 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x4110960f0ee2660b, 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, - 0x41109af7b1f8db5b, 0x41109af7b1f8db5b, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x41109fe0550f50ac, 0x4110a4c8f825c5fd, - 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a4c8f825c5fd, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, 0x4110a9b19b3c3b4e, - 0x4110a9b19b3c3b4e, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110ae9a3e52b09f, 0x4110b382e16925ef, 0x4110b382e16925ef, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 8704 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4110b382e16925ef, 0x4110b382e16925ef, 0x4110b382e16925ef, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, 0x4110b86b847f9b40, - 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110bd5427961091, 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, - 0x4110c23ccaac85e2, 0x4110c23ccaac85e2, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110c7256dc2fb33, 0x4110cc0e10d97083, - 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110cc0e10d97083, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, 0x4110d0f6b3efe5d4, - 0x4110d0f6b3efe5d4, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110d5df57065b25, 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, - 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, 0x4110dac7fa1cd076, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, 0x4110dfb09d3345c7, - 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e4994049bb17, 0x4110e981e3603068, 0x4110e981e3603068, 0x4110e981e3603068, - 0x4110e981e3603068, 0x4110e981e3603068, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110ee6a8676a5b9, 0x4110f353298d1b0a, - 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f353298d1b0a, 0x4110f83bcca3905b, 0x4110f83bcca3905b, 0x4110f83bcca3905b, 0x4110f83bcca3905b, - 0x4110f83bcca3905b, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4110fd246fba05ac, 0x4111020d12d07afc, 0x4111020d12d07afc, - 0x4111020d12d07afc, 0x4111020d12d07afc, 0x4111020d12d07afc, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, 0x411106f5b5e6f04d, - 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x41110bde58fd659e, 0x411110c6fc13daef, 0x411110c6fc13daef, 0x411110c6fc13daef, - 0x411110c6fc13daef, 0x411110c6fc13daef, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x411115af9f2a5040, 0x41111a984240c590, - 0x41111a984240c590, 0x41111a984240c590, 0x41111a984240c590, 0x41111a984240c590, 0x41111f80e5573ae1, 0x41111f80e5573ae1, 0x41111f80e5573ae1, 0x41111f80e5573ae1, - 0x41111f80e5573ae1, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x41112469886db032, 0x411129522b842583, 0x411129522b842583, - 0x411129522b842583, 0x411129522b842583, 0x411129522b842583, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, 0x41112e3ace9a9ad4, - 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111332371b11024, 0x4111380c14c78575, 0x4111380c14c78575, 0x4111380c14c78575, - 0x4111380c14c78575, 0x4111380c14c78575, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x41113cf4b7ddfac6, 0x411141dd5af47017, - 0x411141dd5af47017, 0x411141dd5af47017, 0x411141dd5af47017, 0x411141dd5af47017, 0x411146c5fe0ae568, 0x411146c5fe0ae568, 0x411146c5fe0ae568, 0x411146c5fe0ae568, - 0x411146c5fe0ae568, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x41114baea1215ab8, 0x411150974437d009, 0x411150974437d009, - 0x411150974437d009, 0x411150974437d009, 0x411150974437d009, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, 0x4111557fe74e455a, - 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115a688a64baab, 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, - 0x41115f512d7b2ffc, 0x41115f512d7b2ffc, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x41116439d091a54c, 0x4111692273a81a9d, - 0x4111692273a81a9d, 0x4111692273a81a9d, 0x4111692273a81a9d, 0x4111692273a81a9d, 0x41116e0b16be8fee, 0x41116e0b16be8fee, 0x41116e0b16be8fee, 0x41116e0b16be8fee, - 0x41116e0b16be8fee, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411172f3b9d5053f, 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, - 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, 0x411177dc5ceb7a90, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe1, 0x41117cc50001efe0, - 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x411181ada3186531, 0x41118696462eda82, 0x41118696462eda82, 0x41118696462eda82, - 0x41118696462eda82, 0x41118696462eda82, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x41118b7ee9454fd3, 0x411190678c5bc524, - 0x411190678c5bc524, 0x411190678c5bc524, 0x411190678c5bc524, 0x411190678c5bc524, 0x411195502f723a75, 0x411195502f723a75, 0x411195502f723a75, 0x411195502f723a75, - 0x411195502f723a75, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119a38d288afc5, 0x41119f21759f2516, 0x41119f21759f2516, - 0x41119f21759f2516, 0x41119f21759f2516, 0x41119f21759f2516, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, 0x4111a40a18b59a67, - 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111a8f2bbcc0fb8, 0x4111addb5ee28509, 0x4111addb5ee28509, 0x4111addb5ee28509, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 9216 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4111addb5ee28509, 0x4111addb5ee28509, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b2c401f8fa59, 0x4111b7aca50f6faa, - 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111b7aca50f6faa, 0x4111bc954825e4fb, 0x4111bc954825e4fb, 0x4111bc954825e4fb, 0x4111bc954825e4fb, - 0x4111bc954825e4fb, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c17deb3c5a4c, 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, - 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, 0x4111c6668e52cf9d, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, 0x4111cb4f316944ed, - 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d037d47fba3e, 0x4111d52077962f8f, 0x4111d52077962f8f, 0x4111d52077962f8f, - 0x4111d52077962f8f, 0x4111d52077962f8f, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111da091aaca4e0, 0x4111def1bdc31a31, - 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111def1bdc31a31, 0x4111e3da60d98f81, 0x4111e3da60d98f81, 0x4111e3da60d98f81, 0x4111e3da60d98f81, - 0x4111e3da60d98f81, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111e8c303f004d2, 0x4111edaba7067a23, 0x4111edaba7067a23, - 0x4111edaba7067a23, 0x4111edaba7067a23, 0x4111edaba7067a23, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, 0x4111f2944a1cef74, - 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111f77ced3364c5, 0x4111fc659049da16, 0x4111fc659049da16, 0x4111fc659049da16, - 0x4111fc659049da16, 0x4111fc659049da15, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x4112014e33604f66, 0x41120636d676c4b7, - 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120636d676c4b7, 0x41120b1f798d3a08, 0x41120b1f798d3a08, 0x41120b1f798d3a08, 0x41120b1f798d3a08, - 0x41120b1f798d3a08, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411210081ca3af59, 0x411214f0bfba24aa, 0x411214f0bfba24aa, - 0x411214f0bfba24aa, 0x411214f0bfba24aa, 0x411214f0bfba24aa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, 0x411219d962d099fa, - 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x41121ec205e70f4b, 0x411223aaa8fd849c, 0x411223aaa8fd849c, 0x411223aaa8fd849c, - 0x411223aaa8fd849c, 0x411223aaa8fd849c, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x411228934c13f9ed, 0x41122d7bef2a6f3e, - 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x41122d7bef2a6f3e, 0x411232649240e48e, 0x411232649240e48e, 0x411232649240e48e, 0x411232649240e48e, - 0x411232649240e48e, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x4112374d355759df, 0x41123c35d86dcf30, 0x41123c35d86dcf30, - 0x41123c35d86dcf30, 0x41123c35d86dcf30, 0x41123c35d86dcf30, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, 0x4112411e7b844481, - 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x411246071e9ab9d2, 0x41124aefc1b12f22, 0x41124aefc1b12f22, 0x41124aefc1b12f22, - 0x41124aefc1b12f22, 0x41124aefc1b12f22, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x41124fd864c7a473, 0x411254c107de19c4, - 0x411254c107de19c4, 0x411254c107de19c4, 0x411254c107de19c4, 0x411254c107de19c4, 0x411259a9aaf48f15, 0x411259a9aaf48f15, 0x411259a9aaf48f15, 0x411259a9aaf48f15, - 0x411259a9aaf48f15, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x41125e924e0b0466, 0x4112637af12179b6, 0x4112637af12179b6, - 0x4112637af12179b6, 0x4112637af12179b6, 0x4112637af12179b6, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, 0x411268639437ef07, - 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41126d4c374e6458, 0x41127234da64d9a9, 0x41127234da64d9a9, 0x41127234da64d9a9, - 0x41127234da64d9a9, 0x41127234da64d9a9, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x4112771d7d7b4efa, 0x41127c062091c44b, - 0x41127c062091c44b, 0x41127c062091c44b, 0x41127c062091c44b, 0x41127c062091c44a, 0x411280eec3a8399b, 0x411280eec3a8399b, 0x411280eec3a8399b, 0x411280eec3a8399b, - 0x411280eec3a8399b, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x411285d766beaeec, 0x41128ac009d5243d, 0x41128ac009d5243d, - 0x41128ac009d5243d, 0x41128ac009d5243d, 0x41128ac009d5243d, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, 0x41128fa8aceb998e, - 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x4112949150020edf, 0x41129979f318842f, 0x41129979f318842f, 0x41129979f318842f, - 0x41129979f318842f, 0x41129979f318842f, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x41129e62962ef980, 0x4112a34b39456ed1, - 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a34b39456ed1, 0x4112a833dc5be422, 0x4112a833dc5be422, 0x4112a833dc5be422, 0x4112a833dc5be422, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 9728 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4112a833dc5be422, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112ad1c7f725973, 0x4112b2052288cec3, 0x4112b2052288cec3, - 0x4112b2052288cec3, 0x4112b2052288cec3, 0x4112b2052288cec3, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, 0x4112b6edc59f4414, - 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112bbd668b5b965, 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, - 0x4112c0bf0bcc2eb6, 0x4112c0bf0bcc2eb6, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112c5a7aee2a407, 0x4112ca9051f91957, - 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112ca9051f91957, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, 0x4112cf78f50f8ea8, - 0x4112cf78f50f8ea8, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d461982603f9, 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, - 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, 0x4112d94a3b3c794a, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, 0x4112de32de52ee9b, - 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e31b816963eb, 0x4112e804247fd93c, 0x4112e804247fd93c, 0x4112e804247fd93c, - 0x4112e804247fd93c, 0x4112e804247fd93c, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112ececc7964e8d, 0x4112f1d56aacc3de, - 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f1d56aacc3de, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, 0x4112f6be0dc3392f, - 0x4112f6be0dc3392f, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae80, 0x4112fba6b0d9ae7f, 0x4113008f53f023d0, 0x4113008f53f023d0, - 0x4113008f53f023d0, 0x4113008f53f023d0, 0x4113008f53f023d0, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, 0x41130577f7069921, - 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130a609a1d0e72, 0x41130f493d3383c3, 0x41130f493d3383c3, 0x41130f493d3383c3, - 0x41130f493d3383c3, 0x41130f493d3383c3, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x41131431e049f914, 0x4113191a83606e64, - 0x4113191a83606e64, 0x4113191a83606e64, 0x4113191a83606e64, 0x4113191a83606e64, 0x41131e032676e3b5, 0x41131e032676e3b5, 0x41131e032676e3b5, 0x41131e032676e3b5, - 0x41131e032676e3b5, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411322ebc98d5906, 0x411327d46ca3ce57, 0x411327d46ca3ce57, - 0x411327d46ca3ce57, 0x411327d46ca3ce57, 0x411327d46ca3ce57, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, 0x41132cbd0fba43a8, - 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x4063a28c59d5433b, 0x40774475ad031dbf, 0x40774475ad031dbf, 0x40774475ad031dbf, - 0x40774475ad031dc0, 0x40774475ad031dbf, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x40825bd2968dccf1, 0x4089156a569a0b02, - 0x4089156a569a0b02, 0x4089156a569a0b02, 0x4089156a569a0b02, 0x4089156a569a0b02, 0x408fcf0216a64913, 0x408fcf0216a64913, 0x408fcf0216a64913, 0x408fcf0216a64913, - 0x408fcf0216a64913, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4093444ceb594392, 0x4096a118cb5f629a, 0x4096a118cb5f629a, - 0x4096a118cb5f629a, 0x4096a118cb5f629a, 0x4096a118cb5f629a, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, 0x4099fde4ab6581a3, - 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x409d5ab08b6ba0ab, 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, - 0x40a05bbe35b8dfda, 0x40a05bbe35b8dfda, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a20a2425bbef5e, 0x40a3b88a15befee2, - 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a3b88a15befee2, 0x40a566f005c20e67, 0x40a566f005c20e67, 0x40a566f005c20e67, 0x40a566f005c20e67, - 0x40a566f005c20e67, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a71555f5c51deb, 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, - 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, 0x40a8c3bbe5c82d6f, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, 0x40aa7221d5cb3cf3, - 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40ac2087c5ce4c78, 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, - 0x40adceedb5d15bfc, 0x40adceedb5d15bfc, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40af7d53a5d46b80, 0x40b095dccaebbd82, - 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b095dccaebbd82, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, 0x40b16d0fc2ed4544, - 0x40b16d0fc2ed4544, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b24442baeecd06, 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, - 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, 0x40b31b75b2f054c9, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, 0x40b3f2a8aaf1dc8b, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d1e56d15d49d932, 0x3d1e56d15d49d932, 0x3d1e56d15d49d932, - 0xbd20d497515b1367, 0x3d1e56d15d49d932, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d2162ace0052e27, - 0x3d2162ace0052e27, 0x3d2162ace0052e27, 0x3d2162ace0052e27, 0x3d2162ace0052e27, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd21f0c26eaf48e7, 0xbd21f0c26eaf48e7, 0xbd21f0c26eaf48e7, 0xbd21f0c26eaf48e7, 0xbd21f0c26eaf48e7, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d227ed7fd5963a8, 0x3d227ed7fd5963a8, 0x3d227ed7fd5963a8, 0x3d227ed7fd5963a8, 0x3d227ed7fd5963a8, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd230ced8c037e68, 0xbd230ced8c037e68, 0xbd230ced8c037e68, - 0xbd230ced8c037e68, 0xbd230ced8c037e68, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4b193f395499b6, - 0xbd4b193f395499b6, 0xbd4b193f395499b6, 0xbd4b193f395499b6, 0xbd4b193f395499b6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd242918a957b3e9, 0xbd242918a957b3e9, 0xbd242918a957b3e9, 0xbd242918a957b3e9, 0xbd242918a957b3e9, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4ad23471ff8c56, 0xbd4ad23471ff8c56, 0xbd4ad23471ff8c56, 0xbd4ad23471ff8c56, 0xbd4ad23471ff8c56, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd254543c6abe969, 0xbd254543c6abe969, 0xbd254543c6abe969, - 0xbd254543c6abe969, 0xbd254543c6abe969, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4a8b29aaaa7ef6, - 0xbd4a8b29aaaa7ef6, 0xbd4a8b29aaaa7ef6, 0xbd4a8b29aaaa7ef6, 0xbd4a8b29aaaa7ef6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d5d33d2237ffc23, 0x3d5d33d2237ffc23, 0x3d5d33d2237ffc23, 0x3d5d33d2237ffc23, 0x3d5d33d2237ffc23, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d52ddf08e554735, 0x3d52ddf08e554735, 0x3d52ddf08e554735, 0x3d52ddf08e554735, 0x3d52ddf08e554735, -] )) ), - -################ chunk 10240 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b4c9dba2f3644d, 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, - 0x40b5a10e9af4ec0f, 0x40b5a10e9af4ec0f, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b6784192f673d1, 0x40b74f748af7fb93, - 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b74f748af7fb93, 0x40b826a782f98355, 0x40b826a782f98355, 0x40b826a782f98355, 0x40b826a782f98355, - 0x40b826a782f98355, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b8fdda7afb0b17, 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, - 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, 0x40b9d50d72fc92da, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, 0x40baac406afe1a9c, - 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bb837362ffa25e, 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, - 0x40bc5aa65b012a20, 0x40bc5aa65b012a20, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40bd31d95302b1e2, 0x40be090c4b0439a4, - 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40be090c4b0439a4, 0x40bee03f4305c166, 0x40bee03f4305c166, 0x40bee03f4305c166, 0x40bee03f4305c166, - 0x40bee03f4305c166, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40bfb7723b074928, 0x40c0475299846875, 0x40c0475299846875, - 0x40c0475299846875, 0x40c0475299846875, 0x40c0475299846875, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, 0x40c0b2ec15852c56, - 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c11e859185f037, 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, - 0x40c18a1f0d86b418, 0x40c18a1f0d86b418, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c1f5b8898777fa, 0x40c2615205883bdb, - 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2615205883bdb, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, 0x40c2cceb8188ffbc, - 0x40c2cceb8188ffbc, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c33884fd89c39d, 0x40c3a41e798a877e, 0x40c3a41e798a877e, - 0x40c3a41e798a877e, 0x40c3a41e798a877e, 0x40c3a41e798a877e, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, 0x40c40fb7f58b4b5f, - 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c47b51718c0f40, 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, - 0x40c4e6eaed8cd321, 0x40c4e6eaed8cd321, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c55284698d9702, 0x40c5be1de58e5ae3, - 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c5be1de58e5ae3, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, 0x40c629b7618f1ec4, - 0x40c629b7618f1ec4, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c69550dd8fe2a5, 0x40c700ea5990a686, 0x40c700ea5990a686, - 0x40c700ea5990a686, 0x40c700ea5990a686, 0x40c700ea5990a686, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, 0x40c76c83d5916a67, - 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c7d81d51922e48, 0x40c843b6cd92f229, 0x40c843b6cd92f229, 0x40c843b6cd92f229, - 0x40c843b6cd92f229, 0x40c843b6cd92f229, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c8af504993b60b, 0x40c91ae9c59479ec, - 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c91ae9c59479ec, 0x40c9868341953dcd, 0x40c9868341953dcd, 0x40c9868341953dcd, 0x40c9868341953dcd, - 0x40c9868341953dcd, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40c9f21cbd9601ae, 0x40ca5db63996c58f, 0x40ca5db63996c58f, - 0x40ca5db63996c58f, 0x40ca5db63996c58f, 0x40ca5db63996c58f, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, 0x40cac94fb5978970, - 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cb34e931984d51, 0x40cba082ad991132, 0x40cba082ad991132, 0x40cba082ad991132, - 0x40cba082ad991132, 0x40cba082ad991132, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc0c1c2999d513, 0x40cc77b5a59a98f4, - 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cc77b5a59a98f4, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, 0x40cce34f219b5cd5, - 0x40cce34f219b5cd5, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cd4ee89d9c20b6, 0x40cdba82199ce497, 0x40cdba82199ce497, - 0x40cdba82199ce497, 0x40cdba82199ce497, 0x40cdba82199ce497, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, 0x40ce261b959da878, - 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40ce91b5119e6c59, 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, - 0x40cefd4e8d9f303a, 0x40cefd4e8d9f303a, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cf68e8099ff41c, 0x40cfd48185a0b7fd, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd277d9a0154546b, 0xbd277d9a0154546b, 0xbd277d9a0154546b, - 0xbd277d9a0154546b, 0xbd277d9a0154546b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd49fd141c006435, - 0xbd49fd141c006435, 0xbd49fd141c006435, 0xbd49fd141c006435, 0xbd49fd141c006435, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d5cecc75c2aeec3, 0x3d5cecc75c2aeec3, 0x3d5cecc75c2aeec3, 0x3d5cecc75c2aeec3, 0x3d5cecc75c2aeec3, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d5324fb55aa5495, 0x3d5324fb55aa5495, 0x3d5324fb55aa5495, 0x3d5324fb55aa5495, 0x3d5324fb55aa5495, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd29b5f03bfcbf6c, 0xbd29b5f03bfcbf6c, 0xbd29b5f03bfcbf6c, - 0xbd29b5f03bfcbf6c, 0xbd29b5f03bfcbf6c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd496efe8d564975, - 0xbd496efe8d564975, 0xbd496efe8d564975, 0xbd496efe8d564975, 0xbd496efe8d564975, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d5ca5bc94d5e162, 0x3d5ca5bc94d5e162, 0x3d5ca5bc94d5e162, 0x3d5ca5bc94d5e162, 0x3d5ca5bc94d5e162, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6649fcf1804f05, 0xbd6649fcf1804f05, 0xbd6649fcf1804f05, 0xbd6649fcf1804f05, 0xbd6649fcf1804f05, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6e411b9895ad59, 0x3d6e411b9895ad59, 0x3d6e411b9895ad59, - 0x3d6e411b9895ad59, 0x3d6e411b9895ad59, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d69c7c5c054f453, - 0x3d69c7c5c054f453, 0x3d69c7c5c054f453, 0x3d69c7c5c054f453, 0x3d69c7c5c054f453, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd61d0a7193f95ff, 0xbd61d0a7193f95ff, 0xbd61d0a7193f95ff, 0xbd61d0a7193f95ff, 0xbd61d0a7193f95ff, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d53b310e4546f56, 0x3d53b310e4546f56, 0x3d53b310e4546f56, 0x3d53b310e4546f56, 0x3d53b310e4546f56, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd2e269cb14d956e, 0xbd2e269cb14d956e, 0xbd2e269cb14d956e, - 0xbd2e269cb14d956e, 0xbd2e269cb14d956e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4852d3700213f4, - 0xbd4852d3700213f4, 0xbd4852d3700213f4, 0xbd4852d3700213f4, 0xbd4852d3700213f4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d5c17a7062bc6a2, 0x3d5c17a7062bc6a2, 0x3d5c17a7062bc6a2, 0x3d5c17a7062bc6a2, 0x3d5c17a7062bc6a2, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6602f22a2b41a5, 0xbd6602f22a2b41a5, 0xbd6602f22a2b41a5, 0xbd6602f22a2b41a5, 0xbd6602f22a2b41a5, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6dfa10d1409ff9, 0x3d6dfa10d1409ff9, 0x3d6dfa10d1409ff9, - 0x3d6dfa10d1409ff9, 0x3d6dfa10d1409ff9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6a0ed087aa01b3, - 0x3d6a0ed087aa01b3, 0x3d6a0ed087aa01b3, 0x3d6a0ed087aa01b3, 0x3d6a0ed087aa01b3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd6217b1e094a35f, 0xbd6217b1e094a35f, 0xbd6217b1e094a35f, 0xbd6217b1e094a35f, 0xbd6217b1e094a35f, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d54412672fe8a16, 0x3d54412672fe8a16, 0x3d54412672fe8a16, 0x3d54412672fe8a16, 0x3d54412672fe8a16, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd314ba4934f35b9, 0xbd314ba4934f35b9, 0xbd314ba4934f35b9, - 0xbd314ba4934f35b9, 0xbd314ba4934f35b9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd4736a852adde74, - 0xbd4736a852adde74, 0xbd4736a852adde74, 0xbd4736a852adde74, 0xbd4736a852adde74, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d5b89917781abe2, 0x3d5b89917781abe2, 0x3d5b89917781abe2, 0x3d5b89917781abe2, 0x3d5b89917781abe2, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd65bbe762d63445, 0xbd65bbe762d63445, 0xbd65bbe762d63445, 0xbd65bbe762d63445, 0xbd65bbe762d63445, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6db30609eb9299, 0x3d6db30609eb9299, 0x3d6db30609eb9299, - 0x3d6db30609eb9299, 0x3d6db30609eb9299, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6a55db4eff0f13, -] )) ), - -################ chunk 10752 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40cfd48185a0b7fd, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, 0x40d0200d80d0bdef, - 0x40d0200d80d0bdef, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d055da3ed11fdf, 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, - 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, 0x40d08ba6fcd181d0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, 0x40d0c173bad1e3c0, - 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d0f74078d245b1, 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, - 0x40d12d0d36d2a7a1, 0x40d12d0d36d2a7a1, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d162d9f4d30992, 0x40d198a6b2d36b83, - 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d198a6b2d36b83, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, 0x40d1ce7370d3cd73, - 0x40d1ce7370d3cd73, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d204402ed42f64, 0x40d23a0cecd49154, 0x40d23a0cecd49154, - 0x40d23a0cecd49154, 0x40d23a0cecd49154, 0x40d23a0cecd49154, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, 0x40d26fd9aad4f345, - 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2a5a668d55535, 0x40d2db7326d5b726, 0x40d2db7326d5b726, 0x40d2db7326d5b726, - 0x40d2db7326d5b726, 0x40d2db7326d5b726, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3113fe4d61916, 0x40d3470ca2d67b07, - 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d3470ca2d67b07, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, 0x40d37cd960d6dcf7, - 0x40d37cd960d6dcf7, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3b2a61ed73ee8, 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, - 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, 0x40d3e872dcd7a0d8, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, 0x40d41e3f9ad802c9, - 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d4540c58d864b9, 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, - 0x40d489d916d8c6aa, 0x40d489d916d8c6aa, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4bfa5d4d9289b, 0x40d4f57292d98a8b, - 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d4f57292d98a8b, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, 0x40d52b3f50d9ec7c, - 0x40d52b3f50d9ec7c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d5610c0eda4e6c, 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, - 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, 0x40d596d8ccdab05d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, 0x40d5cca58adb124d, - 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6027248db743e, 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, - 0x40d6383f06dbd62e, 0x40d6383f06dbd62e, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d66e0bc4dc381f, 0x40d6a3d882dc9a0f, - 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6a3d882dc9a0f, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, 0x40d6d9a540dcfc00, - 0x40d6d9a540dcfc00, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d70f71fedd5df0, 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, - 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, 0x40d7453ebcddbfe1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, 0x40d77b0b7ade21d1, - 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7b0d838de83c2, 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, - 0x40d7e6a4f6dee5b2, 0x40d7e6a4f6dee5b2, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d81c71b4df47a3, 0x40d8523e72dfa994, - 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8523e72dfa994, 0x40d8880b30e00b84, 0x40d8880b30e00b84, 0x40d8880b30e00b84, 0x40d8880b30e00b84, - 0x40d8880b30e00b84, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8bdd7eee06d75, 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, - 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, 0x40d8f3a4ace0cf65, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, 0x40d929716ae13156, - 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d95f3e28e19346, 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, - 0x40d9950ae6e1f537, 0x40d9950ae6e1f537, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40d9cad7a4e25727, 0x40da00a462e2b918, - 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da00a462e2b918, 0x40da367120e31b08, 0x40da367120e31b08, 0x40da367120e31b08, 0x40da367120e31b08, - 0x40da367120e31b08, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40da6c3ddee37cf9, 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d6a55db4eff0f13, 0x3d6a55db4eff0f13, 0x3d6a55db4eff0f13, 0x3d6a55db4eff0f13, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d76d0a1ac0b27a0, 0x3d76d0a1ac0b27a0, 0x3d76d0a1ac0b27a0, 0x3d76d0a1ac0b27a0, 0x3d76d0a1ac0b27a0, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7acc30ff95d6ca, 0xbd7acc30ff95d6ca, 0xbd7acc30ff95d6ca, 0xbd7acc30ff95d6ca, 0xbd7acc30ff95d6ca, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7ec7c0532085f4, 0x3d7ec7c0532085f4, 0x3d7ec7c0532085f4, - 0x3d7ec7c0532085f4, 0x3d7ec7c0532085f4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7d3cb05954cae2, - 0x3d7d3cb05954cae2, 0x3d7d3cb05954cae2, 0x3d7d3cb05954cae2, 0x3d7d3cb05954cae2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd79412105ca1bb8, 0xbd79412105ca1bb8, 0xbd79412105ca1bb8, 0xbd79412105ca1bb8, 0xbd79412105ca1bb8, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d754591b23f6c8e, 0x3d754591b23f6c8e, 0x3d754591b23f6c8e, 0x3d754591b23f6c8e, 0x3d754591b23f6c8e, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd714a025eb4bd64, 0xbd714a025eb4bd64, 0xbd714a025eb4bd64, - 0xbd714a025eb4bd64, 0xbd714a025eb4bd64, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6a9ce616541c73, - 0x3d6a9ce616541c73, 0x3d6a9ce616541c73, 0x3d6a9ce616541c73, 0x3d6a9ce616541c73, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd62a5c76f3ebe1f, 0xbd62a5c76f3ebe1f, 0xbd62a5c76f3ebe1f, 0xbd62a5c76f3ebe1f, 0xbd62a5c76f3ebe1f, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d555d519052bf97, 0x3d555d519052bf97, 0x3d555d519052bf97, 0x3d555d519052bf97, 0x3d555d519052bf97, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd35bc5108a00bbb, 0xbd35bc5108a00bbb, 0xbd35bc5108a00bbb, - 0xbd35bc5108a00bbb, 0xbd35bc5108a00bbb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd44fe5218057372, - 0xbd44fe5218057372, 0xbd44fe5218057372, 0xbd44fe5218057372, 0xbd44fe5218057372, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d5a6d665a2d7661, 0x3d5a6d665a2d7661, 0x3d5a6d665a2d7661, 0x3d5a6d665a2d7661, 0x3d5a6d665a2d7661, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd652dd1d42c1985, 0xbd652dd1d42c1985, 0xbd652dd1d42c1985, 0xbd652dd1d42c1985, 0xbd652dd1d42c1985, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6d24f07b4177d9, 0x3d6d24f07b4177d9, 0x3d6d24f07b4177d9, - 0x3d6d24f07b4177d9, 0x3d6d24f07b4177d9, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd728e07912b6b16, - 0xbd728e07912b6b16, 0xbd728e07912b6b16, 0xbd728e07912b6b16, 0xbd728e07912b6b16, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d768996e4b61a40, 0x3d768996e4b61a40, 0x3d768996e4b61a40, 0x3d768996e4b61a40, 0x3d768996e4b61a40, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7a85263840c96a, 0xbd7a85263840c96a, 0xbd7a85263840c96a, 0xbd7a85263840c96a, 0xbd7a85263840c96a, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7e80b58bcb7894, 0x3d7e80b58bcb7894, 0x3d7e80b58bcb7894, - 0x3d7e80b58bcb7894, 0x3d7e80b58bcb7894, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7d83bb20a9d842, - 0x3d7d83bb20a9d842, 0x3d7d83bb20a9d842, 0x3d7d83bb20a9d842, 0x3d7d83bb20a9d842, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd79882bcd1f2918, 0xbd79882bcd1f2918, 0xbd79882bcd1f2918, 0xbd79882bcd1f2918, 0xbd79882bcd1f2918, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d758c9c799479ee, 0x3d758c9c799479ee, 0x3d758c9c799479ee, 0x3d758c9c799479ee, 0x3d758c9c799479ee, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd71910d2609cac4, 0xbd71910d2609cac4, 0xbd71910d2609cac4, - 0xbd71910d2609cac4, 0xbd71910d2609cac4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6b2afba4fe3734, - 0x3d6b2afba4fe3734, 0x3d6b2afba4fe3734, 0x3d6b2afba4fe3734, 0x3d6b2afba4fe3734, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd6333dcfde8d8e0, 0xbd6333dcfde8d8e0, 0xbd6333dcfde8d8e0, 0xbd6333dcfde8d8e0, 0xbd6333dcfde8d8e0, 0xbff0000000000000, 0xbff0000000000000, -] )) ), - -################ chunk 11264 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, 0x40daa20a9ce3dee9, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, 0x40dad7d75ae440da, - 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db0da418e4a2ca, 0x40db4370d6e504bb, 0x40db4370d6e504bb, 0x40db4370d6e504bb, - 0x40db4370d6e504bb, 0x40db4370d6e504bb, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40db793d94e566ac, 0x40dbaf0a52e5c89c, - 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbaf0a52e5c89c, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, 0x40dbe4d710e62a8d, - 0x40dbe4d710e62a8d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc1aa3cee68c7d, 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, - 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, 0x40dc50708ce6ee6e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, 0x40dc863d4ae7505e, - 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcbc0a08e7b24f, 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, - 0x40dcf1d6c6e8143f, 0x40dcf1d6c6e8143f, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd27a384e87630, 0x40dd5d7042e8d820, - 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd5d7042e8d820, 0x40dd933d00e93a11, 0x40dd933d00e93a11, 0x40dd933d00e93a11, 0x40dd933d00e93a11, - 0x40dd933d00e93a11, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddc909bee99c01, 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, - 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, 0x40ddfed67ce9fdf2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, 0x40de34a33aea5fe2, - 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40de6a6ff8eac1d3, 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, - 0x40dea03cb6eb23c3, 0x40dea03cb6eb23c3, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40ded60974eb85b4, 0x40df0bd632ebe7a5, - 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df0bd632ebe7a5, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, 0x40df41a2f0ec4995, - 0x40df41a2f0ec4995, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40df776faeecab86, 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, - 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, 0x40dfad3c6ced0d76, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, 0x40dfe3092aed6f67, - 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e00c6af476e8ac, 0x40e02751537719a4, 0x40e02751537719a4, 0x40e02751537719a4, - 0x40e02751537719a4, 0x40e02751537719a4, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e04237b2774a9c, 0x40e05d1e11777b94, - 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e05d1e11777b94, 0x40e078047077ac8d, 0x40e078047077ac8d, 0x40e078047077ac8d, 0x40e078047077ac8d, - 0x40e078047077ac8d, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e092eacf77dd85, 0x40e0add12e780e7d, 0x40e0add12e780e7d, - 0x40e0add12e780e7d, 0x40e0add12e780e7d, 0x40e0add12e780e7d, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, 0x40e0c8b78d783f75, - 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0e39dec78706e, 0x40e0fe844b78a166, 0x40e0fe844b78a166, 0x40e0fe844b78a166, - 0x40e0fe844b78a166, 0x40e0fe844b78a166, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1196aaa78d25e, 0x40e1345109790357, - 0x40e1345109790357, 0x40e1345109790357, 0x40e1345109790357, 0x40e1345109790357, 0x40e14f376879344f, 0x40e14f376879344f, 0x40e14f376879344f, 0x40e14f376879344f, - 0x40e14f376879344f, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e16a1dc7796547, 0x40e185042679963f, 0x40e185042679963f, - 0x40e185042679963f, 0x40e185042679963f, 0x40e185042679963f, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, 0x40e19fea8579c738, - 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1bad0e479f830, 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, - 0x40e1d5b7437a2928, 0x40e1d5b7437a2928, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e1f09da27a5a20, 0x40e20b84017a8b19, - 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e20b84017a8b19, 0x40e2266a607abc11, 0x40e2266a607abc11, 0x40e2266a607abc11, 0x40e2266a607abc11, - 0x40e2266a607abc11, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e24150bf7aed09, 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, - 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, 0x40e25c371e7b1e01, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, 0x40e2771d7d7b4efa, - 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e29203dc7b7ff2, 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d56797cada6f517, 0x3d56797cada6f517, 0x3d56797cada6f517, 0x3d56797cada6f517, 0x3d56797cada6f517, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd3a2cfd7df0e1be, 0xbd3a2cfd7df0e1be, 0xbd3a2cfd7df0e1be, - 0xbd3a2cfd7df0e1be, 0xbd3a2cfd7df0e1be, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd42c5fbdd5d0871, - 0xbd42c5fbdd5d0871, 0xbd42c5fbdd5d0871, 0xbd42c5fbdd5d0871, 0xbd42c5fbdd5d0871, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d59513b3cd940e1, 0x3d59513b3cd940e1, 0x3d59513b3cd940e1, 0x3d59513b3cd940e1, 0x3d59513b3cd940e1, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd649fbc4581fec4, 0xbd649fbc4581fec4, 0xbd649fbc4581fec4, 0xbd649fbc4581fec4, 0xbd649fbc4581fec4, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6c96daec975d18, 0x3d6c96daec975d18, 0x3d6c96daec975d18, - 0x3d6c96daec975d18, 0x3d6c96daec975d18, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7246fcc9d65db6, - 0xbd7246fcc9d65db6, 0xbd7246fcc9d65db6, 0xbd7246fcc9d65db6, 0xbd7246fcc9d65db6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d76428c1d610ce0, 0x3d76428c1d610ce0, 0x3d76428c1d610ce0, 0x3d76428c1d610ce0, 0x3d76428c1d610ce0, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7a3e1b70ebbc0a, 0xbd7a3e1b70ebbc0a, 0xbd7a3e1b70ebbc0a, 0xbd7a3e1b70ebbc0a, 0xbd7a3e1b70ebbc0a, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7e39aac4766b34, 0x3d7e39aac4766b34, 0x3d7e39aac4766b34, - 0x3d7e39aac4766b34, 0x3d7e39aac4766b34, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7dcac5e7fee5a2, - 0x3d7dcac5e7fee5a2, 0x3d7dcac5e7fee5a2, 0x3d7dcac5e7fee5a2, 0x3d7dcac5e7fee5a2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd79cf3694743678, 0xbd79cf3694743678, 0xbd79cf3694743678, 0xbd79cf3694743678, 0xbd79cf3694743678, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d75d3a740e9874e, 0x3d75d3a740e9874e, 0x3d75d3a740e9874e, 0x3d75d3a740e9874e, 0x3d75d3a740e9874e, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd71d817ed5ed824, 0xbd71d817ed5ed824, 0xbd71d817ed5ed824, - 0xbd71d817ed5ed824, 0xbd71d817ed5ed824, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8911bbb315eb83, - 0xbd8911bbb315eb83, 0xbd8911bbb315eb83, 0xbd8911bbb315eb83, 0xbd8911bbb315eb83, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd63c1f28c92f3a0, 0xbd63c1f28c92f3a0, 0xbd63c1f28c92f3a0, 0xbd63c1f28c92f3a0, 0xbd63c1f28c92f3a0, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8d0d4b06a09aad, 0xbd8d0d4b06a09aad, 0xbd8d0d4b06a09aad, 0xbd8d0d4b06a09aad, 0xbd8d0d4b06a09aad, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd3e9da9f341b7c0, 0xbd3e9da9f341b7c0, 0xbd3e9da9f341b7c0, - 0xbd3e9da9f341b7c0, 0xbd3e9da9f341b7c0, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8ef725a5d4b629, - 0x3d8ef725a5d4b629, 0x3d8ef725a5d4b629, 0x3d8ef725a5d4b629, 0x3d8ef725a5d4b629, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d5835101f850b60, 0x3d5835101f850b60, 0x3d5835101f850b60, 0x3d5835101f850b60, 0x3d5835101f850b60, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8afb96524a06ff, 0x3d8afb96524a06ff, 0x3d8afb96524a06ff, 0x3d8afb96524a06ff, 0x3d8afb96524a06ff, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6c08c55ded4258, 0x3d6c08c55ded4258, 0x3d6c08c55ded4258, - 0x3d6c08c55ded4258, 0x3d6c08c55ded4258, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d870006febf57d5, - 0x3d870006febf57d5, 0x3d870006febf57d5, 0x3d870006febf57d5, 0x3d870006febf57d5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d75fb81560bff80, 0x3d75fb81560bff80, 0x3d75fb81560bff80, 0x3d75fb81560bff80, 0x3d75fb81560bff80, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d830477ab34a8ab, 0x3d830477ab34a8ab, 0x3d830477ab34a8ab, 0x3d830477ab34a8ab, 0x3d830477ab34a8ab, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7df29ffd215dd4, 0x3d7df29ffd215dd4, 0x3d7df29ffd215dd4, -] )) ), - -################ chunk 11776 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40e2acea3b7bb0ea, 0x40e2acea3b7bb0ea, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e2, 0x40e2c7d09a7be1e3, 0x40e2c7d09a7be1e2, 0x40e2e2b6f97c12db, - 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2e2b6f97c12db, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, 0x40e2fd9d587c43d3, - 0x40e2fd9d587c43d3, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e31883b77c74cb, 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, - 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, 0x40e3336a167ca5c4, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, 0x40e34e50757cd6bc, - 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e36936d47d07b4, 0x40e3841d337d38ac, 0x40e3841d337d38ac, 0x40e3841d337d38ac, - 0x40e3841d337d38ac, 0x40e3841d337d38ac, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e39f03927d69a5, 0x40e3b9e9f17d9a9d, - 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3b9e9f17d9a9d, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, 0x40e3d4d0507dcb95, - 0x40e3d4d0507dcb95, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e3efb6af7dfc8d, 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, - 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, 0x40e40a9d0e7e2d86, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, 0x40e425836d7e5e7e, - 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e44069cc7e8f76, 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, - 0x40e45b502b7ec06e, 0x40e45b502b7ec06e, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e476368a7ef167, 0x40e4911ce97f225f, - 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4911ce97f225f, 0x40e4ac03487f5357, 0x40e4ac03487f5357, 0x40e4ac03487f5357, 0x40e4ac03487f5357, - 0x40e4ac03487f5357, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4c6e9a77f8450, 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, - 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, 0x40e4e1d0067fb548, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, 0x40e4fcb6657fe640, - 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5179cc4801738, 0x40e5328323804831, 0x40e5328323804831, 0x40e5328323804831, - 0x40e5328323804831, 0x40e5328323804831, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e54d6982807929, 0x40e5684fe180aa21, - 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e5684fe180aa21, 0x40e583364080db19, 0x40e583364080db19, 0x40e583364080db19, 0x40e583364080db19, - 0x40e583364080db19, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e59e1c9f810c12, 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, - 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, 0x40e5b902fe813d0a, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, 0x40e5d3e95d816e02, - 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e5eecfbc819efa, 0x40e609b61b81cff3, 0x40e609b61b81cff3, 0x40e609b61b81cff3, - 0x40e609b61b81cff3, 0x40e609b61b81cff3, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e6249c7a8200eb, 0x40e63f82d98231e3, - 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e63f82d98231e3, 0x40e65a69388262dc, 0x40e65a69388262dc, 0x40e65a69388262dc, 0x40e65a69388262dc, - 0x40e65a69388262dc, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e6754f978293d4, 0x40e69035f682c4cc, 0x40e69035f682c4cc, - 0x40e69035f682c4cc, 0x40e69035f682c4cc, 0x40e69035f682c4cc, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, 0x40e6ab1c5582f5c4, - 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6c602b48326bd, 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, - 0x40e6e0e9138357b5, 0x40e6e0e9138357b5, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e6fbcf728388ad, 0x40e716b5d183b9a5, - 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e716b5d183b9a5, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, 0x40e7319c3083ea9e, - 0x40e7319c3083ea9e, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e74c828f841b96, 0x40e76768ee844c8e, 0x40e76768ee844c8e, - 0x40e76768ee844c8e, 0x40e76768ee844c8e, 0x40e76768ee844c8e, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, 0x40e7824f4d847d86, - 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e79d35ac84ae7f, 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, - 0x40e7b81c0b84df77, 0x40e7b81c0b84df77, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7d3026a85106f, 0x40e7ede8c9854168, - 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e7ede8c9854168, 0x40e808cf28857260, 0x40e808cf28857260, 0x40e808cf28857260, 0x40e808cf28857260, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d7df29ffd215dd4, 0x3d7df29ffd215dd4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7e11d0af53f302, - 0x3d7e11d0af53f302, 0x3d7e11d0af53f302, 0x3d7e11d0af53f302, 0x3d7e11d0af53f302, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d82f4df521b5e14, 0x3d82f4df521b5e14, 0x3d82f4df521b5e14, 0x3d82f4df521b5e14, 0x3d82f4df521b5e14, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d761ab2083e94ae, 0x3d761ab2083e94ae, 0x3d761ab2083e94ae, 0x3d761ab2083e94ae, 0x3d761ab2083e94ae, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d86f06ea5a60d3e, 0x3d86f06ea5a60d3e, 0x3d86f06ea5a60d3e, - 0x3d86f06ea5a60d3e, 0x3d86f06ea5a60d3e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6c4726c2526cb4, - 0x3d6c4726c2526cb4, 0x3d6c4726c2526cb4, 0x3d6c4726c2526cb4, 0x3d6c4726c2526cb4, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d8aebfdf930bc68, 0x3d8aebfdf930bc68, 0x3d8aebfdf930bc68, 0x3d8aebfdf930bc68, 0x3d8aebfdf930bc68, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d58b1d2e84f6019, 0x3d58b1d2e84f6019, 0x3d58b1d2e84f6019, 0x3d58b1d2e84f6019, 0x3d58b1d2e84f6019, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8ee78d4cbb6b92, 0x3d8ee78d4cbb6b92, 0x3d8ee78d4cbb6b92, - 0x3d8ee78d4cbb6b92, 0x3d8ee78d4cbb6b92, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd3caa9ed01864dd, - 0xbd3caa9ed01864dd, 0xbd3caa9ed01864dd, 0xbd3caa9ed01864dd, 0xbd3caa9ed01864dd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd8d1ce35fb9e544, 0xbd8d1ce35fb9e544, 0xbd8d1ce35fb9e544, 0xbd8d1ce35fb9e544, 0xbd8d1ce35fb9e544, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd638391282dc944, 0xbd638391282dc944, 0xbd638391282dc944, 0xbd638391282dc944, 0xbd638391282dc944, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8921540c2f361a, 0xbd8921540c2f361a, 0xbd8921540c2f361a, - 0xbd8921540c2f361a, 0xbd8921540c2f361a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd71b8e73b2c42f6, - 0xbd71b8e73b2c42f6, 0xbd71b8e73b2c42f6, 0xbd71b8e73b2c42f6, 0xbd71b8e73b2c42f6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd8525c4b8a486f0, 0xbd8525c4b8a486f0, 0xbd8525c4b8a486f0, 0xbd8525c4b8a486f0, 0xbd8525c4b8a486f0, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd79b005e241a14a, 0xbd79b005e241a14a, 0xbd79b005e241a14a, 0xbd79b005e241a14a, 0xbd79b005e241a14a, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd812a356519d7c6, 0xbd812a356519d7c6, 0xbd812a356519d7c6, - 0xbd812a356519d7c6, 0xbd812a356519d7c6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd80d39244ab7fcf, - 0xbd80d39244ab7fcf, 0xbd80d39244ab7fcf, 0xbd80d39244ab7fcf, 0xbd80d39244ab7fcf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd7a5d4c231e5138, 0xbd7a5d4c231e5138, 0xbd7a5d4c231e5138, 0xbd7a5d4c231e5138, 0xbd7a5d4c231e5138, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd84cf2198362ef9, 0xbd84cf2198362ef9, 0xbd84cf2198362ef9, 0xbd84cf2198362ef9, 0xbd84cf2198362ef9, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd72662d7c08f2e4, 0xbd72662d7c08f2e4, 0xbd72662d7c08f2e4, - 0xbd72662d7c08f2e4, 0xbd72662d7c08f2e4, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd88cab0ebc0de23, - 0xbd88cab0ebc0de23, 0xbd88cab0ebc0de23, 0xbd88cab0ebc0de23, 0xbd88cab0ebc0de23, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd64de1da9e72921, 0xbd64de1da9e72921, 0xbd64de1da9e72921, 0xbd64de1da9e72921, 0xbd64de1da9e72921, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8cc6403f4b8d4d, 0xbd8cc6403f4b8d4d, 0xbd8cc6403f4b8d4d, 0xbd8cc6403f4b8d4d, 0xbd8cc6403f4b8d4d, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd43bf816ef1b1e3, 0xbd43bf816ef1b1e3, 0xbd43bf816ef1b1e3, - 0xbd43bf816ef1b1e3, 0xbd43bf816ef1b1e3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8f3e306d29c389, - 0x3d8f3e306d29c389, 0x3d8f3e306d29c389, 0x3d8f3e306d29c389, 0x3d8f3e306d29c389, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 12288 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40e808cf28857260, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e823b58785a358, 0x40e83e9be685d450, 0x40e83e9be685d450, - 0x40e83e9be685d450, 0x40e83e9be685d450, 0x40e83e9be685d450, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, 0x40e8598245860549, - 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e87468a4863641, 0x40e88f4f03866739, 0x40e88f4f03866739, 0x40e88f4f03866739, - 0x40e88f4f03866739, 0x40e88f4f03866739, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8aa3562869831, 0x40e8c51bc186c92a, - 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8c51bc186c92a, 0x40e8e0022086fa22, 0x40e8e0022086fa22, 0x40e8e0022086fa22, 0x40e8e0022086fa22, - 0x40e8e0022086fa22, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e8fae87f872b1a, 0x40e915cede875c12, 0x40e915cede875c12, - 0x40e915cede875c12, 0x40e915cede875c12, 0x40e915cede875c12, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, 0x40e930b53d878d0b, - 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e94b9b9c87be03, 0x40e96681fb87eefb, 0x40e96681fb87eefb, 0x40e96681fb87eefb, - 0x40e96681fb87eefb, 0x40e96681fb87eefb, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e981685a881ff3, 0x40e99c4eb98850ec, - 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e99c4eb98850ec, 0x40e9b735188881e4, 0x40e9b735188881e4, 0x40e9b735188881e4, 0x40e9b735188881e4, - 0x40e9b735188881e4, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9d21b7788b2dc, 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, - 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, 0x40e9ed01d688e3d5, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, 0x40ea07e8358914cd, - 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea22ce948945c5, 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, - 0x40ea3db4f38976bd, 0x40ea3db4f38976bd, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea589b5289a7b6, 0x40ea7381b189d8ae, - 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea7381b189d8ae, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, 0x40ea8e68108a09a6, - 0x40ea8e68108a09a6, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eaa94e6f8a3a9e, 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, - 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, 0x40eac434ce8a6b97, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, 0x40eadf1b2d8a9c8f, - 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eafa018c8acd87, 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, - 0x40eb14e7eb8afe7f, 0x40eb14e7eb8afe7f, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb2fce4a8b2f78, 0x40eb4ab4a98b6070, - 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb4ab4a98b6070, 0x40eb659b088b9168, 0x40eb659b088b9168, 0x40eb659b088b9168, 0x40eb659b088b9168, - 0x40eb659b088b9168, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb8081678bc261, 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, - 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, 0x40eb9b67c68bf359, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, 0x40ebb64e258c2451, - 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebd134848c5549, 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, - 0x40ebec1ae38c8642, 0x40ebec1ae38c8642, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec0701428cb73a, 0x40ec21e7a18ce832, - 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec21e7a18ce832, 0x40ec3cce008d192a, 0x40ec3cce008d192a, 0x40ec3cce008d192a, 0x40ec3cce008d192a, - 0x40ec3cce008d192a, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec57b45f8d4a23, 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, - 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, 0x40ec729abe8d7b1b, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, 0x40ec8d811d8dac13, - 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40eca8677c8ddd0b, 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, - 0x40ecc34ddb8e0e04, 0x40ecc34ddb8e0e04, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecde343a8e3efc, 0x40ecf91a998e6ff4, - 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ecf91a998e6ff4, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, 0x40ed1400f88ea0ed, - 0x40ed1400f88ea0ed, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed2ee7578ed1e5, 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, - 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, 0x40ed49cdb68f02dd, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, 0x40ed64b4158f33d5, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3d55fcb9e4dca05f, 0x3d55fcb9e4dca05f, 0x3d55fcb9e4dca05f, 0x3d55fcb9e4dca05f, 0x3d55fcb9e4dca05f, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8b42a1199f145f, 0x3d8b42a1199f145f, 0x3d8b42a1199f145f, 0x3d8b42a1199f145f, 0x3d8b42a1199f145f, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d6aec9a40990cd7, 0x3d6aec9a40990cd7, 0x3d6aec9a40990cd7, - 0x3d6aec9a40990cd7, 0x3d6aec9a40990cd7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d874711c6146535, - 0x3d874711c6146535, 0x3d874711c6146535, 0x3d874711c6146535, 0x3d874711c6146535, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d756d6bc761e4c0, 0x3d756d6bc761e4c0, 0x3d756d6bc761e4c0, 0x3d756d6bc761e4c0, 0x3d756d6bc761e4c0, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d834b827289b60b, 0x3d834b827289b60b, 0x3d834b827289b60b, 0x3d834b827289b60b, 0x3d834b827289b60b, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7d648a6e774314, 0x3d7d648a6e774314, 0x3d7d648a6e774314, - 0x3d7d648a6e774314, 0x3d7d648a6e774314, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7e9fe63dfe0dc2, - 0x3d7e9fe63dfe0dc2, 0x3d7e9fe63dfe0dc2, 0x3d7e9fe63dfe0dc2, 0x3d7e9fe63dfe0dc2, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d82add48ac650b4, 0x3d82add48ac650b4, 0x3d82add48ac650b4, 0x3d82add48ac650b4, 0x3d82add48ac650b4, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d76a8c796e8af6e, 0x3d76a8c796e8af6e, 0x3d76a8c796e8af6e, 0x3d76a8c796e8af6e, 0x3d76a8c796e8af6e, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d86a963de50ffde, 0x3d86a963de50ffde, 0x3d86a963de50ffde, - 0x3d86a963de50ffde, 0x3d86a963de50ffde, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6d6351dfa6a235, - 0x3d6d6351dfa6a235, 0x3d6d6351dfa6a235, 0x3d6d6351dfa6a235, 0x3d6d6351dfa6a235, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d8aa4f331dbaf08, 0x3d8aa4f331dbaf08, 0x3d8aa4f331dbaf08, 0x3d8aa4f331dbaf08, 0x3d8aa4f331dbaf08, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d5aea2922f7cb1a, 0x3d5aea2922f7cb1a, 0x3d5aea2922f7cb1a, 0x3d5aea2922f7cb1a, 0x3d5aea2922f7cb1a, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8ea08285665e32, 0x3d8ea08285665e32, 0x3d8ea08285665e32, - 0x3d8ea08285665e32, 0x3d8ea08285665e32, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd33c945e576b8d8, - 0xbd33c945e576b8d8, 0xbd33c945e576b8d8, 0xbd33c945e576b8d8, 0xbd33c945e576b8d8, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd8d63ee270ef2a4, 0xbd8d63ee270ef2a4, 0xbd8d63ee270ef2a4, 0xbd8d63ee270ef2a4, 0xbd8d63ee270ef2a4, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6267660ad993c3, 0xbd6267660ad993c3, 0xbd6267660ad993c3, 0xbd6267660ad993c3, 0xbd6267660ad993c3, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd89685ed384437a, 0xbd89685ed384437a, 0xbd89685ed384437a, - 0xbd89685ed384437a, 0xbd89685ed384437a, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd712ad1ac822835, - 0xbd712ad1ac822835, 0xbd712ad1ac822835, 0xbd712ad1ac822835, 0xbd712ad1ac822835, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd856ccf7ff99450, 0xbd856ccf7ff99450, 0xbd856ccf7ff99450, 0xbd856ccf7ff99450, 0xbd856ccf7ff99450, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7921f053978689, 0xbd7921f053978689, 0xbd7921f053978689, 0xbd7921f053978689, 0xbd7921f053978689, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8171402c6ee526, 0xbd8171402c6ee526, 0xbd8171402c6ee526, - 0xbd8171402c6ee526, 0xbd8171402c6ee526, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd808c877d56726f, - 0xbd808c877d56726f, 0xbd808c877d56726f, 0xbd808c877d56726f, 0xbd808c877d56726f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd7aeb61b1c86bf9, 0xbd7aeb61b1c86bf9, 0xbd7aeb61b1c86bf9, 0xbd7aeb61b1c86bf9, 0xbd7aeb61b1c86bf9, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd848816d0e12199, 0xbd848816d0e12199, 0xbd848816d0e12199, 0xbd848816d0e12199, 0xbd848816d0e12199, -] )) ), - -################ chunk 12800 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed7f9a748f64ce, 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, - 0x40ed9a80d38f95c6, 0x40ed9a80d38f95c6, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edb567328fc6be, 0x40edd04d918ff7b6, - 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edd04d918ff7b6, 0x40edeb33f09028af, 0x40edeb33f09028af, 0x40edeb33f09028af, 0x40edeb33f09028af, - 0x40edeb33f09028af, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee061a4f9059a7, 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, - 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, 0x40ee2100ae908a9f, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, 0x40ee3be70d90bb97, - 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee56cd6c90ec90, 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, - 0x40ee71b3cb911d88, 0x40ee71b3cb911d88, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40ee8c9a2a914e80, 0x40eea78089917f79, - 0x40eea78089917f79, 0x40eea78089917f79, 0x40eea78089917f79, 0x40eea78089917f79, 0x40eec266e891b071, 0x40eec266e891b071, 0x40eec266e891b071, 0x40eec266e891b071, - 0x40eec266e891b071, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eedd4d4791e169, 0x40eef833a6921261, 0x40eef833a6921261, - 0x40eef833a6921261, 0x40eef833a6921261, 0x40eef833a6921261, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, 0x40ef131a0592435a, - 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef2e0064927452, 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, - 0x40ef48e6c392a54a, 0x40ef48e6c392a54a, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef63cd2292d642, 0x40ef7eb38193073b, - 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef7eb38193073b, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, 0x40ef9999e0933833, - 0x40ef9999e0933833, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efb4803f93692b, 0x40efcf669e939a23, 0x40efcf669e939a23, - 0x40efcf669e939a23, 0x40efcf669e939a23, 0x40efcf669e939a23, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, 0x40efea4cfd93cb1c, - 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f00299ae49fe0a, 0x40f0100cddca1686, 0x40f0100cddca1686, 0x40f0100cddca1686, - 0x40f0100cddca1686, 0x40f0100cddca1686, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f01d800d4a2f02, 0x40f02af33cca477e, - 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f02af33cca477e, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, 0x40f038666c4a5ffb, - 0x40f038666c4a5ffb, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f045d99bca7877, 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, - 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, 0x40f0534ccb4a90f3, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, 0x40f060bffacaa96f, - 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f06e332a4ac1eb, 0x40f07ba659cada67, 0x40f07ba659cada67, 0x40f07ba659cada67, - 0x40f07ba659cada67, 0x40f07ba659cada67, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f08919894af2e3, 0x40f0968cb8cb0b5f, - 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0968cb8cb0b5f, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, 0x40f0a3ffe84b23dc, - 0x40f0a3ffe84b23dc, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0b17317cb3c58, 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, - 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, 0x40f0bee6474b54d4, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, 0x40f0cc5976cb6d50, - 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0d9cca64b85cc, 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, - 0x40f0e73fd5cb9e48, 0x40f0e73fd5cb9e48, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f0f4b3054bb6c4, 0x40f1022634cbcf41, - 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f1022634cbcf41, 0x40f10f99644be7bd, 0x40f10f99644be7bd, 0x40f10f99644be7bd, 0x40f10f99644be7bd, - 0x40f10f99644be7bd, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f11d0c93cc0039, 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, - 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, 0x40f12a7fc34c18b5, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, 0x40f137f2f2cc3131, - 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f14566224c49ad, 0x40f152d951cc6229, 0x40f152d951cc6229, 0x40f152d951cc6229, - 0x40f152d951cc6229, 0x40f152d951cc6229, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f1604c814c7aa5, 0x40f16dbfb0cc9322, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd72f4430ab30da5, 0xbd72f4430ab30da5, 0xbd72f4430ab30da5, - 0xbd72f4430ab30da5, 0xbd72f4430ab30da5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8883a6246bd0c3, - 0xbd8883a6246bd0c3, 0xbd8883a6246bd0c3, 0xbd8883a6246bd0c3, 0xbd8883a6246bd0c3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd65fa48c73b5ea1, 0xbd65fa48c73b5ea1, 0xbd65fa48c73b5ea1, 0xbd65fa48c73b5ea1, 0xbd65fa48c73b5ea1, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8c7f3577f67fed, 0xbd8c7f3577f67fed, 0xbd8c7f3577f67fed, 0xbd8c7f3577f67fed, 0xbd8c7f3577f67fed, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd48302de44287e5, 0xbd48302de44287e5, 0xbd48302de44287e5, - 0xbd48302de44287e5, 0xbd48302de44287e5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8f853b347ed0e9, - 0x3d8f853b347ed0e9, 0x3d8f853b347ed0e9, 0x3d8f853b347ed0e9, 0x3d8f853b347ed0e9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d53c463aa34355d, 0x3d53c463aa34355d, 0x3d53c463aa34355d, 0x3d53c463aa34355d, 0x3d53c463aa34355d, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8b89abe0f421bf, 0x3d8b89abe0f421bf, 0x3d8b89abe0f421bf, 0x3d8b89abe0f421bf, 0x3d8b89abe0f421bf, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d69d06f2344d757, 0x3d69d06f2344d757, 0x3d69d06f2344d757, - 0x3d69d06f2344d757, 0x3d69d06f2344d757, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d878e1c8d697295, - 0x3d878e1c8d697295, 0x3d878e1c8d697295, 0x3d878e1c8d697295, 0x3d878e1c8d697295, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d74df5638b7c9ff, 0x3d74df5638b7c9ff, 0x3d74df5638b7c9ff, 0x3d74df5638b7c9ff, 0x3d74df5638b7c9ff, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d83928d39dec36b, 0x3d83928d39dec36b, 0x3d83928d39dec36b, 0x3d83928d39dec36b, 0x3d83928d39dec36b, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7cd674dfcd2853, 0x3d7cd674dfcd2853, 0x3d7cd674dfcd2853, - 0x3d7cd674dfcd2853, 0x3d7cd674dfcd2853, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9834810cd5f5df, - 0xbd9834810cd5f5df, 0xbd9834810cd5f5df, 0xbd9834810cd5f5df, 0xbd9834810cd5f5df, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd96cc9b1e475e56, 0xbd96cc9b1e475e56, 0xbd96cc9b1e475e56, 0xbd96cc9b1e475e56, 0xbd96cc9b1e475e56, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7736dd2592ca2f, 0x3d7736dd2592ca2f, 0x3d7736dd2592ca2f, 0x3d7736dd2592ca2f, 0x3d7736dd2592ca2f, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d86625916fbf27e, 0x3d86625916fbf27e, 0x3d86625916fbf27e, - 0x3d86625916fbf27e, 0x3d86625916fbf27e, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9c30106060a509, - 0xbd9c30106060a509, 0xbd9c30106060a509, 0xbd9c30106060a509, 0xbd9c30106060a509, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd92d10bcabcaf2c, 0xbd92d10bcabcaf2c, 0xbd92d10bcabcaf2c, 0xbd92d10bcabcaf2c, 0xbd92d10bcabcaf2c, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d5d227f5da0361b, 0x3d5d227f5da0361b, 0x3d5d227f5da0361b, 0x3d5d227f5da0361b, 0x3d5d227f5da0361b, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8e5977be1150d2, 0x3d8e5977be1150d2, 0x3d8e5977be1150d2, - 0x3d8e5977be1150d2, 0x3d8e5977be1150d2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9fd4604c14abcd, - 0x3d9fd4604c14abcd, 0x3d9fd4604c14abcd, 0x3d9fd4604c14abcd, 0x3d9fd4604c14abcd, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd8daaf8ee640004, 0xbd8daaf8ee640004, 0xbd8daaf8ee640004, 0xbd8daaf8ee640004, 0xbd8daaf8ee640004, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd614b3aed855e42, 0xbd614b3aed855e42, 0xbd614b3aed855e42, 0xbd614b3aed855e42, 0xbd614b3aed855e42, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d93284b32935793, 0x3d93284b32935793, 0x3d93284b32935793, - 0x3d93284b32935793, 0x3d93284b32935793, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9bd8d0f889fca3, -] )) ), - -################ chunk 13312 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f16dbfb0cc9322, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, 0x40f17b32e04cab9e, - 0x40f17b32e04cab9e, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f188a60fccc41a, 0x40f196193f4cdc96, 0x40f196193f4cdc96, - 0x40f196193f4cdc96, 0x40f196193f4cdc96, 0x40f196193f4cdc96, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, 0x40f1a38c6eccf512, - 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1b0ff9e4d0d8e, 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, - 0x40f1be72cdcd260a, 0x40f1be72cdcd260a, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1cbe5fd4d3e86, 0x40f1d9592ccd5703, - 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1d9592ccd5703, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, 0x40f1e6cc5c4d6f7f, - 0x40f1e6cc5c4d6f7f, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f1f43f8bcd87fb, 0x40f201b2bb4da077, 0x40f201b2bb4da077, - 0x40f201b2bb4da077, 0x40f201b2bb4da077, 0x40f201b2bb4da077, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, 0x40f20f25eacdb8f3, - 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f21c991a4dd16f, 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, - 0x40f22a0c49cde9eb, 0x40f22a0c49cde9eb, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f2377f794e0268, 0x40f244f2a8ce1ae4, - 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f244f2a8ce1ae4, 0x40f25265d84e3360, 0x40f25265d84e3360, 0x40f25265d84e3360, 0x40f25265d84e3360, - 0x40f25265d84e3360, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f25fd907ce4bdc, 0x40f26d4c374e6458, 0x40f26d4c374e6458, - 0x40f26d4c374e6458, 0x40f26d4c374e6458, 0x40f26d4c374e6458, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, 0x40f27abf66ce7cd4, - 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f28832964e9550, 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, - 0x40f295a5c5ceadcc, 0x40f295a5c5ceadcc, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2a318f54ec649, 0x40f2b08c24cedec5, - 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2b08c24cedec5, 0x40f2bdff544ef741, 0x40f2bdff544ef741, 0x40f2bdff544ef741, 0x40f2bdff544ef741, - 0x40f2bdff544ef741, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2cb7283cf0fbd, 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, - 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, 0x40f2d8e5b34f2839, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, 0x40f2e658e2cf40b5, - 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f2f3cc124f5931, 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, - 0x40f3013f41cf71ae, 0x40f3013f41cf71ae, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f30eb2714f8a2a, 0x40f31c25a0cfa2a6, - 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f31c25a0cfa2a6, 0x40f32998d04fbb22, 0x40f32998d04fbb22, 0x40f32998d04fbb22, 0x40f32998d04fbb22, - 0x40f32998d04fbb22, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3370bffcfd39e, 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, - 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, 0x40f3447f2f4fec1a, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, 0x40f351f25ed00496, - 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f35f658e501d12, 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, - 0x40f36cd8bdd0358f, 0x40f36cd8bdd0358f, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f37a4bed504e0b, 0x40f387bf1cd06687, - 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f387bf1cd06687, 0x40f395324c507f03, 0x40f395324c507f03, 0x40f395324c507f03, 0x40f395324c507f03, - 0x40f395324c507f03, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3a2a57bd0977f, 0x40f3b018ab50affb, 0x40f3b018ab50affb, - 0x40f3b018ab50affb, 0x40f3b018ab50affb, 0x40f3b018ab50affb, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, 0x40f3bd8bdad0c877, - 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3caff0a50e0f4, 0x40f3d87239d0f970, 0x40f3d87239d0f970, 0x40f3d87239d0f970, - 0x40f3d87239d0f970, 0x40f3d87239d0f970, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3e5e5695111ec, 0x40f3f35898d12a68, - 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f3f35898d12a68, 0x40f400cbc85142e4, 0x40f400cbc85142e4, 0x40f400cbc85142e4, 0x40f400cbc85142e4, - 0x40f400cbc85142e4, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f40e3ef7d15b60, 0x40f41bb2275173dc, 0x40f41bb2275173dc, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d9bd8d0f889fca3, 0x3d9bd8d0f889fca3, 0x3d9bd8d0f889fca3, 0x3d9bd8d0f889fca3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd85b3da474ea1b0, 0xbd85b3da474ea1b0, 0xbd85b3da474ea1b0, 0xbd85b3da474ea1b0, 0xbd85b3da474ea1b0, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7893dac4ed6bc9, 0xbd7893dac4ed6bc9, 0xbd7893dac4ed6bc9, 0xbd7893dac4ed6bc9, 0xbd7893dac4ed6bc9, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9723da861e06bd, 0x3d9723da861e06bd, 0x3d9723da861e06bd, - 0x3d9723da861e06bd, 0x3d9723da861e06bd, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d97dd41a4ff4d79, - 0x3d97dd41a4ff4d79, 0x3d97dd41a4ff4d79, 0x3d97dd41a4ff4d79, 0x3d97dd41a4ff4d79, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd7b7977407286b9, 0xbd7b7977407286b9, 0xbd7b7977407286b9, 0xbd7b7977407286b9, 0xbd7b7977407286b9, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd84410c098c1439, 0xbd84410c098c1439, 0xbd84410c098c1439, 0xbd84410c098c1439, 0xbd84410c098c1439, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9b1f69d9a8b5e7, 0x3d9b1f69d9a8b5e7, 0x3d9b1f69d9a8b5e7, - 0x3d9b1f69d9a8b5e7, 0x3d9b1f69d9a8b5e7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d93e1b251749e4f, - 0x3d93e1b251749e4f, 0x3d93e1b251749e4f, 0x3d93e1b251749e4f, 0x3d93e1b251749e4f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd671673e48f9422, 0xbd671673e48f9422, 0xbd671673e48f9422, 0xbd671673e48f9422, 0xbd671673e48f9422, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8c382ab0a1728d, 0xbd8c382ab0a1728d, 0xbd8c382ab0a1728d, 0xbd8c382ab0a1728d, 0xbd8c382ab0a1728d, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9f1af92d336511, 0x3d9f1af92d336511, 0x3d9f1af92d336511, - 0x3d9f1af92d336511, 0x3d9f1af92d336511, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8fcc45fbd3de49, - 0x3d8fcc45fbd3de49, 0x3d8fcc45fbd3de49, 0x3d8fcc45fbd3de49, 0x3d8fcc45fbd3de49, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d518c0d6f8bca5c, 0x3d518c0d6f8bca5c, 0x3d518c0d6f8bca5c, 0x3d518c0d6f8bca5c, 0x3d518c0d6f8bca5c, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9217a4abdb6870, 0xbd9217a4abdb6870, 0xbd9217a4abdb6870, 0xbd9217a4abdb6870, 0xbd9217a4abdb6870, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9ce9777f41ebc5, 0xbd9ce9777f41ebc5, 0xbd9ce9777f41ebc5, - 0xbd9ce9777f41ebc5, 0xbd9ce9777f41ebc5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d87d52754be7ff6, - 0x3d87d52754be7ff6, 0x3d87d52754be7ff6, 0x3d87d52754be7ff6, 0x3d87d52754be7ff6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d745140aa0daf3f, 0x3d745140aa0daf3f, 0x3d745140aa0daf3f, 0x3d745140aa0daf3f, 0x3d745140aa0daf3f, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd961333ff66179a, 0xbd961333ff66179a, 0xbd961333ff66179a, 0xbd961333ff66179a, 0xbd961333ff66179a, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd98ede82bb73c9b, 0xbd98ede82bb73c9b, 0xbd98ede82bb73c9b, - 0xbd98ede82bb73c9b, 0xbd98ede82bb73c9b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7fbc115b524343, - 0x3d7fbc115b524343, 0x3d7fbc115b524343, 0x3d7fbc115b524343, 0x3d7fbc115b524343, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d821fbefc1c35f3, 0x3d821fbefc1c35f3, 0x3d821fbefc1c35f3, 0x3d821fbefc1c35f3, 0x3d821fbefc1c35f3, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9a0ec352f0c6c4, 0xbd9a0ec352f0c6c4, 0xbd9a0ec352f0c6c4, 0xbd9a0ec352f0c6c4, 0xbd9a0ec352f0c6c4, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd94f258d82c8d71, 0xbd94f258d82c8d71, 0xbd94f258d82c8d71, - 0xbd94f258d82c8d71, 0xbd94f258d82c8d71, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6f9ba81a4f0d36, - 0x3d6f9ba81a4f0d36, 0x3d6f9ba81a4f0d36, 0x3d6f9ba81a4f0d36, 0x3d6f9ba81a4f0d36, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d8a16dda3319447, 0x3d8a16dda3319447, 0x3d8a16dda3319447, 0x3d8a16dda3319447, 0x3d8a16dda3319447, 0xbff0000000000000, 0xbff0000000000000, -] )) ), - -################ chunk 13824 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f41bb2275173dc, 0x40f41bb2275173dc, 0x40f41bb2275173dc, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, 0x40f4292556d18c58, - 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f436988651a4d5, 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, - 0x40f4440bb5d1bd51, 0x40f4440bb5d1bd51, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f4517ee551d5cd, 0x40f45ef214d1ee49, - 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f45ef214d1ee49, 0x40f46c65445206c5, 0x40f46c65445206c5, 0x40f46c65445206c5, 0x40f46c65445206c5, - 0x40f46c65445206c5, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f479d873d21f41, 0x40f4874ba35237bd, 0x40f4874ba35237bd, - 0x40f4874ba35237bd, 0x40f4874ba35237bd, 0x40f4874ba35237bd, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, 0x40f494bed2d2503a, - 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4a232025268b6, 0x40f4afa531d28132, 0x40f4afa531d28132, 0x40f4afa531d28132, - 0x40f4afa531d28132, 0x40f4afa531d28132, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4bd18615299ae, 0x40f4ca8b90d2b22a, - 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4ca8b90d2b22a, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, 0x40f4d7fec052caa6, - 0x40f4d7fec052caa6, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4e571efd2e322, 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, - 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, 0x40f4f2e51f52fb9e, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, 0x40f500584ed3141b, - 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f50dcb7e532c97, 0x40f51b3eadd34513, 0x40f51b3eadd34513, 0x40f51b3eadd34513, - 0x40f51b3eadd34513, 0x40f51b3eadd34513, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f528b1dd535d8f, 0x40f536250cd3760b, - 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f536250cd3760b, 0x40f543983c538e87, 0x40f543983c538e87, 0x40f543983c538e87, 0x40f543983c538e87, - 0x40f543983c538e87, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f5510b6bd3a703, 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, - 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, 0x40f55e7e9b53bf80, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, 0x40f56bf1cad3d7fc, - 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f57964fa53f078, 0x40f586d829d408f4, 0x40f586d829d408f4, 0x40f586d829d408f4, - 0x40f586d829d408f4, 0x40f586d829d408f4, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5944b59542170, 0x40f5a1be88d439ec, - 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5a1be88d439ec, 0x40f5af31b8545268, 0x40f5af31b8545268, 0x40f5af31b8545268, 0x40f5af31b8545268, - 0x40f5af31b8545268, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5bca4e7d46ae4, 0x40f5ca1817548361, 0x40f5ca1817548361, - 0x40f5ca1817548361, 0x40f5ca1817548361, 0x40f5ca1817548361, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, 0x40f5d78b46d49bdd, - 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5e4fe7654b459, 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, - 0x40f5f271a5d4ccd5, 0x40f5f271a5d4ccd5, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f5ffe4d554e551, 0x40f60d5804d4fdcd, - 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f60d5804d4fdcd, 0x40f61acb34551649, 0x40f61acb34551649, 0x40f61acb34551649, 0x40f61acb34551649, - 0x40f61acb34551649, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f6283e63d52ec6, 0x40f635b193554742, 0x40f635b193554742, - 0x40f635b193554742, 0x40f635b193554742, 0x40f635b193554742, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, 0x40f64324c2d55fbe, - 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65097f255783a, 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, - 0x40f65e0b21d590b6, 0x40f65e0b21d590b6, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f66b7e5155a932, 0x40f678f180d5c1ae, - 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f678f180d5c1ae, 0x40f68664b055da2a, 0x40f68664b055da2a, 0x40f68664b055da2a, 0x40f68664b055da2a, - 0x40f68664b055da2a, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f693d7dfd5f2a7, 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, - 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, 0x40f6a14b0f560b23, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, 0x40f6aebe3ed6239f, - 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6bc316e563c1b, 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9e0a52a67b75ee, 0xbd9e0a52a67b75ee, 0xbd9e0a52a67b75ee, 0xbd9e0a52a67b75ee, 0xbd9e0a52a67b75ee, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd90f6c984a1de47, 0xbd90f6c984a1de47, 0xbd90f6c984a1de47, - 0xbd90f6c984a1de47, 0xbd90f6c984a1de47, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd0034a0819b066f, - 0xbd0034a0819b066f, 0xbd0034a0819b066f, 0xbd0034a0819b066f, 0xbd0034a0819b066f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d9106fe2523794e, 0x3d9106fe2523794e, 0x3d9106fe2523794e, 0x3d9106fe2523794e, 0x3d9106fe2523794e, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9dfa1e05f9dae8, 0x3d9dfa1e05f9dae8, 0x3d9dfa1e05f9dae8, 0x3d9dfa1e05f9dae8, 0x3d9dfa1e05f9dae8, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd89f674622e5e3b, 0xbd89f674622e5e3b, 0xbd89f674622e5e3b, - 0xbd89f674622e5e3b, 0xbd89f674622e5e3b, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd700ea68f2df2b5, - 0xbd700ea68f2df2b5, 0xbd700ea68f2df2b5, 0xbd700ea68f2df2b5, 0xbd700ea68f2df2b5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d95028d78ae2878, 0x3d95028d78ae2878, 0x3d95028d78ae2878, 0x3d95028d78ae2878, 0x3d95028d78ae2878, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d99fe8eb26f2bbe, 0x3d99fe8eb26f2bbe, 0x3d99fe8eb26f2bbe, 0x3d99fe8eb26f2bbe, 0x3d99fe8eb26f2bbe, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd81ff55bb18ffe7, 0xbd81ff55bb18ffe7, 0xbd81ff55bb18ffe7, - 0xbd81ff55bb18ffe7, 0xbd81ff55bb18ffe7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7ffce3dd58af5d, - 0xbd7ffce3dd58af5d, 0xbd7ffce3dd58af5d, 0xbd7ffce3dd58af5d, 0xbd7ffce3dd58af5d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d98fe1ccc38d7a2, 0x3d98fe1ccc38d7a2, 0x3d98fe1ccc38d7a2, 0x3d98fe1ccc38d7a2, 0x3d98fe1ccc38d7a2, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9602ff5ee47c94, 0x3d9602ff5ee47c94, 0x3d9602ff5ee47c94, 0x3d9602ff5ee47c94, 0x3d9602ff5ee47c94, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd74106e28074325, 0xbd74106e28074325, 0xbd74106e28074325, - 0xbd74106e28074325, 0xbd74106e28074325, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd87f59095c1b602, - 0xbd87f59095c1b602, 0xbd87f59095c1b602, 0xbd87f59095c1b602, 0xbd87f59095c1b602, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d9cf9ac1fc386cc, 0x3d9cf9ac1fc386cc, 0x3d9cf9ac1fc386cc, 0x3d9cf9ac1fc386cc, 0x3d9cf9ac1fc386cc, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9207700b59cd6a, 0x3d9207700b59cd6a, 0x3d9207700b59cd6a, 0x3d9207700b59cd6a, 0x3d9207700b59cd6a, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd5088c3677219f5, 0xbd5088c3677219f5, 0xbd5088c3677219f5, - 0xbd5088c3677219f5, 0xbd5088c3677219f5, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8fecaf3cd71456, - 0xbd8fecaf3cd71456, 0xbd8fecaf3cd71456, 0xbd8fecaf3cd71456, 0xbd8fecaf3cd71456, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd9f0ac48cb1ca0a, 0xbd9f0ac48cb1ca0a, 0xbd9f0ac48cb1ca0a, 0xbd9f0ac48cb1ca0a, 0xbd9f0ac48cb1ca0a, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8c17c16f9e3c80, 0x3d8c17c16f9e3c80, 0x3d8c17c16f9e3c80, 0x3d8c17c16f9e3c80, 0x3d8c17c16f9e3c80, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d679818e89c6c55, 0x3d679818e89c6c55, 0x3d679818e89c6c55, - 0x3d679818e89c6c55, 0x3d679818e89c6c55, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd93f1e6f1f63955, - 0xbd93f1e6f1f63955, 0xbd93f1e6f1f63955, 0xbd93f1e6f1f63955, 0xbd93f1e6f1f63955, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd9b0f3539271ae0, 0xbd9b0f3539271ae0, 0xbd9b0f3539271ae0, 0xbd9b0f3539271ae0, 0xbd9b0f3539271ae0, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8420a2c888de2c, 0x3d8420a2c888de2c, 0x3d8420a2c888de2c, 0x3d8420a2c888de2c, 0x3d8420a2c888de2c, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7bba49c278f2d3, 0x3d7bba49c278f2d3, 0x3d7bba49c278f2d3, -] )) ), - -################ chunk 14336 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f6c9a49dd65497, 0x40f6c9a49dd65497, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6d717cd566d13, 0x40f6e48afcd6858f, - 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6e48afcd6858f, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, 0x40f6f1fe2c569e0c, - 0x40f6f1fe2c569e0c, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f6ff715bd6b688, 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, - 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, 0x40f70ce48b56cf04, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, 0x40f71a57bad6e780, - 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f727caea56fffc, 0x40f7353e19d71878, 0x40f7353e19d71878, 0x40f7353e19d71878, - 0x40f7353e19d71878, 0x40f7353e19d71878, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f742b1495730f4, 0x40f7502478d74970, - 0x40f7502478d74970, 0x40f7502478d74970, 0x40f7502478d74970, 0x40f7502478d74970, 0x40f75d97a85761ed, 0x40f75d97a85761ed, 0x40f75d97a85761ed, 0x40f75d97a85761ed, - 0x40f75d97a85761ed, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f76b0ad7d77a69, 0x40f7787e075792e5, 0x40f7787e075792e5, - 0x40f7787e075792e5, 0x40f7787e075792e5, 0x40f7787e075792e5, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, 0x40f785f136d7ab61, - 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f793646657c3dd, 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, - 0x40f7a0d795d7dc59, 0x40f7a0d795d7dc59, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7ae4ac557f4d5, 0x40f7bbbdf4d80d51, - 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7bbbdf4d80d51, 0x40f7c931245825ce, 0x40f7c931245825ce, 0x40f7c931245825ce, 0x40f7c931245825ce, - 0x40f7c931245825ce, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7d6a453d83e4a, 0x40f7e417835856c6, 0x40f7e417835856c6, - 0x40f7e417835856c6, 0x40f7e417835856c6, 0x40f7e417835856c6, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, 0x40f7f18ab2d86f42, - 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f7fefde25887be, 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, - 0x40f80c7111d8a03a, 0x40f80c7111d8a03a, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f819e44158b8b6, 0x40f8275770d8d133, - 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f8275770d8d133, 0x40f834caa058e9af, 0x40f834caa058e9af, 0x40f834caa058e9af, 0x40f834caa058e9af, - 0x40f834caa058e9af, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f8423dcfd9022b, 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, - 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, 0x40f84fb0ff591aa7, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, 0x40f85d242ed93323, - 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f86a975e594b9f, 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, - 0x40f8780a8dd9641b, 0x40f8780a8dd9641b, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f8857dbd597c97, 0x40f892f0ecd99514, - 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f892f0ecd99514, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, 0x40f8a0641c59ad90, - 0x40f8a0641c59ad90, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8add74bd9c60c, 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, - 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, 0x40f8bb4a7b59de88, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, 0x40f8c8bdaad9f704, - 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8d630da5a0f80, 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, - 0x40f8e3a409da27fc, 0x40f8e3a409da27fc, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8f117395a4079, 0x40f8fe8a68da58f5, - 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f8fe8a68da58f5, 0x40f90bfd985a7171, 0x40f90bfd985a7171, 0x40f90bfd985a7171, 0x40f90bfd985a7171, - 0x40f90bfd985a7171, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f91970c7da89ed, 0x40f926e3f75aa269, 0x40f926e3f75aa269, - 0x40f926e3f75aa269, 0x40f926e3f75aa269, 0x40f926e3f75aa269, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, 0x40f9345726dabae5, - 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f941ca565ad361, 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, - 0x40f94f3d85daebdd, 0x40f94f3d85daebdd, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f95cb0b55b045a, 0x40f96a23e4db1cd6, - 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f96a23e4db1cd6, 0x40f97797145b3552, 0x40f97797145b3552, 0x40f97797145b3552, 0x40f97797145b3552, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d7bba49c278f2d3, 0x3d7bba49c278f2d3, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd97ed764580e87f, - 0xbd97ed764580e87f, 0xbd97ed764580e87f, 0xbd97ed764580e87f, 0xbd97ed764580e87f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd9713a5e59c6bb6, 0xbd9713a5e59c6bb6, 0xbd9713a5e59c6bb6, 0xbd9713a5e59c6bb6, 0xbd9713a5e59c6bb6, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d78530842e6ffaf, 0x3d78530842e6ffaf, 0x3d78530842e6ffaf, 0x3d78530842e6ffaf, 0x3d78530842e6ffaf, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d85d4438851d7bd, 0x3d85d4438851d7bd, 0x3d85d4438851d7bd, - 0x3d85d4438851d7bd, 0x3d85d4438851d7bd, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9be905990b97a9, - 0xbd9be905990b97a9, 0xbd9be905990b97a9, 0xbd9be905990b97a9, 0xbd9be905990b97a9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd9318169211bc8c, 0xbd9318169211bc8c, 0xbd9318169211bc8c, 0xbd9318169211bc8c, 0xbd9318169211bc8c, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d60c995e978860f, 0x3d60c995e978860f, 0x3d60c995e978860f, 0x3d60c995e978860f, 0x3d60c995e978860f, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8dcb622f673611, 0x3d8dcb622f673611, 0x3d8dcb622f673611, - 0x3d8dcb622f673611, 0x3d8dcb622f673611, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9fe494ec9646d3, - 0xbd9fe494ec9646d3, 0xbd9fe494ec9646d3, 0xbd9fe494ec9646d3, 0xbd9fe494ec9646d3, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd8e390e7d0e1ac5, 0xbd8e390e7d0e1ac5, 0xbd8e390e7d0e1ac5, 0xbd8e390e7d0e1ac5, 0xbd8e390e7d0e1ac5, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd5e25c965b9e682, 0xbd5e25c965b9e682, 0xbd5e25c965b9e682, 0xbd5e25c965b9e682, 0xbd5e25c965b9e682, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d92e1406b3e4a33, 0x3d92e1406b3e4a33, 0x3d92e1406b3e4a33, - 0x3d92e1406b3e4a33, 0x3d92e1406b3e4a33, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9c1fdbbfdf0a03, - 0x3d9c1fdbbfdf0a03, 0x3d9c1fdbbfdf0a03, 0x3d9c1fdbbfdf0a03, 0x3d9c1fdbbfdf0a03, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd8641efd5f8bc71, 0xbd8641efd5f8bc71, 0xbd8641efd5f8bc71, 0xbd8641efd5f8bc71, 0xbd8641efd5f8bc71, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7777afa7993648, 0xbd7777afa7993648, 0xbd7777afa7993648, 0xbd7777afa7993648, 0xbd7777afa7993648, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d96dccfbec8f95d, 0x3d96dccfbec8f95d, 0x3d96dccfbec8f95d, - 0x3d96dccfbec8f95d, 0x3d96dccfbec8f95d, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d98244c6c545ad9, - 0x3d98244c6c545ad9, 0x3d98244c6c545ad9, 0x3d98244c6c545ad9, 0x3d98244c6c545ad9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd7c95a25dc6bc3a, 0xbd7c95a25dc6bc3a, 0xbd7c95a25dc6bc3a, 0xbd7c95a25dc6bc3a, 0xbd7c95a25dc6bc3a, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd83b2f67ae1f978, 0xbd83b2f67ae1f978, 0xbd83b2f67ae1f978, 0xbd83b2f67ae1f978, 0xbd83b2f67ae1f978, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9ad85f1253a887, 0x3d9ad85f1253a887, 0x3d9ad85f1253a887, - 0x3d9ad85f1253a887, 0x3d9ad85f1253a887, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9428bd18c9abaf, - 0x3d9428bd18c9abaf, 0x3d9428bd18c9abaf, 0x3d9428bd18c9abaf, 0x3d9428bd18c9abaf, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd694eca1f37ff23, 0xbd694eca1f37ff23, 0xbd694eca1f37ff23, 0xbd694eca1f37ff23, 0xbd694eca1f37ff23, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8baa1521f757cc, 0xbd8baa1521f757cc, 0xbd8baa1521f757cc, 0xbd8baa1521f757cc, 0xbd8baa1521f757cc, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9ed3ee65de57b1, 0x3d9ed3ee65de57b1, 0x3d9ed3ee65de57b1, - 0x3d9ed3ee65de57b1, 0x3d9ed3ee65de57b1, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d902d2dc53efc85, - 0x3d902d2dc53efc85, 0x3d902d2dc53efc85, 0x3d902d2dc53efc85, 0x3d902d2dc53efc85, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 14848 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40f97797145b3552, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9850a43db4dce, 0x40f9927d735b664a, 0x40f9927d735b664a, - 0x40f9927d735b664a, 0x40f9927d735b664a, 0x40f9927d735b664a, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, 0x40f99ff0a2db7ec6, - 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9ad63d25b9742, 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, - 0x40f9bad701dbafbf, 0x40f9bad701dbafbf, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9c84a315bc83b, 0x40f9d5bd60dbe0b7, - 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9d5bd60dbe0b7, 0x40f9e330905bf933, 0x40f9e330905bf933, 0x40f9e330905bf933, 0x40f9e330905bf933, - 0x40f9e330905bf933, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9f0a3bfdc11af, 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, - 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, 0x40f9fe16ef5c2a2b, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, 0x40fa0b8a1edc42a7, - 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa18fd4e5c5b23, 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, - 0x40fa26707ddc73a0, 0x40fa26707ddc73a0, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa33e3ad5c8c1c, 0x40fa4156dcdca498, - 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4156dcdca498, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, 0x40fa4eca0c5cbd14, - 0x40fa4eca0c5cbd14, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa5c3d3bdcd590, 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, - 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, 0x40fa69b06b5cee0c, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, 0x40fa77239add0688, - 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa8496ca5d1f05, 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, - 0x40fa9209f9dd3781, 0x40fa9209f9dd3781, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40fa9f7d295d4ffd, 0x40faacf058dd6879, - 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faacf058dd6879, 0x40faba63885d80f5, 0x40faba63885d80f5, 0x40faba63885d80f5, 0x40faba63885d80f5, - 0x40faba63885d80f5, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fac7d6b7dd9971, 0x40fad549e75db1ed, 0x40fad549e75db1ed, - 0x40fad549e75db1ed, 0x40fad549e75db1ed, 0x40fad549e75db1ed, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, 0x40fae2bd16ddca69, - 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40faf030465de2e6, 0x40fafda375ddfb62, 0x40fafda375ddfb62, 0x40fafda375ddfb62, - 0x40fafda375ddfb62, 0x40fafda375ddfb62, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb0b16a55e13de, 0x40fb1889d4de2c5a, - 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb1889d4de2c5a, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, 0x40fb25fd045e44d6, - 0x40fb25fd045e44d6, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb337033de5d52, 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, - 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, 0x40fb40e3635e75ce, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, 0x40fb4e5692de8e4b, - 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb5bc9c25ea6c7, 0x40fb693cf1debf43, 0x40fb693cf1debf43, 0x40fb693cf1debf43, - 0x40fb693cf1debf43, 0x40fb693cf1debf43, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb76b0215ed7bf, 0x40fb842350def03b, - 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb842350def03b, 0x40fb9196805f08b7, 0x40fb9196805f08b7, 0x40fb9196805f08b7, 0x40fb9196805f08b7, - 0x40fb9196805f08b7, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fb9f09afdf2133, 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, - 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, 0x40fbac7cdf5f39af, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, 0x40fbb9f00edf522c, - 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbc7633e5f6aa8, 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, - 0x40fbd4d66ddf8324, 0x40fbd4d66ddf8324, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbe2499d5f9ba0, 0x40fbefbcccdfb41c, - 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbefbcccdfb41c, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, 0x40fbfd2ffc5fcc98, - 0x40fbfd2ffc5fcc98, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc0aa32bdfe514, 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, - 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, 0x40fc18165b5ffd91, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, 0x40fc25898ae0160d, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3d4a36c1f475e8b3, 0x3d4a36c1f475e8b3, 0x3d4a36c1f475e8b3, 0x3d4a36c1f475e8b3, 0x3d4a36c1f475e8b3, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd91d099e4865b10, 0xbd91d099e4865b10, 0xbd91d099e4865b10, 0xbd91d099e4865b10, 0xbd91d099e4865b10, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9d30824696f925, 0xbd9d30824696f925, 0xbd9d30824696f925, - 0xbd9d30824696f925, 0xbd9d30824696f925, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d88633ce3689ab6, - 0x3d88633ce3689ab6, 0x3d88633ce3689ab6, 0x3d88633ce3689ab6, 0x3d88633ce3689ab6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d7335158cb979be, 0x3d7335158cb979be, 0x3d7335158cb979be, 0x3d7335158cb979be, 0x3d7335158cb979be, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd95cc2938110a3a, 0xbd95cc2938110a3a, 0xbd95cc2938110a3a, 0xbd95cc2938110a3a, 0xbd95cc2938110a3a, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9934f2f30c49fb, 0xbd9934f2f30c49fb, 0xbd9934f2f30c49fb, - 0xbd9934f2f30c49fb, 0xbd9934f2f30c49fb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d806c1e3c533c62, - 0x3d806c1e3c533c62, 0x3d806c1e3c533c62, 0x3d806c1e3c533c62, 0x3d806c1e3c533c62, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d8191a96d721b33, 0x3d8191a96d721b33, 0x3d8191a96d721b33, 0x3d8191a96d721b33, 0x3d8191a96d721b33, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd99c7b88b9bb964, 0xbd99c7b88b9bb964, 0xbd99c7b88b9bb964, 0xbd99c7b88b9bb964, 0xbd99c7b88b9bb964, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9539639f819ad1, 0xbd9539639f819ad1, 0xbd9539639f819ad1, - 0xbd9539639f819ad1, 0xbd9539639f819ad1, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d70e9ff2a7bbc1c, - 0x3d70e9ff2a7bbc1c, 0x3d70e9ff2a7bbc1c, 0x3d70e9ff2a7bbc1c, 0x3d70e9ff2a7bbc1c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d8988c814877987, 0x3d8988c814877987, 0x3d8988c814877987, 0x3d8988c814877987, 0x3d8988c814877987, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9dc347df26688e, 0xbd9dc347df26688e, 0xbd9dc347df26688e, 0xbd9dc347df26688e, 0xbd9dc347df26688e, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd913dd44bf6eba7, 0xbd913dd44bf6eba7, 0xbd913dd44bf6eba7, - 0xbd913dd44bf6eba7, 0xbd913dd44bf6eba7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d2f783b8a1fee79, - 0x3d2f783b8a1fee79, 0x3d2f783b8a1fee79, 0x3d2f783b8a1fee79, 0x3d2f783b8a1fee79, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d90bff35dce6bee, 0x3d90bff35dce6bee, 0x3d90bff35dce6bee, 0x3d90bff35dce6bee, 0x3d90bff35dce6bee, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9e4128cd4ee848, 0x3d9e4128cd4ee848, 0x3d9e4128cd4ee848, 0x3d9e4128cd4ee848, 0x3d9e4128cd4ee848, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8a8489f0d878fb, 0xbd8a8489f0d878fb, 0xbd8a8489f0d878fb, - 0xbd8a8489f0d878fb, 0xbd8a8489f0d878fb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6de4f6e3b37a68, - 0xbd6de4f6e3b37a68, 0xbd6de4f6e3b37a68, 0xbd6de4f6e3b37a68, 0xbd6de4f6e3b37a68, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d94bb82b1591b18, 0x3d94bb82b1591b18, 0x3d94bb82b1591b18, 0x3d94bb82b1591b18, 0x3d94bb82b1591b18, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9a459979c4391e, 0x3d9a459979c4391e, 0x3d9a459979c4391e, 0x3d9a459979c4391e, 0x3d9a459979c4391e, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd828d6b49c31aa7, 0xbd828d6b49c31aa7, 0xbd828d6b49c31aa7, - 0xbd828d6b49c31aa7, 0xbd828d6b49c31aa7, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd7ee0b8c00479dc, - 0xbd7ee0b8c00479dc, 0xbd7ee0b8c00479dc, 0xbd7ee0b8c00479dc, 0xbd7ee0b8c00479dc, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d98b71204e3ca42, 0x3d98b71204e3ca42, 0x3d98b71204e3ca42, 0x3d98b71204e3ca42, 0x3d98b71204e3ca42, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d964a0a263989f4, 0x3d964a0a263989f4, 0x3d964a0a263989f4, 0x3d964a0a263989f4, 0x3d964a0a263989f4, -] )) ), - -################ chunk 15360 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc32fcba602e89, 0x40fc406fe9e04705, 0x40fc406fe9e04705, 0x40fc406fe9e04705, - 0x40fc406fe9e04705, 0x40fc406fe9e04705, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc4de319605f81, 0x40fc5b5648e077fd, - 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc5b5648e077fd, 0x40fc68c978609079, 0x40fc68c978609079, 0x40fc68c978609079, 0x40fc68c978609079, - 0x40fc68c978609079, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc763ca7e0a8f5, 0x40fc83afd760c172, 0x40fc83afd760c172, - 0x40fc83afd760c172, 0x40fc83afd760c172, 0x40fc83afd760c172, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, 0x40fc912306e0d9ee, - 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fc9e963660f26a, 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, - 0x40fcac0965e10ae6, 0x40fcac0965e10ae6, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcb97c95612362, 0x40fcc6efc4e13bde, - 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcc6efc4e13bde, 0x40fcd462f461545a, 0x40fcd462f461545a, 0x40fcd462f461545a, 0x40fcd462f461545a, - 0x40fcd462f461545a, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fce1d623e16cd7, 0x40fcef4953618553, 0x40fcef4953618553, - 0x40fcef4953618553, 0x40fcef4953618553, 0x40fcef4953618553, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, 0x40fcfcbc82e19dcf, - 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd0a2fb261b64b, 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, - 0x40fd17a2e1e1cec7, 0x40fd17a2e1e1cec7, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd25161161e743, 0x40fd328940e1ffbf, - 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd328940e1ffbf, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, 0x40fd3ffc7062183b, - 0x40fd3ffc7062183b, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd4d6f9fe230b8, 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, - 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, 0x40fd5ae2cf624934, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, 0x40fd6855fee261b0, - 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd75c92e627a2c, 0x40fd833c5de292a8, 0x40fd833c5de292a8, 0x40fd833c5de292a8, - 0x40fd833c5de292a8, 0x40fd833c5de292a8, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd90af8d62ab24, 0x40fd9e22bce2c3a0, - 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fd9e22bce2c3a0, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, 0x40fdab95ec62dc1d, - 0x40fdab95ec62dc1d, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdb9091be2f499, 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, - 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, 0x40fdc67c4b630d15, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, 0x40fdd3ef7ae32591, - 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fde162aa633e0d, 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, - 0x40fdeed5d9e35689, 0x40fdeed5d9e35689, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fdfc4909636f05, 0x40fe09bc38e38781, - 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe09bc38e38781, 0x40fe172f68639ffe, 0x40fe172f68639ffe, 0x40fe172f68639ffe, 0x40fe172f68639ffe, - 0x40fe172f68639ffe, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe24a297e3b87a, 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, - 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, 0x40fe3215c763d0f6, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, 0x40fe3f88f6e3e972, - 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe4cfc266401ee, 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, - 0x40fe5a6f55e41a6a, 0x40fe5a6f55e41a6a, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe67e2856432e6, 0x40fe7555b4e44b62, - 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe7555b4e44b62, 0x40fe82c8e46463df, 0x40fe82c8e46463df, 0x40fe82c8e46463df, 0x40fe82c8e46463df, - 0x40fe82c8e46463df, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe903c13e47c5b, 0x40fe9daf436494d7, 0x40fe9daf436494d7, - 0x40fe9daf436494d7, 0x40fe9daf436494d7, 0x40fe9daf436494d7, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, 0x40feab2272e4ad53, - 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40feb895a264c5cf, 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, - 0x40fec608d1e4de4b, 0x40fec608d1e4de4b, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fed37c0164f6c7, 0x40fee0ef30e50f44, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd752c99455b78a6, 0xbd752c99455b78a6, 0xbd752c99455b78a6, - 0xbd752c99455b78a6, 0xbd752c99455b78a6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd87677b07179b42, - 0xbd87677b07179b42, 0xbd87677b07179b42, 0xbd87677b07179b42, 0xbd87677b07179b42, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d9cb2a1586e796c, 0x3d9cb2a1586e796c, 0x3d9cb2a1586e796c, 0x3d9cb2a1586e796c, 0x3d9cb2a1586e796c, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d924e7ad2aedaca, 0x3d924e7ad2aedaca, 0x3d924e7ad2aedaca, 0x3d924e7ad2aedaca, 0x3d924e7ad2aedaca, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd54f96fdcc2eff8, 0xbd54f96fdcc2eff8, 0xbd54f96fdcc2eff8, - 0xbd54f96fdcc2eff8, 0xbd54f96fdcc2eff8, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8f5e99ae2cf996, - 0xbd8f5e99ae2cf996, 0xbd8f5e99ae2cf996, 0xbd8f5e99ae2cf996, 0xbd8f5e99ae2cf996, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd9f51cf5406d76a, 0xbd9f51cf5406d76a, 0xbd9f51cf5406d76a, 0xbd9f51cf5406d76a, 0xbd9f51cf5406d76a, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8ca5d6fe485740, 0x3d8ca5d6fe485740, 0x3d8ca5d6fe485740, 0x3d8ca5d6fe485740, 0x3d8ca5d6fe485740, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d655fc2adf40154, 0x3d655fc2adf40154, 0x3d655fc2adf40154, - 0x3d655fc2adf40154, 0x3d655fc2adf40154, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd93aadc2aa12bf5, - 0xbd93aadc2aa12bf5, 0xbd93aadc2aa12bf5, 0xbd93aadc2aa12bf5, 0xbd93aadc2aa12bf5, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd9b5640007c2840, 0xbd9b5640007c2840, 0xbd9b5640007c2840, 0xbd9b5640007c2840, 0xbd9b5640007c2840, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d84aeb85732f8ec, 0x3d84aeb85732f8ec, 0x3d84aeb85732f8ec, 0x3d84aeb85732f8ec, 0x3d84aeb85732f8ec, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d7a9e1ea524bd52, 0x3d7a9e1ea524bd52, 0x3d7a9e1ea524bd52, - 0x3d7a9e1ea524bd52, 0x3d7a9e1ea524bd52, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd97a66b7e2bdb1f, - 0xbd97a66b7e2bdb1f, 0xbd97a66b7e2bdb1f, 0xbd97a66b7e2bdb1f, 0xbd97a66b7e2bdb1f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd975ab0acf17917, 0xbd975ab0acf17917, 0xbd975ab0acf17917, 0xbd975ab0acf17917, 0xbd975ab0acf17917, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d796f33603b3530, 0x3d796f33603b3530, 0x3d796f33603b3530, 0x3d796f33603b3530, 0x3d796f33603b3530, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d85462df9a7bcfd, 0x3d85462df9a7bcfd, 0x3d85462df9a7bcfd, - 0x3d85462df9a7bcfd, 0x3d85462df9a7bcfd, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9ba1fad1b68a49, - 0xbd9ba1fad1b68a49, 0xbd9ba1fad1b68a49, 0xbd9ba1fad1b68a49, 0xbd9ba1fad1b68a49, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd935f215966c9ed, 0xbd935f215966c9ed, 0xbd935f215966c9ed, 0xbd935f215966c9ed, 0xbd935f215966c9ed, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d6301ec2420f110, 0x3d6301ec2420f110, 0x3d6301ec2420f110, 0x3d6301ec2420f110, 0x3d6301ec2420f110, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d8d3d4ca0bd1b51, 0x3d8d3d4ca0bd1b51, 0x3d8d3d4ca0bd1b51, - 0x3d8d3d4ca0bd1b51, 0x3d8d3d4ca0bd1b51, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9f9d8a25413973, - 0xbd9f9d8a25413973, 0xbd9f9d8a25413973, 0xbd9f9d8a25413973, 0xbd9f9d8a25413973, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd8ec7240bb83585, 0xbd8ec7240bb83585, 0xbd8ec7240bb83585, 0xbd8ec7240bb83585, 0xbd8ec7240bb83585, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd59b51cf0691080, 0xbd59b51cf0691080, 0xbd59b51cf0691080, 0xbd59b51cf0691080, 0xbd59b51cf0691080, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d929a35a3e93cd2, 0x3d929a35a3e93cd2, 0x3d929a35a3e93cd2, - 0x3d929a35a3e93cd2, 0x3d929a35a3e93cd2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9c66e687341763, -] )) ), - -################ chunk 15872 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40fee0ef30e50f44, 0x40feee62606527c0, 0x40feee62606527c0, 0x40feee62606527c0, 0x40feee62606527c0, - 0x40feee62606527c0, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40fefbd58fe5403c, 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, - 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, 0x40ff0948bf6558b8, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, 0x40ff16bbeee57134, - 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff242f1e6589b0, 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, - 0x40ff31a24de5a22c, 0x40ff31a24de5a22c, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff3f157d65baa8, 0x40ff4c88ace5d325, - 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff4c88ace5d325, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, 0x40ff59fbdc65eba1, - 0x40ff59fbdc65eba1, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff676f0be6041d, 0x40ff74e23b661c99, 0x40ff74e23b661c99, - 0x40ff74e23b661c99, 0x40ff74e23b661c99, 0x40ff74e23b661c99, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, 0x40ff82556ae63515, - 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff8fc89a664d91, 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, - 0x40ff9d3bc9e6660d, 0x40ff9d3bc9e6660d, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffaaaef9667e8a, 0x40ffb82228e69706, - 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffb82228e69706, 0x40ffc5955866af82, 0x40ffc5955866af82, 0x40ffc5955866af82, 0x40ffc5955866af82, - 0x40ffc5955866af82, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffd30887e6c7fe, 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, - 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, 0x40ffe07bb766e07a, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, 0x40ffedeee6e6f8f6, - 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x40fffb6216671172, 0x4100046aa2f394f7, 0x4100046aa2f394f7, 0x4100046aa2f394f7, - 0x4100046aa2f394f7, 0x4100046aa2f394f7, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x41000b243ab3a135, 0x410011ddd273ad73, - 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410011ddd273ad73, 0x410018976a33b9b1, 0x410018976a33b9b1, 0x410018976a33b9b1, 0x410018976a33b9b1, - 0x410018976a33b9b1, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x41001f5101f3c5f0, 0x4100260a99b3d22e, 0x4100260a99b3d22e, - 0x4100260a99b3d22e, 0x4100260a99b3d22e, 0x4100260a99b3d22e, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, 0x41002cc43173de6c, - 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x4100337dc933eaaa, 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, - 0x41003a3760f3f6e8, 0x41003a3760f3f6e8, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410040f0f8b40326, 0x410047aa90740f64, - 0x410047aa90740f64, 0x410047aa90740f64, 0x410047aa90740f64, 0x410047aa90740f64, 0x41004e6428341ba2, 0x41004e6428341ba2, 0x41004e6428341ba2, 0x41004e6428341ba2, - 0x41004e6428341ba2, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x4100551dbff427e0, 0x41005bd757b4341e, 0x41005bd757b4341e, - 0x41005bd757b4341e, 0x41005bd757b4341e, 0x41005bd757b4341e, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, 0x41006290ef74405c, - 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x4100694a87344c9a, 0x410070041ef458d8, 0x410070041ef458d8, 0x410070041ef458d8, - 0x410070041ef458d8, 0x410070041ef458d8, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x410076bdb6b46516, 0x41007d774e747154, - 0x41007d774e747154, 0x41007d774e747154, 0x41007d774e747154, 0x41007d774e747154, 0x41008430e6347d93, 0x41008430e6347d93, 0x41008430e6347d93, 0x41008430e6347d93, - 0x41008430e6347d92, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x41008aea7df489d1, 0x410091a415b4960f, 0x410091a415b4960f, - 0x410091a415b4960f, 0x410091a415b4960f, 0x410091a415b4960f, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, 0x4100985dad74a24d, - 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x41009f174534ae8b, 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, - 0x4100a5d0dcf4bac9, 0x4100a5d0dcf4bac9, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100ac8a74b4c707, 0x4100b3440c74d345, - 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b3440c74d345, 0x4100b9fda434df83, 0x4100b9fda434df83, 0x4100b9fda434df83, 0x4100b9fda434df83, - 0x4100b9fda434df83, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c0b73bf4ebc1, 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3d9c66e687341763, 0x3d9c66e687341763, 0x3d9c66e687341763, 0x3d9c66e687341763, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd86d00564a2d731, 0xbd86d00564a2d731, 0xbd86d00564a2d731, 0xbd86d00564a2d731, 0xbd86d00564a2d731, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd765b848a4500c8, 0xbd765b848a4500c8, 0xbd765b848a4500c8, 0xbd765b848a4500c8, 0xbd765b848a4500c8, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9695c4f773ebfc, 0x3d9695c4f773ebfc, 0x3d9695c4f773ebfc, - 0x3d9695c4f773ebfc, 0x3d9695c4f773ebfc, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d986b5733a96839, - 0x3d986b5733a96839, 0x3d986b5733a96839, 0x3d986b5733a96839, 0x3d986b5733a96839, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd7db1cd7b1af1ba, 0xbd7db1cd7b1af1ba, 0xbd7db1cd7b1af1ba, 0xbd7db1cd7b1af1ba, 0xbd7db1cd7b1af1ba, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8324e0ec37deb8, 0xbd8324e0ec37deb8, 0xbd8324e0ec37deb8, 0xbd8324e0ec37deb8, 0xbd8324e0ec37deb8, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9a91544afe9b26, 0x3d9a91544afe9b26, 0x3d9a91544afe9b26, - 0x3d9a91544afe9b26, 0x3d9a91544afe9b26, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d946fc7e01eb90f, - 0x3d946fc7e01eb90f, 0x3d946fc7e01eb90f, 0x3d946fc7e01eb90f, 0x3d946fc7e01eb90f, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd6b872059e06a24, 0xbd6b872059e06a24, 0xbd6b872059e06a24, 0xbd6b872059e06a24, 0xbd6b872059e06a24, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8b1bff934d3d0c, 0xbd8b1bff934d3d0c, 0xbd8b1bff934d3d0c, 0xbd8b1bff934d3d0c, 0xbd8b1bff934d3d0c, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9e8ce39e894a50, 0x3d9e8ce39e894a50, 0x3d9e8ce39e894a50, - 0x3d9e8ce39e894a50, 0x3d9e8ce39e894a50, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda7c5e3b9b5fb0d, - 0xbda7c5e3b9b5fb0d, 0xbda7c5e3b9b5fb0d, 0xbda7c5e3b9b5fb0d, 0xbda7c5e3b9b5fb0d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbdafbaaa5bd8af0d, 0xbdafbaaa5bd8af0d, 0xbdafbaaa5bd8af0d, 0xbdafbaaa5bd8af0d, 0xbdafbaaa5bd8af0d, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da73b3871675928, 0x3da73b3871675928, 0x3da73b3871675928, 0x3da73b3871675928, 0x3da73b3871675928, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd9d778d0dec0686, 0xbd9d778d0dec0686, 0xbd9d778d0dec0686, - 0xbd9d778d0dec0686, 0xbd9d778d0dec0686, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d88f1527212b576, - 0x3d88f1527212b576, 0x3d88f1527212b576, 0x3d88f1527212b576, 0x3d88f1527212b576, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d7218ea6f65443e, 0x3d7218ea6f65443e, 0x3d7218ea6f65443e, 0x3d7218ea6f65443e, 0x3d7218ea6f65443e, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd95851e70bbfcda, 0xbd95851e70bbfcda, 0xbd95851e70bbfcda, 0xbd95851e70bbfcda, 0xbd95851e70bbfcda, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3da3420122cf5452, 0x3da3420122cf5452, 0x3da3420122cf5452, - 0x3da3420122cf5452, 0x3da3420122cf5452, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdabc1730d40aa37, - 0xbdabc1730d40aa37, 0xbdabc1730d40aa37, 0xbdabc1730d40aa37, 0xbdabc1730d40aa37, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbdabbf1b084dffe3, 0xbdabbf1b084dffe3, 0xbdabbf1b084dffe3, 0xbdabbf1b084dffe3, 0xbdabbf1b084dffe3, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da33fa91ddca9fe, 0x3da33fa91ddca9fe, 0x3da33fa91ddca9fe, 0x3da33fa91ddca9fe, 0x3da33fa91ddca9fe, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd95806e66d6a832, 0xbd95806e66d6a832, 0xbd95806e66d6a832, - 0xbd95806e66d6a832, 0xbd95806e66d6a832, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d72062a47cff19c, - 0x3d72062a47cff19c, 0x3d72062a47cff19c, 0x3d72062a47cff19c, 0x3d72062a47cff19c, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d88fab285dd5ec7, 0x3d88fab285dd5ec7, 0x3d88fab285dd5ec7, 0x3d88fab285dd5ec7, 0x3d88fab285dd5ec7, 0xbff0000000000000, 0xbff0000000000000, -] )) ), - -################ chunk 16384 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, 0x4100c770d3b4f7ff, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, 0x4100ce2a6b75043d, - 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100d4e40335107b, 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, - 0x4100db9d9af51cb9, 0x4100db9d9af51cb9, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e25732b528f7, 0x4100e910ca753535, - 0x4100e910ca753535, 0x4100e910ca753535, 0x4100e910ca753535, 0x4100e910ca753535, 0x4100efca62354174, 0x4100efca62354174, 0x4100efca62354174, 0x4100efca62354174, - 0x4100efca62354174, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100f683f9f54db2, 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, - 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, 0x4100fd3d91b559f0, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, 0x410103f72975662e, - 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x41010ab0c135726c, 0x4101116a58f57eaa, 0x4101116a58f57eaa, 0x4101116a58f57eaa, - 0x4101116a58f57eaa, 0x4101116a58f57eaa, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011823f0b58ae8, 0x41011edd88759726, - 0x41011edd88759726, 0x41011edd88759726, 0x41011edd88759726, 0x41011edd88759726, 0x410125972035a364, 0x410125972035a364, 0x410125972035a364, 0x410125972035a364, - 0x410125972035a364, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x41012c50b7f5afa2, 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, - 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, 0x4101330a4fb5bbe0, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, 0x410139c3e775c81e, - 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101407d7f35d45c, 0x4101473716f5e09a, 0x4101473716f5e09a, 0x4101473716f5e09a, - 0x4101473716f5e09a, 0x4101473716f5e09a, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x41014df0aeb5ecd8, 0x410154aa4675f917, - 0x410154aa4675f917, 0x410154aa4675f917, 0x410154aa4675f917, 0x410154aa4675f917, 0x41015b63de360555, 0x41015b63de360555, 0x41015b63de360555, 0x41015b63de360555, - 0x41015b63de360555, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x4101621d75f61193, 0x410168d70db61dd1, 0x410168d70db61dd1, - 0x410168d70db61dd1, 0x410168d70db61dd1, 0x410168d70db61dd1, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, 0x41016f90a5762a0f, - 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x4101764a3d36364d, 0x41017d03d4f6428b, 0x41017d03d4f6428b, 0x41017d03d4f6428b, - 0x41017d03d4f6428b, 0x41017d03d4f6428b, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x410183bd6cb64ec9, 0x41018a7704765b07, - 0x41018a7704765b07, 0x41018a7704765b07, 0x41018a7704765b07, 0x41018a7704765b07, 0x410191309c366745, 0x410191309c366745, 0x410191309c366745, 0x410191309c366745, - 0x410191309c366745, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x410197ea33f67383, 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, - 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, 0x41019ea3cbb67fc1, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, 0x4101a55d63768bff, - 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101ac16fb36983d, 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, - 0x4101b2d092f6a47b, 0x4101b2d092f6a47b, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101b98a2ab6b0ba, 0x4101c043c276bcf8, - 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c043c276bcf8, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, 0x4101c6fd5a36c936, - 0x4101c6fd5a36c936, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101cdb6f1f6d574, 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, - 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, 0x4101d47089b6e1b2, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, 0x4101db2a2176edf0, - 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e1e3b936fa2e, 0x4101e89d50f7066c, 0x4101e89d50f7066c, 0x4101e89d50f7066c, - 0x4101e89d50f7066c, 0x4101e89d50f7066c, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101ef56e8b712aa, 0x4101f61080771ee8, - 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101f61080771ee8, 0x4101fcca18372b26, 0x4101fcca18372b26, 0x4101fcca18372b26, 0x4101fcca18372b26, - 0x4101fcca18372b26, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020383aff73764, 0x41020a3d47b743a2, 0x41020a3d47b743a2, - 0x41020a3d47b743a2, 0x41020a3d47b743a2, 0x41020a3d47b743a2, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, 0x410210f6df774fe0, - 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x410217b077375c1e, 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9d7c3d17d15b2e, 0xbd9d7c3d17d15b2e, 0xbd9d7c3d17d15b2e, 0xbd9d7c3d17d15b2e, 0xbd9d7c3d17d15b2e, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3da73d90765a037c, 0x3da73d90765a037c, 0x3da73d90765a037c, - 0x3da73d90765a037c, 0x3da73d90765a037c, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdafbd0260cb5961, - 0xbdafbd0260cb5961, 0xbdafbd0260cb5961, 0xbdafbd0260cb5961, 0xbdafbd0260cb5961, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbda7c38bb4c350b9, 0xbda7c38bb4c350b9, 0xbda7c38bb4c350b9, 0xbda7c38bb4c350b9, 0xbda7c38bb4c350b9, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d9e883394a3f5a8, 0x3d9e883394a3f5a8, 0x3d9e883394a3f5a8, 0x3d9e883394a3f5a8, 0x3d9e883394a3f5a8, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd8b129f7f8293bb, 0xbd8b129f7f8293bb, 0xbd8b129f7f8293bb, - 0xbd8b129f7f8293bb, 0xbd8b129f7f8293bb, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd6baca0a90b0f67, - 0xbd6baca0a90b0f67, 0xbd6baca0a90b0f67, 0xbd6baca0a90b0f67, 0xbd6baca0a90b0f67, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d947477ea040db7, 0x3d947477ea040db7, 0x3d947477ea040db7, 0x3d947477ea040db7, 0x3d947477ea040db7, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda2b9addf735cc1, 0xbda2b9addf735cc1, 0xbda2b9addf735cc1, 0xbda2b9addf735cc1, 0xbda2b9addf735cc1, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3dab391fc9e4b2a6, 0x3dab391fc9e4b2a6, 0x3dab391fc9e4b2a6, - 0x3dab391fc9e4b2a6, 0x3dab391fc9e4b2a6, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3dac476e4ba9f775, - 0x3dac476e4ba9f775, 0x3dac476e4ba9f775, 0x3dac476e4ba9f775, 0x3dac476e4ba9f775, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbda3c7fc6138a18f, 0xbda3c7fc6138a18f, 0xbda3c7fc6138a18f, 0xbda3c7fc6138a18f, 0xbda3c7fc6138a18f, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d969114ed8e9754, 0x3d969114ed8e9754, 0x3d969114ed8e9754, 0x3d969114ed8e9754, 0x3d969114ed8e9754, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbd7648c462afae27, 0xbd7648c462afae27, 0xbd7648c462afae27, - 0xbd7648c462afae27, 0xbd7648c462afae27, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd86d965786d8082, - 0xbd86d965786d8082, 0xbd86d965786d8082, 0xbd86d965786d8082, 0xbd86d965786d8082, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3d9c6b9691196c0b, 0x3d9c6b9691196c0b, 0x3d9c6b9691196c0b, 0x3d9c6b9691196c0b, 0x3d9c6b9691196c0b, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda6b53d32fe0beb, 0xbda6b53d32fe0beb, 0xbda6b53d32fe0beb, 0xbda6b53d32fe0beb, 0xbda6b53d32fe0beb, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3daf34af1d6f61d0, 0x3daf34af1d6f61d0, 0x3daf34af1d6f61d0, - 0x3daf34af1d6f61d0, 0x3daf34af1d6f61d0, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da84bdef81f484b, - 0x3da84bdef81f484b, 0x3da84bdef81f484b, 0x3da84bdef81f484b, 0x3da84bdef81f484b, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd9f98da1b5be4cb, 0xbd9f98da1b5be4cb, 0xbd9f98da1b5be4cb, 0xbd9f98da1b5be4cb, 0xbd9f98da1b5be4cb, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d8d33ec8cf27200, 0x3d8d33ec8cf27200, 0x3d8d33ec8cf27200, 0x3d8d33ec8cf27200, 0x3d8d33ec8cf27200, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d63276c734b9653, 0x3d63276c734b9653, 0x3d63276c734b9653, - 0x3d63276c734b9653, 0x3d63276c734b9653, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9363d1634c1e95, - 0xbd9363d1634c1e95, 0xbd9363d1634c1e95, 0xbd9363d1634c1e95, 0xbd9363d1634c1e95, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3da2315a9c176530, 0x3da2315a9c176530, 0x3da2315a9c176530, 0x3da2315a9c176530, 0x3da2315a9c176530, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdaab0cc8688bb15, 0xbdaab0cc8688bb15, 0xbdaab0cc8688bb15, 0xbdaab0cc8688bb15, 0xbdaab0cc8688bb15, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbdaccfc18f05ef06, 0xbdaccfc18f05ef06, 0xbdaccfc18f05ef06, -] )) ), - -################ chunk 16896 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x41021e6a0ef7685d, 0x41021e6a0ef7685d, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022523a6b7749b, 0x41022bdd3e7780d9, - 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41022bdd3e7780d9, 0x41023296d6378d17, 0x41023296d6378d17, 0x41023296d6378d17, 0x41023296d6378d17, - 0x41023296d6378d17, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x410239506df79955, 0x4102400a05b7a593, 0x4102400a05b7a593, - 0x4102400a05b7a593, 0x4102400a05b7a593, 0x4102400a05b7a593, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, 0x410246c39d77b1d1, - 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41024d7d3537be0f, 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, - 0x41025436ccf7ca4d, 0x41025436ccf7ca4d, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x41025af064b7d68b, 0x410261a9fc77e2c9, - 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410261a9fc77e2c9, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, 0x410268639437ef07, - 0x410268639437ef07, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x41026f1d2bf7fb45, 0x410275d6c3b80783, 0x410275d6c3b80783, - 0x410275d6c3b80783, 0x410275d6c3b80783, 0x410275d6c3b80783, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, 0x41027c905b7813c1, - 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028349f3382000, 0x41028a038af82c3e, 0x41028a038af82c3e, 0x41028a038af82c3e, - 0x41028a038af82c3e, 0x41028a038af82c3e, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x410290bd22b8387c, 0x41029776ba7844ba, - 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029776ba7844ba, 0x41029e30523850f8, 0x41029e30523850f8, 0x41029e30523850f8, 0x41029e30523850f8, - 0x41029e30523850f8, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102a4e9e9f85d36, 0x4102aba381b86974, 0x4102aba381b86974, - 0x4102aba381b86974, 0x4102aba381b86974, 0x4102aba381b86974, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, 0x4102b25d197875b2, - 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102b916b13881f0, 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, - 0x4102bfd048f88e2e, 0x4102bfd048f88e2e, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102c689e0b89a6c, 0x4102cd437878a6aa, - 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102cd437878a6aa, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, 0x4102d3fd1038b2e8, - 0x4102d3fd1038b2e8, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102dab6a7f8bf26, 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, - 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, 0x4102e1703fb8cb64, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, 0x4102e829d778d7a3, - 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102eee36f38e3e1, 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, - 0x4102f59d06f8f01f, 0x4102f59d06f8f01f, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x4102fc569eb8fc5d, 0x410303103679089b, - 0x410303103679089b, 0x410303103679089b, 0x410303103679089b, 0x410303103679089b, 0x410309c9ce3914d9, 0x410309c9ce3914d9, 0x410309c9ce3914d9, 0x410309c9ce3914d9, - 0x410309c9ce3914d9, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103108365f92117, 0x4103173cfdb92d55, 0x4103173cfdb92d55, - 0x4103173cfdb92d55, 0x4103173cfdb92d55, 0x4103173cfdb92d55, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, 0x41031df695793993, - 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x410324b02d3945d1, 0x41032b69c4f9520f, 0x41032b69c4f9520f, 0x41032b69c4f9520f, - 0x41032b69c4f9520f, 0x41032b69c4f9520f, 0x4090000000000000, 0x4090040000000000, 0x408ff80000000000, 0x4090020000000000, 0x408ffc0000000000, 0x40a0000000000000, - 0x40a0020000000000, 0x409ffc0000000000, 0x40a0010000000000, 0x409ffe0000000000, 0x40b0000000000000, 0x40b0010000000000, 0x40affe0000000000, 0x40b0008000000000, - 0x40afff0000000000, 0x40c0000000000000, 0x40c0008000000000, 0x40bfff0000000000, 0x40c0004000000000, 0x40bfff8000000000, 0x40d0000000000000, 0x40d0004000000000, - 0x40cfff8000000000, 0x40d0002000000000, 0x40cfffc000000000, 0x40e0000000000000, 0x40e0002000000000, 0x40dfffc000000000, 0x40e0001000000000, 0x40dfffe000000000, - 0x40f0000000000000, 0x40f0001000000000, 0x40efffe000000000, 0x40f0000800000000, 0x40effff000000000, 0x4100000000000000, 0x4100000800000000, 0x40fffff000000000, - 0x4100000400000000, 0x40fffff800000000, 0x4110000000000000, 0x4110000400000000, 0x410ffff800000000, 0x4110000200000000, 0x410ffffc00000000, 0x4120000000000000, - 0x4120000200000000, 0x411ffffc00000000, 0x4120000100000000, 0x411ffffe00000000, 0x4130000000000000, 0x4130000100000000, 0x412ffffe00000000, 0x4130000080000000, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0xbdaccfc18f05ef06, 0xbdaccfc18f05ef06, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da4504fa4949921, - 0x3da4504fa4949921, 0x3da4504fa4949921, 0x3da4504fa4949921, 0x3da4504fa4949921, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd97a1bb74468677, 0xbd97a1bb74468677, 0xbd97a1bb74468677, 0xbd97a1bb74468677, 0xbd97a1bb74468677, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d7a8b5e7d8f6ab1, 0x3d7a8b5e7d8f6ab1, 0x3d7a8b5e7d8f6ab1, 0x3d7a8b5e7d8f6ab1, 0x3d7a8b5e7d8f6ab1, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d84b8186afda23d, 0x3d84b8186afda23d, 0x3d84b8186afda23d, - 0x3d84b8186afda23d, 0x3d84b8186afda23d, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd9b5af00a617ce9, - 0xbd9b5af00a617ce9, 0xbd9b5af00a617ce9, 0xbd9b5af00a617ce9, 0xbd9b5af00a617ce9, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3da62ce9efa2145a, 0x3da62ce9efa2145a, 0x3da62ce9efa2145a, 0x3da62ce9efa2145a, 0x3da62ce9efa2145a, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbdaeac5bda136a3f, 0xbdaeac5bda136a3f, 0xbdaeac5bda136a3f, 0xbdaeac5bda136a3f, 0xbdaeac5bda136a3f, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbda8d4323b7b3fdc, 0xbda8d4323b7b3fdc, 0xbda8d4323b7b3fdc, - 0xbda8d4323b7b3fdc, 0xbda8d4323b7b3fdc, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3da054c05109e9f7, - 0x3da054c05109e9f7, 0x3da054c05109e9f7, 0x3da054c05109e9f7, 0x3da054c05109e9f7, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd8f55399a625045, 0xbd8f55399a625045, 0xbd8f55399a625045, 0xbd8f55399a625045, 0xbd8f55399a625045, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd5544707b183a7d, 0xbd5544707b183a7d, 0xbd5544707b183a7d, 0xbd5544707b183a7d, 0xbd5544707b183a7d, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d92532adc942f72, 0x3d92532adc942f72, 0x3d92532adc942f72, - 0x3d92532adc942f72, 0x3d92532adc942f72, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbda1a90758bb6d9e, - 0xbda1a90758bb6d9e, 0xbda1a90758bb6d9e, 0xbda1a90758bb6d9e, 0xbda1a90758bb6d9e, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3daa2879432cc384, 0x3daa2879432cc384, 0x3daa2879432cc384, 0x3daa2879432cc384, 0x3daa2879432cc384, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3dad5814d261e697, 0x3dad5814d261e697, 0x3dad5814d261e697, 0x3dad5814d261e697, 0x3dad5814d261e697, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0xbda4d8a2e7f090b2, 0xbda4d8a2e7f090b2, 0xbda4d8a2e7f090b2, - 0xbda4d8a2e7f090b2, 0xbda4d8a2e7f090b2, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0x3d98b261fafe7599, - 0x3d98b261fafe7599, 0x3d98b261fafe7599, 0x3d98b261fafe7599, 0x3d98b261fafe7599, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0xbd7ecdf8986f273b, 0xbd7ecdf8986f273b, 0xbd7ecdf8986f273b, 0xbd7ecdf8986f273b, 0xbd7ecdf8986f273b, 0xbff0000000000000, 0xbff0000000000000, - 0xbff0000000000000, 0xbff0000000000000, 0xbff0000000000000, 0xbd8296cb5d8dc3f8, 0xbd8296cb5d8dc3f8, 0xbd8296cb5d8dc3f8, 0xbd8296cb5d8dc3f8, 0xbd8296cb5d8dc3f8, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3d9a4a4983a98dc6, 0x3d9a4a4983a98dc6, 0x3d9a4a4983a98dc6, - 0x3d9a4a4983a98dc6, 0x3d9a4a4983a98dc6, 0x3fef98669d7aedb8, 0x3fe557012c0b1fae, 0x3fd99ab7a3c97099, 0x3fee28df4155ee38, 0x3fe94b9b627e3d8b, 0x3fee6439427e96b9, - 0x3fe8d9ad9d741941, 0x3fcff6ab69ab99f9, 0x3fef794e3e8fb787, 0x3fe5de4587979a24, 0x3fe9ba4a85e6ce6c, 0x3fede9a6e35dc7d2, 0xbfb0e3cd8b89b3a3, 0x3fefb3717aed2271, - 0x3fdae92b9a539aed, 0x3fd2bd43d0eb2c92, 0x3feecf343a9a3b5d, 0xbfe4af3b1102ac8b, 0x3fe6e452f825d183, 0xbfc9c94ff2246ad9, 0xbfea835a25a9edd8, 0x3f9813cd16ce910a, - 0xbfed67101411ae9a, 0xbfdd5aa89a751131, 0xbfefdb982dea8158, 0x3fd7de36a119d74b, 0xbfe28956c81752d0, 0x3fef6eb38d7d11b4, 0xbfbe1809a8e94e2e, 0x3fe8b538b06fb01e, - 0xbfe719453109288b, 0xbfef1d96dea65228, 0x3fc89eba92bf27c6, 0xbfeee37028eb1f04, 0xbfd34ea7c01f9a41, 0x3fa58ced65ec8b50, 0x3feba1859b0d0123, 0xbfea2cebbb513e7c, - 0x3fe08292273454cf, 0xbfdc4ac0840e0011, 0xbfefe2f9378c3909, 0xbfdded644ac6704b, 0xbfe37e403cff462d, 0xbfeab15b51c2ae6d, 0xbfed46027aa61a66, 0x3fef8c1986ca67fa, - 0x3fd9102d8065bbb9, 0x3fe58efb524baf70, 0x3fe91d21d6b953d7, 0x3fee41c1a1728a39, 0x3fee33ada92fe2ae, 0x3fcdacfb27d45b34, 0x3fe937a45bd49642, 0x3fe56f3082d8f8a6, -] )) ), - -################ chunk 17408 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x412fffff00000000, 0x4140000000000000, 0x4140000080000000, 0x413fffff00000000, 0x4140000040000000, 0x413fffff80000000, 0x4150000000000000, 0x4150000040000000, - 0x414fffff80000000, 0x4150000020000000, 0x414fffffc0000000, 0x4160000000000000, 0x4160000020000000, 0x415fffffc0000000, 0x4160000010000000, 0x415fffffe0000000, - 0x4170000000000000, 0x4170000010000000, 0x416fffffe0000000, 0x4170000008000000, 0x416ffffff0000000, 0x4180000000000000, 0x4180000008000000, 0x417ffffff0000000, - 0x4180000004000000, 0x417ffffff8000000, 0x4190000000000000, 0x4190000004000000, 0x418ffffff8000000, 0x4190000002000000, 0x418ffffffc000000, 0x41a0000000000000, - 0x41a0000002000000, 0x419ffffffc000000, 0x41a0000001000000, 0x419ffffffe000000, 0x41b0000000000000, 0x41b0000001000000, 0x41affffffe000000, 0x41b0000000800000, - 0x41afffffff000000, 0x41c0000000000000, 0x41c0000000800000, 0x41bfffffff000000, 0x41c0000000400000, 0x41bfffffff800000, 0x41d0000000000000, 0x41d0000000400000, - 0x41cfffffff800000, 0x41d0000000200000, 0x41cfffffffc00000, 0x41e0000000000000, 0x41e0000000200000, 0x41dfffffffc00000, 0x41e0000000100000, 0x41dfffffffe00000, - 0x41f0000000000000, 0x41f0000000100000, 0x41efffffffe00000, 0x41f0000000080000, 0x41effffffff00000, 0x4200000000000000, 0x4200000000080000, 0x41fffffffff00000, - 0x4200000000040000, 0x41fffffffff80000, 0x4210000000000000, 0x4210000000040000, 0x420ffffffff80000, 0x4210000000020000, 0x420ffffffffc0000, 0x4220000000000000, - 0x4220000000020000, 0x421ffffffffc0000, 0x4220000000010000, 0x421ffffffffe0000, 0x4230000000000000, 0x4230000000010000, 0x422ffffffffe0000, 0x4230000000008000, - 0x422fffffffff0000, 0x4240000000000000, 0x4240000000008000, 0x423fffffffff0000, 0x4240000000004000, 0x423fffffffff8000, 0x4250000000000000, 0x4250000000004000, - 0x424fffffffff8000, 0x4250000000002000, 0x424fffffffffc000, 0x4260000000000000, 0x4260000000002000, 0x425fffffffffc000, 0x4260000000001000, 0x425fffffffffe000, - 0x4270000000000000, 0x4270000000001000, 0x426fffffffffe000, 0x4270000000000800, 0x426ffffffffff000, 0x4280000000000000, 0x4280000000000800, 0x427ffffffffff000, - 0x4280000000000400, 0x427ffffffffff800, 0x4290000000000000, 0x4290000000000400, 0x428ffffffffff800, 0x4290000000000200, 0x428ffffffffffc00, 0x42a0000000000000, - 0x42a0000000000200, 0x429ffffffffffc00, 0x42a0000000000100, 0x429ffffffffffe00, 0x42b0000000000000, 0x42b0000000000100, 0x42affffffffffe00, 0x42b0000000000080, - 0x42afffffffffff00, 0x42c0000000000000, 0x42c0000000000080, 0x42bfffffffffff00, 0x42c0000000000040, 0x42bfffffffffff80, 0x42d0000000000000, 0x42d0000000000040, - 0x42cfffffffffff80, 0x42d0000000000020, 0x42cfffffffffffc0, 0x42e0000000000000, 0x42e0000000000020, 0x42dfffffffffffc0, 0x42e0000000000010, 0x42dfffffffffffe0, - 0x42f0000000000000, 0x42f0000000000010, 0x42efffffffffffe0, 0x42f0000000000008, 0x42effffffffffff0, 0x4300000000000000, 0x4300000000000008, 0x42fffffffffffff0, - 0x4300000000000004, 0x42fffffffffffff8, 0x4310000000000000, 0x4310000000000004, 0x430ffffffffffff8, 0x4310000000000002, 0x430ffffffffffffc, 0x408f400000000000, - 0x4091300000000000, 0x408c200000000000, 0x408f480000000000, 0x408f380000000000, 0x40c3880000000000, 0x40c57c0000000000, 0x40c1940000000000, 0x40c3888000000000, - 0x40c3878000000000, 0x40f86a0000000000, 0x40fadb0000000000, 0x40f5f90000000000, 0x40f86a1000000000, 0x40f869f000000000, 0x412e848000000000, 0x4130c8e000000000, - 0x412b774000000000, 0x412e848200000000, 0x412e847e00000000, 0x416312d000000000, 0x4164fb1800000000, 0x41612a8800000000, 0x416312d020000000, 0x416312cfe0000000, - 0x4197d78400000000, 0x419a39de00000000, 0x4195752a00000000, 0x4197d78404000000, 0x4197d783fc000000, 0x41cdcd6500000000, 0x41d0642ac0000000, 0x41cad27480000000, - 0x41cdcd6500800000, 0x41cdcd64ff800000, 0x4202a05f20000000, 0x42047d3570000000, 0x4200c388d0000000, 0x4202a05f20080000, 0x4202a05f1ff80000, 0x42374876e8000000, - 0x42399c82cc000000, 0x4234f46b04000000, 0x42374876e8010000, 0x42374876e7ff0000, 0x426d1a94a2000000, 0x427001d1bf800000, 0x426a3185c5000000, 0x426d1a94a2002000, - 0x426d1a94a1ffe000, 0x42a2309ce5400000, 0x42a402462f600000, 0x42a05ef39b200000, 0x42a2309ce5400200, 0x42a2309ce53ffe00, 0x42d6bcc41e900000, 0x42d902d7bb380000, - 0x42d476b081e80000, 0x42d6bcc41e900040, 0x42d6bcc41e8fffc0, 0x430c6bf526340000, 0x430f438daa060000, 0x4309945ca2620000, 0x430c6bf526340008, 0x430c6bf52633fff8, - 0x4341c37937e08000, 0x43438a388a43c000, 0x433ff973cafa8000, 0x4341c37937e08000, 0x4341c37937e08000, 0x4376345785d8a000, 0x43786cc6acd4b000, 0x4373fbe85edc9000, - 0x4376345785d8a000, 0x4376345785d8a000, 0x43abc16d674ec800, 0x43ae87f85809dc00, 0x43a8fae27693b400, 0x43abc16d674ec800, 0x43abc16d674ec800, 0x409f400000000000, - 0x40d3880000000000, 0x40a7700000000000, 0x40dd4c0000000000, 0x40b3880000000000, 0x40e86a0000000000, 0x40bf400000000000, 0x40f3880000000000, 0x40c9640000000000, - 0x40ffbd0000000000, 0x40d4820000000000, 0x4109a28000000000, 0x40e09a0000000000, 0x4114c08000000000, 0x40eadb0000000000, 0x4120c8e000000000, 0x40f5ba8000000000, - 0x412b292000000000, 0x4101940000000000, 0x4135f90000000000, 0x410c714000000000, 0x4141c6c800000000, 0x411702a000000000, 0x414cc34800000000, 0x41229da000000000, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3fef932ec65b1d71, 0x3fe9027224e704fa, 0xbfba48dfb6dedc7a, 0x3fee4f9f2ca69a7a, 0x3fd8c11bfcff0bf3, 0x3fef84cb87f27aca, 0x3fcc5e944c25ddfc, 0xbfe66ce45566976a, - 0x3fee16e2d72bcae5, 0xbfd178cb94e982c8, 0x3fe52f27725c6a75, 0xbfecdb2c9e19e37f, 0xbfeb3aefdaedf0d7, 0xbfbf9d6bdd62473d, 0xbfeff47d828035ae, 0xbfe2b1386c2356f5, - 0x3fe40ad67f3f0c9a, 0x3fefd1fe5195a1a2, 0xbfd4532c3721ed43, 0x3fed8c6f300a4e27, 0x3fc684222ce7cf42, 0xbfcb9381aa1f0792, 0x3fe691e3aaf2bac6, 0xbfee0505ed05495e, - 0x3fd1dccdb8fb604b, 0xbfe5080d3c655fda, 0xbfed078da7f267e0, 0xbfeb03b8eccd6d81, 0xbfc16b64d0ba2fee, 0xbfefee5117e7de7f, 0xbfe305495657bcbf, 0x3fe4ab6511a7d39b, - 0x3fefb957eac4b278, 0xbfd2c6e027930661, 0x3fedd9ddebc91055, 0x3fc9b59e71dbc3e9, 0xbfc5315d441272de, 0x3fe7b15b165a9836, 0xbfed6b063454023c, 0x3fd4f5e4c8c289df, - 0xbfe3c78ca5b8e438, 0xbfee3edd2dfeef90, 0xbfe922a043b37f85, 0xbfce3164dbe8bfd8, 0xbfef8d94f6ae2333, 0xbfe5886c4549d6fe, 0x3fe92cb46a920144, 0x3fee398612c96801, - 0xbfb82ac4b53cde6b, 0x3fef904817b569bf, 0x3fd93e7a92b37336, 0x3fce70c2d5131e55, 0x3fee442c6ece90b5, 0xbfe60af33efcd1b2, 0x3fe594794e581a33, 0xbfd072280f63ee92, - 0xbfec6160ab00cc87, 0xbfb726fe54bd570a, 0xbfebc620597e2174, 0xbfe1d189a370cb58, 0xbfeffe665569837f, 0x3fe25722fce440b7, 0xbfd85006c884cf67, 0x3feff9997e9f3665, - 0x3fbc2fd68e174e47, 0x3fecaac2a7d977a0, 0xbfd5f42d7467737c, 0xbfef3960081bba1d, 0x3fe35cc7bd281d1a, 0xbfe80b3da22632da, 0x3fc31c48a387ae25, 0xbfe8781e90e43ee1, - 0x3fc08703307bdf8c, 0xbfee92ca17c17a14, 0xbfd72c9f6d71c48f, 0xbfef5c40a4fa17d8, 0x3fc5af85f5920329, 0xbfe79bce4c9299c3, 0x3fed778e67b786ed, 0xbfd4b965f7505f86, - 0x3fe3e0a8bee7d320, 0xbfee29bbad4a34c6, 0xbfe94a07334d8753, 0xbfcd3872fb117645, 0xbfef97fdeabd40fe, 0xbfe558ecbf295df3, 0x3fe8dceca447cc2f, 0x3fee629bc609ad19, - 0xbfbc2522826c9145, 0x3fef7a3c230679ad, 0x3fd852844a7ed11e, 0x3fca8ac198a43f66, 0x3feded4eddb14139, 0xbfe6c1b264108a90, 0x3fe4d4d47738ff61, 0xbfd25eb3471e35df, - 0xbfed3f8577b3aa88, 0xbfc38377325300fc, 0xbfeaba2f0767e6d5, 0xbfe37187c84b9c83, 0xbfefe44e52c8a562, 0x3fe5774001534a97, 0xbfd0be6fe3bde4fc, 0x3fef91693a804015, - 0x3fcdd73d3206811f, 0x3fee3742ec79593e, 0xbfb99bf99b8cd518, 0xbfec85872ad1def1, 0x3fe90ff9d3f8bd7e, 0xbfe212ede44cf1f3, 0x3fd8e927629dffec, 0xbfef5c0a8dda3078, - 0xbfd72aa4b28054b6, 0xbfe64dd1132b34d7, 0xbfe8776f64e86be6, 0xbfee931a53bfcefa, 0x3fed76ba5f13bf3a, 0x3fc5a726eaf73e30, 0x3fea6ceb2dfd7e8a, 0x3fe3defeb13ad651, - 0x3fefd7bcfe4b6fda, 0x3fe641d49e1cdd35, 0xbfcd48fcbe1f7e38, 0x3fef5f59494ee482, 0x3fd104f34f3f27c7, 0x3fee8e28818df4da, 0xbfa09e872a291106, 0xbfeb795e5bdf8cd0, - 0x3fea5a06f53679cb, 0xbfe03ebd9cc36159, 0x3fdcd80e73c34fc0, 0xbfefeebccef9b75b, 0xbfdf031d80668b28, 0xbfe30019f9247067, 0xbfeb072cdfc5a2bc, 0xbfed04d6c3c72a0b, - 0x3fefbb05dbc935f1, 0x3fdb507555f95a45, 0x3fe4a18bfc569a6a, 0x3fe9dc0898a5864b, 0x3fedd5367fd5480f, 0x3feeed40cc9f557c, 0x3fd396d992df53dd, 0x3fe79ffecb2a56b3, - 0x3fe7336dbdd8de2c, 0x3fef14a86ab65801, 0x3febc7711009e00b, 0x3faa480d05a78bd4, 0x3fec6027497a209e, 0x3fe0c34d7d94f93d, 0x3feffe73a085a62d, 0x3fe1ff026793f1bb, - 0x3feceabab3af8d64, 0x3fb0f58b3b6e2fb2, 0xbfd9158d4fc66255, 0x3feffd21b0401f9a, 0xbfee780e88ec4409, 0xbfd218d6717dbfd7, 0xbfe938c234a2c7e5, 0xbfd077601e8bdb04, - 0xbfe8b116ef7bfe0d, 0xbfeffac3841b3da7, 0x3feecc924c9c9ddc, 0x3fee1992128c0e47, 0xbfe23dc16ebb5fb1, 0xbfe050e628324337, 0x3fedf9df9906d32c, 0xbfed8e78a6cf2845, - 0xbfee5b77243ab262, 0x3fe99ed513372fa0, 0x3fcb165cde80ddd4, 0xbfed085be7a8f4a1, 0xbfe67c8180332c01, 0xbfefe80ce42182ac, 0xbfeb02b20ff99943, 0xbfc172fbc27daf4a, - 0xbfd741b388a8c029, 0xbfafcce8b3c0581b, 0x3fe7166c772abd32, 0xbfef5e7eac0cb917, 0x3fe2cdb23ebc4568, 0x3feacff8c7364234, 0xbfea042293820edd, 0x3fca1e6b94962239, - 0xbf7b079aad325820, 0x3fed2f4c89ddace2, 0x3febf098901c931a, 0x3fefecf9ce0c9b34, 0x3fddca527e0c50bb, 0x3fec391aa90d21f5, 0x3faf8062696d2f86, 0x3fd7bbf860c90a11, - 0x3fe8d966b8bedd25, 0xbfc08168e201f762, 0xbfe2985c9e8e130b, 0x3fef6b38f6f58ac3, 0x3fe9538731dff223, 0x3feb8e9e9f6df628, 0xbfd18ba183302d62, 0x3fee248913bcac5b, - 0xbfb6333d9e49c508, 0x3feea2b93bceea60, 0x3fe2989191d619ee, 0x3fede59ed8fd8127, 0x3fe854d2c978a2c8, 0x3fd18c1ea754277c, 0xbfef4a5e8cbdb66a, 0xbfefe4696e7709a4, - 0xbfec05431799cd0e, 0xbfd689003319820d, 0xbfe68b8aa9ebdcce, 0xbfe06c154609d33f, 0x3fe5cf370e1af74d, 0x3fd49d0e2edada03, 0xbfeffbd56a1a9b4d, 0x3fdc79c39defd9ee, - 0xbfe40991e398dbfc, 0xbfd643003557e87a, 0x3fefb26d3b4abef0, 0xbfe40991e398dbfc, 0xbfe40991e398dbfc, 0xbfec567c5278afcb, 0x3fed5593a9e16356, 0x3fc89deb18111af4, - 0xbfec567c5278afcb, 0xbfec567c5278afcb, 0x3fbe4da072c0759a, 0xbfe21d675cc21247, 0x3fd6cfe55a4245cc, 0x3fbe4da072c0759a, 0x3fbe4da072c0759a, 0xbfd784750e7f6c2a, - 0x3fea05bb5b890b51, 0xbfef38c9e0798e67, 0xbfe315f3639820d8, 0x3fc3cc2ca122a80a, 0xbf924e6a56dfd385, 0x3fb0ce1e7bcc7037, 0xbfe957097e2c1a8a, 0x3fefdf2399378a74, - 0x3fe3fde43ecb9017, 0xbf987a8016eef42c, 0xbfef1701b4f36985, 0xbfbcfeccfad03c13, 0xbfdb033fab1e8187, 0xbfefb2c766c4626d, 0x3fc902b4d65ae22c, 0x3fcfc82497b395fb, - 0x3fe9cfcd0ebaa2a6, 0xbfd83bbf8a8250e2, 0x3fe797e35c9cd4a7, 0x3fe9ae6aba6a0c5b, 0x3fefcf117865afce, 0xbfeb64cc7eb9ecb1, 0x3fe517d2451e1402, 0xbfefda3eab97a114, -] )) ), - -################ chunk 17920 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4157450800000000, 0x412e1ef000000000, 0x4162d35600000000, 0x41385e4800000000, 0x416e75da00000000, 0x4143b6e000000000, 0x4178a49800000000, 0x414fe60400000000, - 0x4183efc280000000, 0x4159ce7200000000, 0x4190210740000000, 0x4164e0ba00000000, 0x419a18e880000000, 0x40f8a88000000000, 0x412ed2a000000000, 0x416343a400000000, - 0x4073d4d0507dcb95, 0x4063d4d0507dcb95, 0x40f9258000000000, 0x412f6ee000000000, 0x4163a54c00000000, 0x407439583dcedc4a, 0x406439583dcedc4a, 0x40fa1f8000000000, - 0x413053b000000000, 0x4164689c00000000, 0x407502681870fdb2, 0x406502681870fdb2, 0x40fa9c8000000000, 0x4130a1d000000000, 0x4164ca4400000000, 0x407566f005c20e67, - 0x406566f005c20e67, 0x40fb968000000000, 0x41313e1000000000, 0x41658d9400000000, 0x40762fffe0642fcf, 0x40662fffe0642fcf, 0x40ff018000000000, 0x413360f000000000, - 0x4168392c00000000, 0x4078efb75d9ba4be, 0x4068efb75d9ba4be, 0x40fffb8000000000, 0x4133fd3000000000, 0x4168fc7c00000000, 0x4079b8c7383dc627, 0x4069b8c7383dc627, - 0x4100b94000000000, 0x4134e79000000000, 0x416a217400000000, 0x407ae65f0030f844, 0x406ae65f0030f844, 0x4100f7c000000000, 0x413535b000000000, 0x416a831c00000000, - 0x407b4ae6ed8208f8, 0x406b4ae6ed8208f8, 0x4102304000000000, 0x4136bc5000000000, 0x416c6b6400000000, 0x407d418e90175c7e, 0x406d418e90175c7e, 0x41026ec000000000, - 0x41370a7000000000, 0x416ccd0c00000000, 0x407da6167d686d33, 0x406da6167d686d33, 0x41032a4000000000, 0x4137f4d000000000, 0x416df20400000000, 0x407ed3ae455b9f50, - 0x406ed3ae455b9f50, 0x4103e5c000000000, 0x4138df3000000000, 0x416f16fc00000000, 0x408000a306a768b6, 0x407000a306a768b6, 0x410462c000000000, 0x41397b7000000000, - 0x416fda4c00000000, 0x4080652af3f8796b, 0x4070652af3f8796b, 0x41051e4000000000, 0x413a65d000000000, 0x41707fa200000000, 0x4080fbf6d7f21279, 0x4070fbf6d7f21279, - 0x4105d9c000000000, 0x413b503000000000, 0x4171121e00000000, 0x408192c2bbebab88, 0x407192c2bbebab88, 0x4106184000000000, 0x413b9e5000000000, 0x417142f200000000, - 0x4081c506b29433e2, 0x4071c506b29433e2, 0x410750c000000000, 0x413d24f000000000, 0x4172371600000000, 0x4082c05a83dedda5, 0x4072c05a83dedda5, 0x41078f4000000000, - 0x413d731000000000, 0x417267ea00000000, 0x4082f29e7a8765ff, 0x4072f29e7a8765ff, 0x41080c4000000000, 0x413e0f5000000000, 0x4172c99200000000, 0x4083572667d876b4, - 0x4073572667d876b4, 0x41084ac000000000, 0x413e5d7000000000, 0x4172fa6600000000, 0x4083896a5e80ff0e, 0x4073896a5e80ff0e, 0x4109c1c000000000, 0x4140191800000000, - 0x41741f5e00000000, 0x4084b7022674312b, 0x4074b7022674312b, 0x410b38c000000000, 0x4141037800000000, 0x4175445600000000, 0x4085e499ee676348, 0x4075e499ee676348, - 0x410bb5c000000000, 0x4141519800000000, 0x4175a5fe00000000, 0x40864921dbb873fd, 0x40764921dbb873fd, 0x410bf44000000000, 0x414178a800000000, 0x4175d6d200000000, - 0x40867b65d260fc57, 0x40767b65d260fc57, 0x410c714000000000, 0x4141c6c800000000, 0x4176387a00000000, 0x4086dfedbfb20d0b, 0x4076dfedbfb20d0b, 0x410d2cc000000000, - 0x41423bf800000000, 0x4176caf600000000, 0x408776b9a3aba61a, 0x407776b9a3aba61a, 0x410d6b4000000000, 0x4142630800000000, 0x4176fbca00000000, 0x4087a8fd9a542e74, - 0x4077a8fd9a542e74, 0x410ea3c000000000, 0x4143265800000000, 0x4177efee00000000, 0x4088a4516b9ed837, 0x4078a4516b9ed837, 0x410f5f4000000000, 0x41439b8800000000, - 0x4178826a00000000, 0x40893b1d4f987145, 0x40793b1d4f987145, 0x41100d6000000000, 0x414410b800000000, 0x417914e600000000, 0x4089d1e933920a54, 0x4079d1e933920a54, - 0x41106b2000000000, 0x414485e800000000, 0x4179a76200000000, 0x408a68b5178ba363, 0x407a68b5178ba363, 0x41108a6000000000, 0x4144acf800000000, 0x4179d83600000000, - 0x408a9af90e342bbd, 0x407a9af90e342bbd, 0x4110e82000000000, 0x4145222800000000, 0x417a6ab200000000, 0x408b31c4f22dc4cb, 0x407b31c4f22dc4cb, 0x411126a000000000, - 0x4145704800000000, 0x417acc5a00000000, 0x408b964cdf7ed580, 0x407b964cdf7ed580, 0x411145e000000000, 0x4145975800000000, 0x417afd2e00000000, 0x408bc890d6275dda, - 0x407bc890d6275dda, 0x4111e22000000000, 0x41465aa800000000, 0x417bf15200000000, 0x408cc3e4a772079d, 0x407cc3e4a772079d, 0x4112bce000000000, 0x41476c1800000000, - 0x417d471e00000000, 0x408e23c0660dc214, 0x407e23c0660dc214, 0x4112fb6000000000, 0x4147ba3800000000, 0x417da8c600000000, 0x408e8848535ed2c8, 0x407e8848535ed2c8, - 0x41131aa000000000, 0x4147e14800000000, 0x417dd99a00000000, 0x408eba8c4a075b23, 0x407eba8c4a075b23, 0x4113592000000000, 0x41482f6800000000, 0x417e3b4200000000, - 0x408f1f1437586bd7, 0x407f1f1437586bd7, 0x411433e000000000, 0x414940d800000000, 0x417f910e00000000, 0x40903f77fafa1327, 0x40803f77fafa1327, 0x411491a000000000, - 0x4149b60800000000, 0x418011c500000000, 0x40908addecf6dfae, 0x40808addecf6dfae, 0x41152de000000000, 0x414a795800000000, 0x41808bd700000000, 0x40910887d59c3490, - 0x40810887d59c3490, 0x41154d2000000000, 0x414aa06800000000, 0x4180a44100000000, 0x409121a9d0f078bd, 0x408121a9d0f078bd, 0x41158ba000000000, 0x414aee8800000000, - 0x4180d51500000000, 0x409153edc7990117, 0x408153edc7990117, 0x4115e96000000000, 0x414b63b800000000, 0x41811e5300000000, 0x40919f53b995cd9f, 0x40819f53b995cd9f, - 0x4116666000000000, 0x414bfff800000000, 0x41817ffb00000000, 0x409203dba6e6de53, 0x408203dba6e6de53, 0x7fdfffffffffffff, 0x7fe1ccf385ebc8a0, 0x7fac7b1f3cac7433, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3fe2573f41b3c7da, 0x3fecda8a29be2324, 0xbfce84fffb89359d, 0xbfee0c31d0e7ad55, 0xbfedd6d53a17647b, 0xbfe65582204e1f1d, 0xbfc0722375c39fb1, 0x3fda2d9efbcc29af, - 0x3fde985903385d94, 0x3fd78dc1c376279c, 0x3fe9e881f09b2014, 0x3feff7e30694ffef, 0x3fece1db297e0adc, 0xbfe2ee384081d8aa, 0xbfeff6f609e4245b, 0x3fec8872fa00c805, - 0xbff0000000000000, 0x3cf3da34489c213b, 0x3feef37d2c3baa6b, 0xbfeade48cd01342c, 0x3feb6cca87aced27, 0xbff0000000000000, 0x3d0dcc4d42e59df2, 0xbfec258b382b33c9, - 0x3fcf23207919ef10, 0x3fe8cb70945763fa, 0xbff0000000000000, 0xbd02c0e3eeb304ee, 0x3fe880653893353f, 0x3fe864ef708e9d05, 0x3fe749304164d8b4, 0xbff0000000000000, - 0xbd04f8837880a9a2, 0xbfeff420d658420b, 0x3feb78f3c1ed6a0b, 0x3fe3eb65a925f2b8, 0xbff0000000000000, 0x3d0b94adb917f93e, 0xbfdc0ebed26639cc, 0x3fc62fbf84eb5a52, - 0x3fc5d2860e6ec49c, 0xbff0000000000000, 0xbce60b679ab8cd3b, 0xbfd2d5fce9cc76de, 0x3fef9ebca91283a0, 0x3f9cf9437551142b, 0xbff0000000000000, 0x3cf3dfe9cf7253a2, - 0x3fc245763c42706b, 0xbfc1aa6eaad4a4e8, 0xbfc7b37f72e0f767, 0xbff0000000000000, 0xbcc1c2b1d543580a, 0xbfef228ea1517b6f, 0xbfe609679c4744c5, 0xbfd0506b32a5d343, - 0xbff0000000000000, 0xbd072a6d7b781bef, 0x3feb63088671d585, 0x3fe5317393efbfa3, 0xbfe27890d57450ce, 0xbff0000000000000, 0x3d008b687775b320, 0xbfe975146b460391, - 0x3fef301dfe29b980, 0xbfe44a75361753ae, 0xbff0000000000000, 0x3d072dfeefbdfb70, 0xbfdd6fbcdaecf3cd, 0xbfb11fe2f7799739, 0xbfe917f9f91c0f72, 0xbff0000000000000, - 0xbcfcb46a4ab20e3f, 0xbfa268f6fb37fae9, 0xbfedf3e1abeb85c3, 0xbfecbef3d8abd0e3, 0xbff0000000000000, 0xbd1d3cca5285f698, 0x3fe6b2a7d74fe691, 0x3f9fedfebd6cd16b, - 0xbfee74d876434eb1, 0xbff0000000000000, 0x3d04f93a295b6fef, 0x3fd5bce1ec9cad13, 0x3fee560c7f952539, 0xbfefd93b84b18d0d, 0xbff0000000000000, 0x3d19ed47d084c231, - 0xbfb863f44319801f, 0xbfe2812004ecce65, 0xbfefc7ca262f5e83, 0xbff0000000000000, 0x3cda8d34a48c3a73, 0x3feebf0672a8e9fb, 0xbfee3de51cb88228, 0xbfef6e8b041b0240, - 0xbff0000000000000, 0x3d04f4f2043aca22, 0xbfea907f4bcc6270, 0x3fedd935a26e3ea0, 0xbfeb57b79de5cafa, 0xbff0000000000000, 0xbcfcabda0070c2a5, 0x3fea5ade1f0480e7, - 0x3feefc7c91b8d270, 0xbfea15bba7bed456, 0xbff0000000000000, 0x3d134e42cc825961, 0xbfefa4a8a1a86b2a, 0x3fb3755bc1870ea2, 0xbfe72d2d5cc2a872, 0xbff0000000000000, - 0xbd146b249ab1552f, 0x3fe00f3bc3161e20, 0xbfe09778d53da4ff, 0xbfe58a696478699d, 0xbff0000000000000, 0x3d008fb09c9658ed, 0xbfd66fe353da9644, 0x3fecf2acb06e9ab9, - 0xbfd37c5ebeab7f24, 0xbff0000000000000, 0xbcc17e2f8338fb35, 0xbfee498080c4da1a, 0xbfefa9e708ce0bd0, 0x3fbe91e4b503b332, 0xbff0000000000000, 0xbd02bf768cfd7854, - 0x3fde1893bf6a1b15, 0xbfc75679cdf0cd77, 0x3fd09f232306d34d, 0xbff0000000000000, 0x3d1e59ac20b4f266, 0xbfefcb7a62423c2c, 0x3fdb22302652215a, 0x3fd4fec23ac426b3, - 0xbff0000000000000, 0xbd12365fd44ec9ae, 0x3fe9ae6aba6a0c5b, 0x3fefcf117865afce, 0x3fdd65fe2db183e3, 0xbff0000000000000, 0x3cf840e311f61f09, 0x3fef6117fa4086ae, - 0xbfd90b48a460f2b0, 0x3fe469e394ce625d, 0xbff0000000000000, 0x3d1585e2564ffe16, 0xbfe15d33643502c1, 0xbfeb52437809e7ff, 0x3fe61f4bd3d12aa2, 0xbff0000000000000, - 0xbd02c52c13d3aabb, 0x3fe8bf796559910d, 0x3feab5542b668bd8, 0x3fecd0c1cfe733fe, 0xbff0000000000000, 0x3d09643117d6138b, 0x3fdb62d7bd7d7659, 0x3fd256cbc1094ceb, - 0x3fef1e1d3f0cb914, 0xbff0000000000000, 0x3d17b7cc59477063, 0x3f2b50ddd4ae47eb, 0xbfeffffb722113c5, 0x3feffe38991924ee, 0xbff0000000000000, 0x3ceef2760c30aba7, - 0xbfdb5cab81ceaade, 0x3fd2982e55c3e476, 0x3fef66cd5cb9af7f, 0xbff0000000000000, 0xbd1f7469dc539b4d, 0x3fefee7127f20cea, 0x3fe96172e72a696e, 0x3feee195bf2ad218, - 0xbff0000000000000, 0x3d13511d8fed7295, 0x3febf7b03767668e, 0x3fd6ac5f9124265d, 0x3fec6335bd26ed12, 0xbff0000000000000, 0x3d1118c755450793, 0xbfef0b2ab9d87a2e, - 0xbfe8aaf02acb84ff, 0x3fe9fe0eb602e86f, 0xbff0000000000000, 0xbd16a0a011eea6fc, 0x3fe2a101e4b505d8, 0xbfefec4384be6263, 0x3fe897a1328e2f08, 0xbff0000000000000, - 0x3d04faa78b10fc89, 0xbfe9b074127b6ace, 0x3fefd2b952679ff7, 0x3fdfbdde27e11bcb, 0xbff0000000000000, 0xbd0b99ac8f136558, 0xbfed2998c5c92b9c, 0xbfdcf35fa996aad8, - 0x3f92cb36f5a505d2, 0xbff0000000000000, 0xbcfca8ff3d05a971, 0x3fd890c0748129bd, 0x3fe657f3ffb41259, 0xbfbfd54f525fcc3e, 0xbff0000000000000, 0xbd1f70d8680dbbcc, - 0xbfeffeb89eb9ed3d, 0x3fef80723e5dad64, 0xbfc8f36768b90512, 0xbff0000000000000, 0xbd146bdb4b8c1b7c, 0x3fe7bdb989640d91, 0x3fdef8fe54dec590, 0xbfd54ba53c417f9a, - 0xbff0000000000000, 0x3ceed5ea6a01afa4, 0xbfccd5b05dfefe8c, 0x3fe4a64fd456b13c, 0xbfe7d30552b27476, 0xbff0000000000000, 0xbd18d1d3640b52fd, 0x3fcb46dda507e5d0, - 0x3fe17296739dc736, 0xbfebd38bfee47e5b, 0xbff0000000000000, 0x3d2e9ddc249ee693, 0x3fb87f252dcc47ab, 0xbfe2653a15da0fba, 0xbfef98cdee3bccad, 0xbff0000000000000, - 0x3cf84f28e30d9d0b, 0x3fec7fdf74bbb846, 0x3f81e53b76142066, 0xbfefe0beb8a53796, 0xbff0000000000000, 0x3cf83e084e8b05d6, 0xbfd5b67583a74e67, 0x3fee60d924d57743, - 0xbfeff3521f6f320f, 0xbff0000000000000, 0x3d1e561aac6f12e5, 0xbfe6b03f8df65bfe, 0x3f9ba9d2b8f492fb, 0xbfeed6cfac0da265, 0xbff0000000000000, 0x3d2ea000372f3979, - 0x3fe50733fc8ca908, 0xbfe4382465bdc5fc, 0xbfeb2d0d07da1074, 0xbff0000000000000, 0x3d09659e798ba024, 0x3f645300b2210ee6, 0xbfec859a523ff229, 0x3fd8e94538ed3a0b, -] )) ), - -################ chunk 18432 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x7f76c8e5ca239029, 0x40b0000000000001, 0x40affffffffffffe, 0x40b0000000000002, 0x40affffffffffffc, 0x40c0000000000001, 0x40bffffffffffffe, 0x40c0000000000002, - 0x40bffffffffffffc, 0x40d0000000000001, 0x40cffffffffffffe, 0x40d0000000000002, 0x40cffffffffffffc, 0x40e0000000000001, 0x40dffffffffffffe, 0x40e0000000000002, - 0x40dffffffffffffc, 0x40f0000000000001, 0x40effffffffffffe, 0x40f0000000000002, 0x40effffffffffffc, 0x4100000000000001, 0x40fffffffffffffe, 0x4100000000000002, - 0x40fffffffffffffc, 0x4110000000000001, 0x410ffffffffffffe, 0x4110000000000002, 0x410ffffffffffffc, 0x4120000000000001, 0x411ffffffffffffe, 0x4120000000000002, - 0x411ffffffffffffc, 0x4130000000000001, 0x412ffffffffffffe, 0x4130000000000002, 0x412ffffffffffffc, 0x4144bd24ea0af22d, 0x4179ec6e248daeb8, 0x41b033c4d6d88d33, - 0x413594458ff7aee3, 0x416af956f3f59a9c, 0x419086a2783956a1, 0x4175f58baee1093f, 0x40a88b2f6c200000, 0x40a8d54d48547b05, 0x40b88b2f6c200000, 0x40b8d54d48547b05, - 0x40c2686391180000, 0x40c29ff9f63f5c44, 0x40c88b2f6c200000, 0x40c8d54d48547b05, 0x40ceadfb47280000, 0x40cf0aa09a6999c6, 0x40d2686391180000, 0x40d29ff9f63f5c44, - 0x40d579c97e9c0000, 0x40d5baa39f49eba4, 0x40d88b2f6c200000, 0x40d8d54d48547b05, 0x40db9c9559a40000, 0x40dbeff6f15f0a66, 0x40deadfb47280000, 0x40df0aa09a6999c6, - 0x40e0dfb09a560000, 0x40e112a521ba1493, 0x40e2686391180000, 0x40e29ff9f63f5c44, 0x40e3f11687da0000, 0x40e42d4ecac4a3f4, 0x40e579c97e9c0000, 0x40e5baa39f49eba4, - 0x40e7027c755e0000, 0x40e747f873cf3355, 0x40e88b2f6c200000, 0x40e8d54d48547b05, 0x40ea13e262e20000, 0x40ea62a21cd9c2b5, 0x40eb9c9559a40000, 0x40ebeff6f15f0a66, - 0x40ed254850660000, 0x40ed7d4bc5e45216, 0x40eeadfb47280000, 0x40ef0aa09a6999c6, 0x40f01b571ef50000, 0x40f04bfab77770bb, 0x40f0dfb09a560000, 0x40f112a521ba1493, - 0x40f1a40a15b70000, 0x40f1d94f8bfcb86c, 0x40f2686391180000, 0x40f29ff9f63f5c44, 0x40f32cbd0c790000, 0x40f366a46082001c, 0x40f3f11687da0000, 0x40f42d4ecac4a3f4, - 0x40f4b570033b0000, 0x40f4f3f9350747cc, 0x40f579c97e9c0000, 0x40f5baa39f49eba4, 0x40f63e22f9fd0000, 0x40f6814e098c8f7d, 0x40f7027c755e0000, 0x40f747f873cf3355, - 0x40f7c6d5f0bf0000, 0x40f80ea2de11d72d, 0x40f88b2f6c200000, 0x40f8d54d48547b05, 0x40f94f88e7810000, 0x40f99bf7b2971edd, 0x40fa13e262e20000, 0x40fa62a21cd9c2b5, - 0x40fad83bde430000, 0x40fb294c871c668d, 0x40fb9c9559a40000, 0x40fbeff6f15f0a66, 0x40fc60eed5050000, 0x40fcb6a15ba1ae3e, 0x40fd254850660000, 0x40fd7d4bc5e45216, - 0x40fde9a1cbc70000, 0x40fe43f63026f5ee, 0x40feadfb47280000, 0x40ff0aa09a6999c6, 0x40ff7254c2890000, 0x40ffd14b04ac3d9e, 0x41001b571ef50000, 0x41004bfab77770bb, - 0x41007d83dca58000, 0x4100af4fec98c2a7, 0x4100dfb09a560000, 0x410112a521ba1493, 0x410141dd58068000, 0x410175fa56db6680, 0x4101a40a15b70000, 0x4101d94f8bfcb86c, - 0x41020636d3678000, 0x41023ca4c11e0a58, 0x4102686391180000, 0x41029ff9f63f5c44, 0x4102ca904ec88000, 0x4103034f2b60ae30, 0x41032cbd0c790000, 0x410366a46082001c, - 0x41038ee9ca298000, 0x4103c9f995a35208, 0x4103f11687da0000, 0x41042d4ecac4a3f4, 0x41045343458a8000, 0x410490a3ffe5f5e0, 0x4104b570033b0000, 0x4104f3f9350747cc, - 0x4105179cc0eb8000, 0x4105574e6a2899b8, 0x410579c97e9c0000, 0x4105baa39f49eba4, 0x4105dbf63c4c8000, 0x41061df8d46b3d90, 0x41063e22f9fd0000, 0x4106814e098c8f7d, - 0x4106a04fb7ad8000, 0x4106e4a33eade169, 0x4107027c755e0000, 0x410747f873cf3355, 0x410764a9330e8000, 0x4107ab4da8f08541, 0x4107c6d5f0bf0000, 0x41080ea2de11d72d, - 0x41082902ae6f8000, 0x410871f813332919, 0x41088b2f6c200000, 0x4108d54d48547b05, 0x4108ed5c29d08000, 0x410938a27d75ccf1, 0x41094f88e7810000, 0x41099bf7b2971edd, - 0x4109b1b5a5318000, 0x4109ff4ce7b870c9, 0x410a13e262e20000, 0x410a62a21cd9c2b5, 0x410a760f20928000, 0x410ac5f751fb14a1, 0x410ad83bde430000, 0x410b294c871c668d, - 0x410b3a689bf38000, 0x410b8ca1bc3db87a, 0x410b9c9559a40000, 0x410beff6f15f0a66, 0x410bfec217548000, 0x410c534c26805c52, 0x410c60eed5050000, 0x410cb6a15ba1ae3e, - 0x410cc31b92b58000, 0x410d19f690c3002a, 0x410d254850660000, 0x410d7d4bc5e45216, 0x410d87750e168000, 0x410de0a0fb05a402, 0x410de9a1cbc70000, 0x410e43f63026f5ee, - 0x410e4bce89778000, 0x410ea74b654847da, 0x410eadfb47280000, 0x410f0aa09a6999c6, 0x410f102804d88000, 0x410f6df5cf8aebb2, 0x410f7254c2890000, 0x410fd14b04ac3d9e, - 0x410fd48180398000, 0x41101a501ce6c7c5, 0x41101b571ef50000, 0x41104bfab77770bb, 0x41104c6d7dcd4000, 0x41107da5520819b1, 0x41107d83dca58000, 0x4110af4fec98c2a7, - 0x4110ae9a3b7dc000, 0x4110e0fa87296b9d, 0x4110dfb09a560000, 0x411112a521ba1493, 0x411110c6f92e4000, 0x4111444fbc4abd89, 0x411141dd58068000, 0x411175fa56db6680, - 0x411172f3b6dec000, 0x4111a7a4f16c0f76, 0x4111a40a15b70000, 0x4111d94f8bfcb86c, 0x4111d520748f4000, 0x41120afa268d6162, 0x41120636d3678000, 0x41123ca4c11e0a58, - 0x4112374d323fc000, 0x41126e4f5baeb34e, 0x4112686391180000, 0x41129ff9f63f5c44, 0x41129979eff04000, 0x4112d1a490d0053a, 0x4112ca904ec88000, 0x4113034f2b60ae30, - 0x4112fba6ada0c000, 0x411334f9c5f15726, 0x41132cbd0c790000, 0x411366a46082001c, 0x41135dd36b514000, 0x4113984efb12a912, 0x41138ee9ca298000, 0x4113c9f995a35208, - 0x4113c0002901c000, 0x4113fba43033fafe, 0x4113f11687da0000, 0x41142d4ecac4a3f4, 0x4114222ce6b24000, 0x41145ef965554cea, 0x41145343458a8000, 0x411490a3ffe5f5e0, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3f9041f386ab0d8e, 0x3fe9ba4a85e6e174, 0x3fe9ba4a85e6bb65, 0x3fe9ba4a85e6f47b, 0x3fe9ba4a85e6a85e, 0x3fd2bd43d0eba6f6, 0x3fd2bd43d0eab22e, 0x3fd2bd43d0ec215a, - 0x3fd2bd43d0ea37ca, 0xbfea835a25a9a62c, 0xbfea835a25aa3584, 0xbfea835a25a95e80, 0xbfea835a25aa7d30, 0x3fd7de36a117fc3b, 0x3fd7de36a11bb25b, 0x3fd7de36a116212b, - 0x3fd7de36a11d8d6b, 0xbfe71945310a8ae2, 0xbfe719453107c635, 0xbfe71945310bed38, 0xbfe71945310663df, 0x3fa58ced662c7ccb, 0x3fa58ced65ac99d5, 0x3fa58ced666c6e46, - 0x3fa58ced656ca85a, 0xbfefe2f9378b8cc8, 0xbfefe2f9378ce549, 0xbfefe2f9378ae088, 0xbfefe2f9378d9189, 0x3fef8c1986c7b96a, 0x3fef8c1986cd168b, 0x3fef8c1986c50ada, - 0x3fef8c1986cfc51b, 0x3fee33ada9254f48, 0x3fee33ada93a7614, 0x3fee33ada91abbe1, 0x3fee33ada945097b, 0x3fefeee78e111f71, 0x3fe98c8906317f89, 0x3fef7e0b0a6c4088, - 0x3fec22656e4b15af, 0x3fd011af6244cc6a, 0x3feff694e10528b3, 0x3feffaeca000f8eb, 0x3fefffffffba912b, 0x3fe9a6bd73fd4b47, 0x3feffffffeea44ad, 0x3fd23fb35cc33541, - 0x3feffffffd8f1a84, 0xbfd60bc5ad6595f8, 0x3feffffffba912b2, 0xbfeacbebb4bce650, 0x3feffffff9382d37, 0xbfefeffe6c39a05d, 0x3feffffff63c6a12, 0xbfe867e5ee73fcaa, - 0x3feffffff2b5c943, 0xbfccc2bf1879bfa5, 0x3fefffffeea44acb, 0x3fd9c1ca0c00f5fe, 0x3fefffffea07eeaa, 0x3febd64b658b31ea, 0x3fefffffe4e0b4df, 0x3fefc009b40e3602, - 0x3fefffffdf2e9d6b, 0x3fe710a41b143da1, 0x3fefffffd8f1a84d, 0x3fc4e951e2894bb9, 0x3fefffffd229d587, 0xbfdd5e0a168febe6, 0x3fefffffcad72518, 0xbfecc4d20c75a005, - 0x3fefffffc2f99700, 0xbfef7051d0f03aa9, 0x3fefffffba912b3f, 0xbfe5a24f5d88fe3e, 0x3fefffffb19de1d6, 0xbfb9f5f295f4b6df, 0x3fefffffa81fbac5, 0x3fe06e7498f55e6c, - 0x3fefffff9e16b60b, 0x3fed96910b510e68, 0x3fefffff9382d3a9, 0x3fef0126829e48d3, 0x3fefffff8864139f, 0x3fe41e562eab10af, 0x3fefffff7cba75ee, 0x3fa3fe91ca384f68, - 0x3fefffff7085fa95, 0xbfe21d74136007d7, 0x3fefffff63c6a195, 0xbfee4ab68e71fd1c, 0x3fefffff567c6aee, 0xbfee72f6ff5c9668, 0x3fefffff48a756a0, 0xbfe2863cade9b45e, - 0x3fefffff3a4764ab, 0x3f980584438de084, 0x3fefffff2b5c9511, 0x3fe3ba54509278fd, 0x3fefffff1be6e7d0, 0x3feee08e5e932130, 0x3fefffff0be65ce9, 0x3fedc65184b264ad, - 0x3feffffefb5af45c, 0x3fe0db9b1cffb356, 0x3feffffeea44ae2b, 0xbfb5fc090e4505ae, 0x3feffffed8a38a54, 0xbfe543784798f80a, 0x3feffffec67788d9, 0xbfef5782951f5382, - 0x3feffffeb3c0a9b9, 0xbfecfbe2c91e690a, 0x3feffffea07eecf5, 0xbfde40388f18cb74, 0x3feffffe8cb2528d, 0x3fc2f0596be5d162, 0x3feffffe785ada82, 0x3fe6b756adbce12d, - 0x3feffffe637884d4, 0x3fefaf1c32253068, 0x3feffffe4e0b5184, 0x3fec14754f525e95, 0x3feffffe38134091, 0x3fdaaaf7b036e391, 0x3feffffe219051fc, 0xbfcacfbc19547a50, - 0x3feffffe0a8285c5, 0xbfe8147b7ff0ee2b, 0x3feffffdf2e9dbed, 0xbfefe7039365b55c, 0x3feffffddac65474, 0xbfeb10f09b98b12d, 0x3feffffdc217ef5b, 0xbfd6fb0938af3272, - 0x3feffffda8deaca2, 0x3fd14a2632fec112, 0x3feffffd8f1a8c4a, 0x3fe9598976f40123, 0x3feffffd74cb8e52, 0x3fefff00cbfc613e, 0x3feffffd59f1b2bc, 0x3fe9f2584c3717ae, - 0x3feffffd3e8cf987, 0x3fd3341d73f785bc, 0x3feffffd229d62b5, 0xbfd51b227ed5ffca, 0x3feffffd0622ee45, 0xbfea853b64c91a8e, 0x3feffffce91d9c39, 0xbfeff6fbdc5399b3, - 0x3feffffccb8d6c90, 0xbfe8b9cb15bf5e14, 0x3feffffcad725f4c, 0xbfceb3f75a5a0e4e, 0x3feffffc8ecc746c, 0x3fd8d701938d260e, 0x3feffffc6f9babf2, 0x3feb966579f2a4f8, - 0x3feffffc4fe005dd, 0x3fefcefcca25873e, 0x3feffffc2f99822f, 0x3fe76881a43a400a, 0x3feffffc0ec820e7, 0x3fc6e0fccea8b647, 0x3feffffbed6be207, 0xbfdc7a0733cdfef2, - 0x3feffffbcb84c58f, 0xbfec8bf671722a6a, 0x3feffffba912cb7f, 0xbfef872b987510cb, 0x3feffffb8615f3d9, 0xbfe5ffcd6253c018, 0x3feffffb628e3e9c, 0xbfbdee3e09750482, - 0x3feffffb3e7babca, 0x3fe00047ff1fcc6f, 0x3feffffb19de3b62, 0x3fed64f8a218d4ef, 0x3feffffaf4b5ed66, 0x3fef1fd01f8876c2, 0x3feffffacf02c1d7, 0x3fe4811727df053f, - 0x3feffffaa8c4b8b4, 0x3fabf92288b6393e, 0x3feffffa81fbd1fe, 0xbfe1b38a88889401, 0x3feffffa5aa80db7, 0xbfee2092f45039b5, 0x3feffffa32c96bde, 0xbfee9951c50a2372, - 0x3feffffa0a5fec75, 0xbfe2edddd0d3d6f9, 0x3feffff9e16b8f7c, 0x3f8018cb98cfb9a8, 0x3feffff9b7ec54f4, 0x3fe35517c8b6864f, 0x3feffff98de23cde, 0x3feebe09bb4ab937, - 0x3feffff9634d473a, 0x3fedf43714948e65, 0x3feffff9382d7409, 0x3fe147b4be42b295, 0x3feffff90c82c34b, 0xbfb200c0de54eaa8, 0x3feffff8e04d3502, 0xbfe4e34e093cad75, - 0x3feffff8b38cc92e, 0xbfef3cbf70ba0350, 0x3feffff886417fd0, 0xbfed3125391fab53, 0x3feffff8586b58e9, 0xbfdf208485bdb4ec, 0x3feffff82a0a547a, 0x3fc0f632e12f9fb2, - 0x3feffff7fb1e7283, 0x3fe65c9eec994152, 0x3feffff7cba7b304, 0x3fef9c35526b042f, 0x3feffff79ba61600, 0x3fec50df57c1b498, 0x3feffff76b199b77, 0x3fdb927bf8f99253, - 0x3feffff73a024369, 0xbfc8db0d7428af50, 0x3feffff708600dd7, 0xbfe7bf90fcb19afa, 0x3feffff6d632fac3, 0xbfefdc0be11241e8, 0x3feffff6a37b0a2c, 0xbfeb5445cc7bef99, - 0x3feffff670383c15, 0xbfd7e8de385ee5c9, 0x3feffff63c6a907d, 0x3fd053854345cd43, 0x3feffff608120766, 0x3fe90ac1248353ee, 0x3feffff5d32ea0d1, 0x3feffc033fd80f93, - 0x3feffff59dc05cbe, 0x3fea3c5549b8575f, 0x3feffff567c73b2e, 0x3fd427553e29e8ac, 0x3feffff531433c23, 0xbfd4292eab31ccdf, 0x3feffff4fa345f9d, 0xbfea3ce4133b0874, - 0x3feffff4c29aa59d, 0xbfeffbfb7435b58b, 0x3feffff48a760e24, 0xbfe90a25db95f3d5, 0x3feffff451c69933, 0xbfd051a2f21e112a, 0x3feffff4188c46cb, 0x3fd7eaace7ab3ed8, -] )) ), - -################ chunk 18944 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x41148459a462c000, 0x4114c24e9a769ed6, 0x4114b570033b0000, 0x4114f3f9350747cc, 0x4114e68662134000, 0x411525a3cf97f0c2, 0x4115179cc0eb8000, 0x4115574e6a2899b8, - 0x411548b31fc3c000, 0x411588f904b942ae, 0x411579c97e9c0000, 0x4115baa39f49eba4, 0x4115aadfdd744000, 0x4115ec4e39da949a, 0x4115dbf63c4c8000, 0x41161df8d46b3d90, - 0x41160d0c9b24c000, 0x41164fa36efbe687, 0x41163e22f9fd0000, 0x4116814e098c8f7d, 0x41166f3958d54000, 0x4116b2f8a41d3873, 0x4116a04fb7ad8000, 0x4116e4a33eade169, - 0x4116d1661685c000, 0x4117164dd93e8a5f, 0x4117027c755e0000, 0x411747f873cf3355, 0x41173392d4364000, 0x411779a30e5fdc4b, 0x411764a9330e8000, 0x4117ab4da8f08541, - 0x411795bf91e6c000, 0x4117dcf843812e37, 0x4117c6d5f0bf0000, 0x41180ea2de11d72d, 0x4117f7ec4f974000, 0x4118404d78a28023, 0x41182902ae6f8000, 0x411871f813332919, - 0x41185a190d47c000, 0x4118a3a2adc3d20f, 0x41188b2f6c200000, 0x4118d54d48547b05, 0x4118bc45caf84000, 0x411906f7e2e523fb, 0x4118ed5c29d08000, 0x411938a27d75ccf1, - 0x41191e7288a8c000, 0x41196a4d180675e7, 0x41194f88e7810000, 0x41199bf7b2971edd, 0x4119809f46594000, 0x4119cda24d27c7d3, 0x4119b1b5a5318000, 0x4119ff4ce7b870c9, - 0x4119e2cc0409c000, 0x411a30f7824919bf, 0x411a13e262e20000, 0x411a62a21cd9c2b5, 0x411a44f8c1ba4000, 0x411a944cb76a6bab, 0x411a760f20928000, 0x411ac5f751fb14a1, - 0x411aa7257f6ac000, 0x411af7a1ec8bbd97, 0x411ad83bde430000, 0x411b294c871c668d, 0x411b09523d1b4000, 0x411b5af721ad0f84, 0x411b3a689bf38000, 0x411b8ca1bc3db87a, - 0x411b6b7efacbc000, 0x411bbe4c56ce6170, 0x411b9c9559a40000, 0x411beff6f15f0a66, 0x411bcdabb87c4000, 0x411c21a18befb35c, 0x411bfec217548000, 0x411c534c26805c52, - 0x411c2fd8762cc000, 0x411c84f6c1110548, 0x411c60eed5050000, 0x411cb6a15ba1ae3e, 0x411c920533dd4000, 0x411ce84bf6325734, 0x411cc31b92b58000, 0x411d19f690c3002a, - 0x411cf431f18dc000, 0x411d4ba12b53a920, 0x411d254850660000, 0x411d7d4bc5e45216, 0x411d565eaf3e4000, 0x411daef66074fb0c, 0x411d87750e168000, 0x411de0a0fb05a402, - 0x411db88b6ceec000, 0x411e124b95964cf8, 0x411de9a1cbc70000, 0x411e43f63026f5ee, 0x411e1ab82a9f4000, 0x411e75a0cab79ee4, 0x411e4bce89778000, 0x411ea74b654847da, - 0x411e7ce4e84fc000, 0x411ed8f5ffd8f0d0, 0x411eadfb47280000, 0x411f0aa09a6999c6, 0x411edf11a6004000, 0x411f3c4b34fa42bc, 0x411f102804d88000, 0x411f6df5cf8aebb2, - 0x411f413e63b0c000, 0x411f9fa06a1b94a8, 0x411f7254c2890000, 0x411fd14b04ac3d9e, 0x411fa36b21614000, 0x4120017acf9e734a, 0x411fd48180398000, 0x41201a501ce6c7c5, - 0x412002cbef88e000, 0x412033256a2f1c40, 0x41201b571ef50000, 0x41204bfab77770bb, 0x412033e24e612000, 0x412064d004bfc536, 0x41204c6d7dcd4000, 0x41207da5520819b1, - 0x412064f8ad396000, 0x4120967a9f506e2c, 0x41207d83dca58000, 0x4120af4fec98c2a7, 0x4120960f0c11a000, 0x4120c82539e11722, 0x4120ae9a3b7dc000, 0x4120e0fa87296b9d, - 0x4120c7256ae9e000, 0x4120f9cfd471c018, 0x4120dfb09a560000, 0x412112a521ba1493, 0x4120f83bc9c22000, 0x41212b7a6f02690e, 0x412110c6f92e4000, 0x4121444fbc4abd89, - 0x41212952289a6000, 0x41215d2509931205, 0x412141dd58068000, 0x412175fa56db6680, 0x41215a688772a000, 0x41218ecfa423bafb, 0x412172f3b6dec000, 0x4121a7a4f16c0f76, - 0x41218b7ee64ae000, 0x4121c07a3eb463f1, 0x4121a40a15b70000, 0x4121d94f8bfcb86c, 0x4121bc9545232000, 0x4121f224d9450ce7, 0x4121d520748f4000, 0x41220afa268d6162, - 0x4121edaba3fb6000, 0x412223cf73d5b5dd, 0x41220636d3678000, 0x41223ca4c11e0a58, 0x41221ec202d3a000, 0x4122557a0e665ed3, 0x4122374d323fc000, 0x41226e4f5baeb34e, - 0x41224fd861abe000, 0x41228724a8f707c9, 0x4122686391180000, 0x41229ff9f63f5c44, 0x412280eec0842000, 0x4122b8cf4387b0bf, 0x41229979eff04000, 0x4122d1a490d0053a, - 0x4122b2051f5c6000, 0x4122ea79de1859b5, 0x4122ca904ec88000, 0x4123034f2b60ae30, 0x4122e31b7e34a000, 0x41231c2478a902ab, 0x4122fba6ada0c000, 0x412334f9c5f15726, - 0x41231431dd0ce000, 0x41234dcf1339aba1, 0x41232cbd0c790000, 0x412366a46082001c, 0x412345483be52000, 0x41237f79adca5497, 0x41235dd36b514000, 0x4123984efb12a912, - 0x4123765e9abd6000, 0x4123b124485afd8d, 0x41238ee9ca298000, 0x4123c9f995a35208, 0x4123a774f995a000, 0x4123e2cee2eba683, 0x4123c0002901c000, 0x4123fba43033fafe, - 0x4123d88b586de000, 0x412414797d7c4f79, 0x4123f11687da0000, 0x41242d4ecac4a3f4, 0x412409a1b7462000, 0x41244624180cf86f, 0x4124222ce6b24000, 0x41245ef965554cea, - 0x41243ab8161e6000, 0x412477ceb29da165, 0x41245343458a8000, 0x412490a3ffe5f5e0, 0x41246bce74f6a000, 0x4124a9794d2e4a5b, 0x41248459a462c000, 0x4124c24e9a769ed6, - 0x41249ce4d3cee000, 0x4124db23e7bef351, 0x4124b570033b0000, 0x4124f3f9350747cc, 0x4124cdfb32a72000, 0x41250cce824f9c47, 0x4124e68662134000, 0x412525a3cf97f0c2, - 0x4124ff11917f6000, 0x41253e791ce0453d, 0x4125179cc0eb8000, 0x4125574e6a2899b8, 0x41253027f057a000, 0x41257023b770ee33, 0x412548b31fc3c000, 0x412588f904b942ae, - 0x4125613e4f2fe000, 0x4125a1ce52019729, 0x412579c97e9c0000, 0x4125baa39f49eba4, 0x41259254ae082000, 0x4125d378ec92401f, 0x4125aadfdd744000, 0x4125ec4e39da949a, - 0x4125c36b0ce06000, 0x412605238722e915, 0x4125dbf63c4c8000, 0x41261df8d46b3d90, 0x4125f4816bb8a000, 0x412636ce21b3920b, 0x41260d0c9b24c000, 0x41264fa36efbe687, - 0x41262597ca90e000, 0x41266878bc443b02, 0x41263e22f9fd0000, 0x4126814e098c8f7d, 0x412656ae29692000, 0x41269a2356d4e3f8, 0x41266f3958d54000, 0x4126b2f8a41d3873, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3feffff3dec716ed, 0x3feb54c787bc5b9b, 0x3feffff3a477099a, 0x3fefdbf485f79ae3, 0x3feffff3699c1ed3, 0x3fe7bee9cfb1c801, 0x3feffff32e365699, 0x3fc8d73ace9aee41, - 0x3feffff2f245b0ed, 0xbfdb943e1bad779a, 0x3feffff2b5ca2dcf, 0xbfec515382fb8b3c, 0x3feffff278c3cd42, 0xbfef9c0e7f34398b, 0x3feffff23b328f46, 0xbfe65bec82bebd2d, - 0x3feffff1fd1673dc, 0xbfc0f2560b699cbd, 0x3feffff1be6f7b04, 0x3fdf2238598a1329, 0x3feffff17f3da4c1, 0x3fed318b6014cf06, 0x3feffff13f80f114, 0x3fef3c894c409c02, - 0x3feffff0ff395ffc, 0x3fe4e291150e5571, 0x3feffff0be66f17c, 0x3fb1f8fa8cc6e0fc, 0x3feffff07d09a595, 0xbfe14886a6b5bca2, 0x3feffff03b217c47, 0xbfedf48ed117b1ea, - 0x3fefffeff8ae7594, 0xbfeebdc47bb7460e, 0x3fefffefb5b0917c, 0xbfe3545107357011, 0x3fefffef7227d002, 0xbf7fb4e429fab66c, 0x3fefffef2e143126, 0x3fe2eea6e5d697b0, - 0x3fefffeee975b4e9, 0x3fee999abf561d8a, 0x3fefffeea44c5b4c, 0x3fee203edee921b0, 0x3fefffee5e982452, 0x3fe1b2bac089d86c, 0x3fefffee18590ffa, 0xbfac08b30f990383, - 0x3fefffedd18f1e46, 0xbfe481d6a04bb98b, 0x3fefffed8a3a4f37, 0xbfef200a0e9cb7b4, 0x3fefffed425aa2ce, 0xbfed64960afa345a, 0x3fefffecf9f0190e, 0xbfdffee000f8de06, - 0x3fefffecb0fab1f6, 0x3fbdf5fb96f574bb, 0x3fefffec677a6d88, 0x3fe600827e9be1b3, 0x3fefffec1d6f4bc5, 0x3fef8756425ba2a3, 0x3fefffebd2d94caf, 0x3fec8b85bb3e3116, - 0x3fefffeb87b87047, 0x3fdc7848796c86ef, 0x3fefffeb3c0cb68e, 0xbfc6e4d25b380ea4, 0x3fefffeaefd61f86, 0xbfe7692baf2a381d, 0x3fefffeaa314ab2f, 0xbfefcf18042f6f4e, - 0x3fefffea55c8598b, 0xbfeb95e7156eb13b, 0x3fefffea07f12a9c, 0xbfd8d535dafebb99, 0x3fefffe9b98f1e62, 0x3fceb7bfd6bbad10, 0x3fefffe96aa234df, 0x3fe8ba696543d297, - 0x3fefffe91b2a6e14, 0x3feff7078b45ad38, 0x3fefffe8cb27ca03, 0x3fea84afd0604b54, 0x3fefffe87a9a48ae, 0x3fd5194b93f9587c, 0x3fefffe82981ea14, 0xbfd335f945ab6a1a, - 0x3fefffe7d7deae38, 0xbfe9f2ea41ee2edd, 0x3fefffe785b0951b, 0xbfeffefce4261776, 0x3fefffe732f79ebf, 0xbfe958f13e4a888c, 0x3fefffe6dfb3cb25, 0xbfd14845eced259f, - 0x3fefffe68be51a4e, 0x3fd6fcdac1e59028, 0x3fefffe6378b8c3c, 0x3feb1175a57e5081, 0x3fefffe5e2a720f0, 0x3fefe6f018aef736, 0x3fefffe58d37d86c, 0x3fe813d73b4bd4bc, - 0x3fefffe5373db2b0, 0x3fcacbec97a2898a, 0x3fefffe4e0b8afc0, 0xbfdaacbd1f3fe5bf, 0x3fefffe489a8cf9b, 0xbfec14ece8516e2a, 0x3fefffe4320e1244, 0xbfefaef9380ab030, - 0x3fefffe3d9e877bb, 0xbfe6b6a701736e65, 0x3fefffe381380004, 0xbfc2ec7ec4966a36, 0x3fefffe327fcab1e, 0x3fde41f01e513ed8, 0x3fefffe2ce36790b, 0x3fecfc4c7990d660, - 0x3fefffe273e569ce, 0x3fef57503e9e3716, 0x3fefffe219097d67, 0x3fe542bde3674806, 0x3fefffe1bda2b3d8, 0x3fb5f4452a6c7ec6, 0x3fefffe161b10d23, 0xbfe0dc6f18d81240, - 0x3fefffe105348949, 0xbfedc6ace2dc5ca0, 0x3fefffe0a82d284b, 0xbfeee04cde0727c6, 0x3fefffe04a9aea2c, 0xbfe3b98feeeef2ab, 0x3fefffdfec7dceed, 0xbf97e65971e36e1d, - 0x3fefffdf8dd5d690, 0x3fe2870809ed58d1, 0x3fefffdf2ea30115, 0x3fee7343afd78ab4, 0x3fefffdecee54e7f, 0x3fee4a66256182a4, 0x3fefffde6e9cbed0, 0x3fe21ca678c1293b, - 0x3fefffde0dc95208, 0xbfa40e253c3fe487, 0x3fefffddac6b082a, 0xbfe41f181f5d5517, 0x3fefffdd4a81e138, 0xbfef016438adfd10, 0x3fefffdce80ddd32, 0xbfed96320a32ec84, - 0x3fefffdc850efc1b, 0xbfe06d9e93160eb0, 0x3fefffdc21853df4, 0x3fb9fdb3898c0fc0, 0x3fefffdbbd70a2bf, 0x3fe5a30720f238d6, 0x3fefffdb58d12a7e, 0x3fef70804edd074e, - 0x3fefffdaf3a6d532, 0x3fecc464d24eee65, 0x3fefffda8df1a2dd, 0x3fdd5c4ee06bb7b4, 0x3fefffda27b19381, 0xbfc4ed2a18c31099, 0x3fefffd9c0e6a720, 0xbfe71150f95f8391, - 0x3fefffd95990ddba, 0xbfefc028cb55997e, 0x3fefffd8f1b03753, 0xbfebd5d05fa12071, 0x3fefffd88944b3ec, 0xbfd9c00166d9b1c5, 0x3fefffd8204e5386, 0x3fccc68b328e2e93, - 0x3fefffd7b6cd1623, 0x3fe868873ab1247d, 0x3fefffd74cc0fbc6, 0x3feff00dfdc0fb35, 0x3fefffd6e22a0470, 0x3feacb635e20fae4, 0x3fefffd677083022, 0x3fd609f1620d463d, - 0x3fefffd60b5b7edf, 0xbfd24191757c7e1a, 0x3fefffd59f23f0a8, 0xbfe9a7528cd08225, 0x3fefffd53261857f, 0xbfeffffffc341213, 0x3fefffd4c5143d67, 0xbfe9a62855138045, - 0x3fefffd4573c1860, 0xbfd23dd53fb2fdc7, 0x3fefffd3e8d9166d, 0x3fd60d99f38674c6, 0x3fefffd379eb3790, 0x3feacc7404fe69a5, 0x3fefffd30a727bca, 0x3fefefeed31e05fc, - 0x3fefffd29a6ee31d, 0x3fe867449c69b24d, 0x3fefffd229e06d8c, 0x3fccbef2f782a318, 0x3fefffd1b8c71b19, 0xbfd9c392ab14c224, 0x3fefffd14722ebc4, 0xbfebd6c664dd3e04, - 0x3fefffd0d4f3df90, 0xbfefbfea953d6485, 0x3fefffd06239f67f, 0xbfe70ff7374bb61a, 0x3fefffcfeef53094, 0xbfc4e579a739ae59, 0x3fefffcf7b258dcf, 0x3fdd5fc545ca67b1, - 0x3fefffcf06cb0e33, 0x3fecc53f3fcc3e1b, 0x3fefffce91e5b1c1, 0x3fef70234b8bccc1, 0x3fefffce1c75787d, 0x3fe5a19794f6396e, 0x3fefffcda67a6267, 0x3fb9ee319be4c795, - 0x3fefffcd2ff46f83, 0xbfe06f4a9af8d6a0, 0x3fefffccb8e39fd1, 0xbfed96f0056e68d3, 0x3fefffcc4147f353, 0xbfef00e8c530396e, 0x3fefffcbc9216a0d, 0xbfe41d9439295b21, - 0x3fefffcb50700400, 0xbfa3eefe52b24d44, 0x3fefffcad733c12d, 0x3fe21e41a9b27d56, 0x3fefffca5d6ca198, 0x3fee4b06f0525e82, 0x3fefffc9e31aa541, 0x3fee72aa47a7fbec, - 0x3fefffc9683dcc2c, 0x3fe285714d80c9a9, 0x3fefffc8ecd6165a, 0xbf9824af0f851e8c, 0x3fefffc870e383cd, 0xbfe3bb18ad879dc8, 0x3fefffc7f4661487, 0xbfeee0cfd7c84d11, - 0x3fefffc7775dc88b, 0xbfedc5f61f7c2417, 0x3fefffc6f9ca9fdb, 0xbfe0dac71d317d8d, 0x3fefffc67bac9a78, 0x3fb603ccec867110, 0x3fefffc5fd03b866, 0x3fe54432a6b60594, -] )) ), - -################ chunk 19456 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x412687c488416000, 0x4126cbcdf1658cee, 0x4126a04fb7ad8000, 0x4126e4a33eade169, 0x4126b8dae719a000, 0x4126fd788bf635e4, 0x4126d1661685c000, 0x4127164dd93e8a5f, - 0x4126e9f145f1e000, 0x41272f232686deda, 0x4127027c755e0000, 0x412747f873cf3355, 0x41271b07a4ca2000, 0x412760cdc11787d0, 0x41273392d4364000, 0x412779a30e5fdc4b, - 0x41274c1e03a26000, 0x412792785ba830c6, 0x412764a9330e8000, 0x4127ab4da8f08541, 0x41277d34627aa000, 0x4127c422f638d9bc, 0x412795bf91e6c000, 0x4127dcf843812e37, - 0x4127ae4ac152e000, 0x4127f5cd90c982b2, 0x4127c6d5f0bf0000, 0x41280ea2de11d72d, 0x4127df61202b2000, 0x412827782b5a2ba8, 0x4127f7ec4f974000, 0x4128404d78a28023, - 0x412810777f036000, 0x41285922c5ead49e, 0x41282902ae6f8000, 0x412871f813332919, 0x4128418ddddba000, 0x41288acd607b7d94, 0x41285a190d47c000, 0x4128a3a2adc3d20f, - 0x412872a43cb3e000, 0x4128bc77fb0c268a, 0x41288b2f6c200000, 0x4128d54d48547b05, 0x4128a3ba9b8c2000, 0x4128ee22959ccf80, 0x4128bc45caf84000, 0x412906f7e2e523fb, - 0x4128d4d0fa646000, 0x41291fcd302d7876, 0x4128ed5c29d08000, 0x412938a27d75ccf1, 0x412905e7593ca000, 0x41295177cabe216c, 0x41291e7288a8c000, 0x41296a4d180675e7, - 0x412936fdb814e000, 0x41298322654eca62, 0x41294f88e7810000, 0x41299bf7b2971edd, 0x4129681416ed2000, 0x4129b4ccffdf7358, 0x4129809f46594000, 0x4129cda24d27c7d3, - 0x4129992a75c56000, 0x4129e6779a701c4e, 0x4129b1b5a5318000, 0x4129ff4ce7b870c9, 0x4129ca40d49da000, 0x412a18223500c544, 0x4129e2cc0409c000, 0x412a30f7824919bf, - 0x4129fb573375e000, 0x412a49cccf916e3a, 0x412a13e262e20000, 0x412a62a21cd9c2b5, 0x412a2c6d924e2000, 0x412a7b776a221730, 0x412a44f8c1ba4000, 0x412a944cb76a6bab, - 0x412a5d83f1266000, 0x412aad2204b2c026, 0x412a760f20928000, 0x412ac5f751fb14a1, 0x412a8e9a4ffea000, 0x412adecc9f43691c, 0x412aa7257f6ac000, 0x412af7a1ec8bbd97, - 0x412abfb0aed6e000, 0x412b107739d41212, 0x412ad83bde430000, 0x412b294c871c668d, 0x412af0c70daf2000, 0x412b4221d464bb09, 0x412b09523d1b4000, 0x412b5af721ad0f84, - 0x412b21dd6c876000, 0x412b73cc6ef563ff, 0x412b3a689bf38000, 0x412b8ca1bc3db87a, 0x412b52f3cb5fa000, 0x412ba57709860cf5, 0x412b6b7efacbc000, 0x412bbe4c56ce6170, - 0x412b840a2a37e000, 0x412bd721a416b5eb, 0x412b9c9559a40000, 0x412beff6f15f0a66, 0x412bb52089102000, 0x412c08cc3ea75ee1, 0x412bcdabb87c4000, 0x412c21a18befb35c, - 0x412be636e7e86000, 0x412c3a76d93807d7, 0x412bfec217548000, 0x412c534c26805c52, 0x412c174d46c0a000, 0x412c6c2173c8b0cd, 0x412c2fd8762cc000, 0x412c84f6c1110548, - 0x412c4863a598e000, 0x412c9dcc0e5959c3, 0x412c60eed5050000, 0x412cb6a15ba1ae3e, 0x412c797a04712000, 0x412ccf76a8ea02b9, 0x412c920533dd4000, 0x412ce84bf6325734, - 0x412caa9063496000, 0x412d0121437aabaf, 0x412cc31b92b58000, 0x412d19f690c3002a, 0x412cdba6c221a000, 0x412d32cbde0b54a5, 0x412cf431f18dc000, 0x412d4ba12b53a920, - 0x412d0cbd20f9e000, 0x412d6476789bfd9b, 0x412d254850660000, 0x412d7d4bc5e45216, 0x412d3dd37fd22000, 0x412d9621132ca691, 0x412d565eaf3e4000, 0x412daef66074fb0c, - 0x412d6ee9deaa6000, 0x412dc7cbadbd4f87, 0x412d87750e168000, 0x412de0a0fb05a402, 0x412da0003d82a000, 0x412df976484df87d, 0x412db88b6ceec000, 0x412e124b95964cf8, - 0x412dd1169c5ae000, 0x412e2b20e2dea173, 0x412de9a1cbc70000, 0x412e43f63026f5ee, 0x412e022cfb332000, 0x412e5ccb7d6f4a69, 0x412e1ab82a9f4000, 0x412e75a0cab79ee4, - 0x412e33435a0b6000, 0x412e8e7617fff35f, 0x412e4bce89778000, 0x412ea74b654847da, 0x412e6459b8e3a000, 0x412ec020b2909c55, 0x412e7ce4e84fc000, 0x412ed8f5ffd8f0d0, - 0x412e957017bbe000, 0x412ef1cb4d21454b, 0x412eadfb47280000, 0x412f0aa09a6999c6, 0x412ec68676942000, 0x412f2375e7b1ee41, 0x412edf11a6004000, 0x412f3c4b34fa42bc, - 0x412ef79cd56c6000, 0x412f552082429737, 0x412f102804d88000, 0x412f6df5cf8aebb2, 0x412f28b33444a000, 0x412f86cb1cd3402d, 0x412f413e63b0c000, 0x412f9fa06a1b94a8, - 0x412f59c9931ce000, 0x412fb875b763e923, 0x412f7254c2890000, 0x412fd14b04ac3d9e, 0x412f8adff1f52000, 0x412fea2051f49219, 0x412fa36b21614000, 0x4130017acf9e734a, - 0x412fbbf650cd6000, 0x41300de576429d88, 0x412fd48180398000, 0x41301a501ce6c7c5, 0x412fed0cafa5a000, 0x413026bac38af203, 0x413002cbef88e000, 0x413033256a2f1c40, - 0x41300f11873ef000, 0x41303f9010d3467e, 0x41301b571ef50000, 0x41304bfab77770bb, 0x4130279cb6ab1000, 0x413058655e1b9af9, 0x413033e24e612000, 0x413064d004bfc536, - 0x41304027e6173000, 0x4130713aab63ef74, 0x41304c6d7dcd4000, 0x41307da5520819b1, 0x413058b315835000, 0x41308a0ff8ac43ef, 0x413064f8ad396000, 0x4130967a9f506e2c, - 0x4130713e44ef7000, 0x4130a2e545f4986a, 0x41307d83dca58000, 0x4130af4fec98c2a7, 0x413089c9745b9000, 0x4130bbba933cece5, 0x4130960f0c11a000, 0x4130c82539e11722, - 0x4130a254a3c7b000, 0x4130d48fe0854160, 0x4130ae9a3b7dc000, 0x4130e0fa87296b9d, 0x4130badfd333d000, 0x4130ed652dcd95db, 0x4130c7256ae9e000, 0x4130f9cfd471c018, - 0x4130d36b029ff000, 0x4131063a7b15ea56, 0x4130dfb09a560000, 0x413112a521ba1493, 0x4130ebf6320c1000, 0x41311f0fc85e3ed1, 0x4130f83bc9c22000, 0x41312b7a6f02690e, - 0x4131048161783000, 0x413137e515a6934c, 0x413110c6f92e4000, 0x4131444fbc4abd89, 0x41311d0c90e45000, 0x413150ba62eee7c7, 0x41312952289a6000, 0x41315d2509931205, - 0x41313597c0507000, 0x4131698fb0373c42, 0x413141dd58068000, 0x413175fa56db6680, 0x41314e22efbc9000, 0x41318264fd7f90bd, 0x41315a688772a000, 0x41318ecfa423bafb, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3fefffc57dcff9a5, 0x3fef57b4e42e2340, 0x3fefffc4fe115e39, 0x3fecfb7911d06c58, 0x3fefffc47dc7e623, 0x3fde3e80f8c0d65d, 0x3fefffc3fcf39165, 0xbfc2f4340e971ee4, - 0x3fefffc37b946002, 0xbfe6b806549cc957, 0x3fefffc2f9aa51fd, 0xbfefaf3f24b9e762, 0x3fefffc277356756, 0xbfec13fdafad6a10, 0x3fefffc1f435a010, 0xbfdaa9323ae878b3, - 0x3fefffc170aafc2f, 0x3fcad38b948a7337, 0x3fefffc0ec957bb3, 0x3fe8151fbeda01b3, 0x3fefffc067f51e9e, 0x3fefe7170689e59d, 0x3fefffbfe2c9e4f5, 0x3feb106b8b46eb54, - 0x3fefffbf5d13ceb7, 0x3fd6f937aa04dc41, 0x3fefffbed6d2dbe9, 0xbfd14c0674f6177c, 0x3fefffbe50070c8c, 0xbfe95a21a99996fe, 0x3fefffbdc8b060a2, 0xbfefff04ac3b0bb9, - 0x3fefffbd40ced82d, 0xbfe9f1c65057db5a, 0x3fefffbcb8627331, 0xbfd332419db51912, 0x3fefffbc2f6b31af, 0x3fd51cf964b08e7f, 0x3fefffbba5e913a9, 0x3fea85c6f2e6e9e4, - 0x3fefffbb1bdc1922, 0x3feff6f025cbce03, 0x3fefffba9144421d, 0x3fe8b92cc05cee8d, 0x3fefffba06218e9b, 0x3fceb02ed6af5d47, 0x3fefffb97a73fe9f, 0xbfd8d8cd4636a6f2, - 0x3fefffb8ee3b922c, 0xbfeb96e3d7eed50f, 0x3fefffb861784943, 0xbfefcee1888e84ee, 0x3fefffb7d42a23e7, 0xbfe767d793b6e140, 0x3fefffb74651221b, 0xbfc6dd273cab9397, - 0x3fefffb6b7ed43e1, 0x3fdc7bc5e76da1b2, 0x3fefffb628fe893b, 0x3fec8c6720e00d0b, 0x3fefffb59984f22b, 0x3fef8700e7134eba, 0x3fefffb509807eb5, 0x3fe5ff1840d3432e, - 0x3fefffb478f12edb, 0x3fbde68074da6ca6, 0x3fefffb3e7d7029e, 0xbfe0011ff9f72aba, 0x3fefffb35631fa02, 0xbfed655b323de07e, 0x3fefffb2c4021509, 0xbfef1f9629118c17, - 0x3fefffb2314753b6, 0xbfe48057aa94c5b6, 0x3fefffb19e01b60a, 0xbfabe991fab0605a, 0x3fefffb10a313c09, 0x3fe1b45a4c5ab274, 0x3fefffb075d5e5b5, 0x3fee20e70293eafd, - 0x3fefffafe0efb310, 0x3fee9908c3791228, 0x3fefffaf4b7ea41e, 0x3fe2ed14b74cc5da, 0x3fefffaeb582b8df, 0xbf8057251ad043cc, 0x3fefffae1efbf158, 0xbfe355de85a7a0da, - 0x3fefffad87ea4d8b, 0xbfeebe4ef394ee92, 0x3fefffacf04dcd79, 0xbfedf3df50f307d9, 0x3fefffac58267127, 0xbfe146e2d1bcb3c4, 0x3fefffabbf743896, 0x3fb208872b5d8399, - 0x3fefffab263723c8, 0x3fe4e40af8701cf1, 0x3fefffaa8c6f32c2, 0x3fef3cf58dc8273c, 0x3fefffa9f21c6584, 0x3fed30bf0b40862d, 0x3fefffa9573ebc12, 0x3fdf1ed0aa9c7d8c, - 0x3fefffa8bbd6366e, 0xbfc0fa0fb2cf919c, 0x3fefffa81fe2d49c, 0xbfe65d515119f219, 0x3fefffa78364969d, 0xbfef9c5c1e1f237d, 0x3fefffa6e65b7c74, 0xbfec506b25d740ff, - 0x3fefffa648c78624, 0xbfdb90b9cfbac946, 0x3fefffa5aaa8b3b0, 0x3fc8dee013d09101, 0x3fefffa50bff051b, 0x3fe7c038240ed31f, 0x3fefffa46cca7a66, 0x3fefdc23349d9518, - 0x3fefffa3cd0b1395, 0x3feb53c40abf62e5, 0x3fefffa32cc0d0aa, 0x3fd7e70f83662500, 0x3fefffa28bebb1a8, 0xbfd05567908dc9ed, 0x3fefffa1ea8bb693, 0xbfe90b5c677f82fb, - 0x3fefffa148a0df6c, 0xbfeffc0b03e37ff7, 0x3fefffa0a62b2c36, 0xbfea3bc679fbf2af, 0x3fefffa0032a9cf4, 0xbfd4257bcc59c5c1, 0x3fefff9f5f9f31a9, 0x3fd42b0813710205, - 0x3fefff9ebb88ea58, 0x3fea3d72d683e40d, 0x3fefff9e16e7c703, 0x3feffbf3a0fc73b8, 0x3fefff9d71bbc7ad, 0x3fe9098a8cb78789, 0x3fefff9ccc04ec5a, 0x3fd04fc09d170815, - 0x3fefff9c25c3350b, 0xbfd7ec7b914ac263, 0x3fefff9b7ef6a1c4, 0xbfeb55493c808822, 0x3fefff9ad79f3287, 0xbfefdbdd234da594, 0x3fefff9a2fbce757, 0xbfe7be429d0f81de, - 0x3fefff99874fc038, 0xbfc8d3682328360c, 0x3fefff98de57bd2b, 0x3fdb960037d60e4b, 0x3fefff9834d4de35, 0x3fec51c7a7797b44, 0x3fefff978ac72357, 0x3fef9be7a47e88dd, - 0x3fefff96e02e8c95, 0x3fe65b3a139bbadf, 0x3fefff96350b19f1, 0x3fc0ee79317e72fd, 0x3fefff95895ccb6e, 0xbfdf23ec26013022, 0x3fefff94dd23a110, 0xbfed31f1801fd85c, - 0x3fefff94305f9ad9, 0xbfef3c53205bfd76, 0x3fefff938310b8cd, 0xbfe4e1d41be54141, 0x3fefff92d536faed, 0xbfb1f13436b53e72, 0x3fefff9226d2613d, 0x3fe149588b159fb7, - 0x3fefff9177e2ebc1, 0x3fedf4e68681fe7c, 0x3fefff90c8689a7a, 0x3feebd7f34d63443, 0x3fefff9018636d6c, 0x3fe3538a4117cd21, 0x3fefff8f67d3649b, 0x3f7f383116cff7d0, - 0x3fefff8eb6b88008, 0xbfe2ef6ff661bea6, 0x3fefff8e0512bfb7, 0xbfee99e3b2619da2, 0x3fefff8d52e223ab, 0xbfee1feac25951fc, 0x3fefff8ca026abe7, 0xbfe1b1eaf4515c9e, - 0x3fefff8bece0586d, 0x3fac18438f550e54, 0x3fefff8b390f2942, 0x3fe4829613ddc72d, 0x3fefff8a84b31e68, 0x3fef2043f64b7822, 0x3fefff89cfcc37e2, 0x3fed64336ce0812f, - 0x3fefff891a5a75b4, 0x3fdffd2ffc2f54e2, 0x3fefff88645dd7df, 0xbfbdfdb91d79aeb3, 0x3fefff87add65e68, 0xbfe6013795a2c69d, 0x3fefff86f6c40951, 0xbfef8780e4c7a91f, - 0x3fefff863f26d89e, 0xbfec8b14fe49a895, 0x3fefff8586fecc51, 0xbfdc7689b8427959, 0x3fefff84ce4be46f, 0x3fc6e8a7e2297a2e, 0x3fefff84150e20f9, 0x3fe769d5b499b7c9, - 0x3fefff835b4581f3, 0x3fefcf3336ad8631, 0x3fefff82a0f20760, 0x3feb9568aa54e6ce, 0x3fefff81e613b144, 0x3fd8d36a1c8bd4aa, 0x3fefff812aaa7fa2, 0xbfcebb884c11747e, - 0x3fefff806eb6727c, 0xbfe8bb07aeea2686, 0x3fefff7fb23789d5, 0xbfeff71332a2c4f5, 0x3fefff7ef52dc5b2, 0xbfea842435ac9d56, 0x3fefff7e37992616, 0xbfd51774a3fcd1f7, - 0x3fefff7d7979ab02, 0x3fd337d512d05544, 0x3fefff7cbacf547c, 0x3fe9f37c31865ac6, 0x3fefff7bfb9a2285, 0x3feffef8f4b82f50, 0x3fefff7b3bda1522, 0x3fe95858ff938cd4, - 0x3fefff7a7b8f2c55, 0x3fd14665a2c1b71a, 0x3fefff79bab96822, 0xbfd6feac45c563e6, 0x3fefff78f958c88b, 0xbfeb11faa8f7a9bd, 0x3fefff78376d4d95, 0xbfefe6dc9667e02d, - 0x3fefff7774f6f743, 0xbfe81332f0f2c392, 0x3fefff76b1f5c597, 0xbfcac81d0fe30d21, 0x3fefff75ee69b896, 0x3fdaae8287ed4272, 0x3fefff752a52d042, 0x3fec15647a9d0fa5, -] )) ), - -################ chunk 19968 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x413166ae1f28b000, 0x41319b3a4ac7e538, 0x413172f3b6dec000, 0x4131a7a4f16c0f76, 0x41317f394e94d000, 0x4131b40f981039b3, 0x41318b7ee64ae000, 0x4131c07a3eb463f1, - 0x413197c47e00f000, 0x4131cce4e5588e2e, 0x4131a40a15b70000, 0x4131d94f8bfcb86c, 0x4131b04fad6d1000, 0x4131e5ba32a0e2a9, 0x4131bc9545232000, 0x4131f224d9450ce7, - 0x4131c8dadcd93000, 0x4131fe8f7fe93724, 0x4131d520748f4000, 0x41320afa268d6162, 0x4131e1660c455000, 0x41321764cd318b9f, 0x4131edaba3fb6000, 0x413223cf73d5b5dd, - 0x4131f9f13bb17000, 0x4132303a1a79e01a, 0x41320636d3678000, 0x41323ca4c11e0a58, 0x4132127c6b1d9000, 0x4132490f67c23495, 0x41321ec202d3a000, 0x4132557a0e665ed3, - 0x41322b079a89b000, 0x413261e4b50a8910, 0x4132374d323fc000, 0x41326e4f5baeb34e, 0x41324392c9f5d000, 0x41327aba0252dd8b, 0x41324fd861abe000, 0x41328724a8f707c9, - 0x41325c1df961f000, 0x4132938f4f9b3206, 0x4132686391180000, 0x41329ff9f63f5c44, 0x413274a928ce1000, 0x4132ac649ce38681, 0x413280eec0842000, 0x4132b8cf4387b0bf, - 0x41328d34583a3000, 0x4132c539ea2bdafc, 0x41329979eff04000, 0x4132d1a490d0053a, 0x4132a5bf87a65000, 0x4132de0f37742f77, 0x4132b2051f5c6000, 0x4132ea79de1859b5, - 0x4132be4ab7127000, 0x4132f6e484bc83f2, 0x4132ca904ec88000, 0x4133034f2b60ae30, 0x4132d6d5e67e9000, 0x41330fb9d204d86d, 0x4132e31b7e34a000, 0x41331c2478a902ab, - 0x4132ef6115eab000, 0x4133288f1f4d2ce8, 0x4132fba6ada0c000, 0x413334f9c5f15726, 0x413307ec4556d000, 0x413341646c958163, 0x41331431dd0ce000, 0x41334dcf1339aba1, - 0x4133207774c2f000, 0x41335a39b9ddd5de, 0x41332cbd0c790000, 0x413366a46082001c, 0x41333902a42f1000, 0x4133730f07262a59, 0x413345483be52000, 0x41337f79adca5497, - 0x4133518dd39b3000, 0x41338be4546e7ed4, 0x41335dd36b514000, 0x4133984efb12a912, 0x41336a1903075000, 0x4133a4b9a1b6d34f, 0x4133765e9abd6000, 0x4133b124485afd8d, - 0x413382a432737000, 0x4133bd8eeeff27ca, 0x41338ee9ca298000, 0x4133c9f995a35208, 0x41339b2f61df9000, 0x4133d6643c477c46, 0x4133a774f995a000, 0x4133e2cee2eba683, - 0x4133b3ba914bb000, 0x4133ef39898fd0c1, 0x4133c0002901c000, 0x4133fba43033fafe, 0x4133cc45c0b7d000, 0x4134080ed6d8253c, 0x4133d88b586de000, 0x413414797d7c4f79, - 0x4133e4d0f023f000, 0x413420e4242079b7, 0x4133f11687da0000, 0x41342d4ecac4a3f4, 0x4133fd5c1f901000, 0x413439b97168ce32, 0x413409a1b7462000, 0x41344624180cf86f, - 0x413415e74efc3000, 0x4134528ebeb122ad, 0x4134222ce6b24000, 0x41345ef965554cea, 0x41342e727e685000, 0x41346b640bf97728, 0x41343ab8161e6000, 0x413477ceb29da165, - 0x413446fdadd47000, 0x413484395941cba3, 0x41345343458a8000, 0x413490a3ffe5f5e0, 0x41345f88dd409000, 0x41349d0ea68a201e, 0x41346bce74f6a000, 0x4134a9794d2e4a5b, - 0x413478140cacb000, 0x4134b5e3f3d27499, 0x41348459a462c000, 0x4134c24e9a769ed6, 0x4134909f3c18d000, 0x4134ceb9411ac914, 0x41349ce4d3cee000, 0x4134db23e7bef351, - 0x4134a92a6b84f000, 0x4134e78e8e631d8f, 0x4134b570033b0000, 0x4134f3f9350747cc, 0x4134c1b59af11000, 0x41350063dbab720a, 0x4134cdfb32a72000, 0x41350cce824f9c47, - 0x4134da40ca5d3000, 0x4135193928f3c685, 0x4134e68662134000, 0x413525a3cf97f0c2, 0x4134f2cbf9c95000, 0x4135320e763c1b00, 0x4134ff11917f6000, 0x41353e791ce0453d, - 0x41350b5729357000, 0x41354ae3c3846f7b, 0x4135179cc0eb8000, 0x4135574e6a2899b8, 0x413523e258a19000, 0x413563b910ccc3f6, 0x41353027f057a000, 0x41357023b770ee33, - 0x41353c6d880db000, 0x41357c8e5e151871, 0x413548b31fc3c000, 0x413588f904b942ae, 0x413554f8b779d000, 0x41359563ab5d6cec, 0x4135613e4f2fe000, 0x4135a1ce52019729, - 0x41356d83e6e5f000, 0x4135ae38f8a5c167, 0x413579c97e9c0000, 0x4135baa39f49eba4, 0x4135860f16521000, 0x4135c70e45ee15e2, 0x41359254ae082000, 0x4135d378ec92401f, - 0x41359e9a45be3000, 0x4135dfe393366a5d, 0x4135aadfdd744000, 0x4135ec4e39da949a, 0x4135b725752a5000, 0x4135f8b8e07ebed8, 0x4135c36b0ce06000, 0x413605238722e915, - 0x4135cfb0a4967000, 0x4136118e2dc71353, 0x4135dbf63c4c8000, 0x41361df8d46b3d90, 0x4135e83bd4029000, 0x41362a637b0f67ce, 0x4135f4816bb8a000, 0x413636ce21b3920b, - 0x413600c7036eb000, 0x41364338c857bc49, 0x41360d0c9b24c000, 0x41364fa36efbe687, 0x4136195232dad000, 0x41365c0e15a010c4, 0x41362597ca90e000, 0x41366878bc443b02, - 0x413631dd6246f000, 0x413674e362e8653f, 0x41363e22f9fd0000, 0x4136814e098c8f7d, 0x41364a6891b31000, 0x41368db8b030b9ba, 0x413656ae29692000, 0x41369a2356d4e3f8, - 0x413662f3c11f3000, 0x4136a68dfd790e35, 0x41366f3958d54000, 0x4136b2f8a41d3873, 0x41367b7ef08b5000, 0x4136bf634ac162b0, 0x413687c488416000, 0x4136cbcdf1658cee, - 0x4136940a1ff77000, 0x4136d8389809b72b, 0x4136a04fb7ad8000, 0x4136e4a33eade169, 0x4136ac954f639000, 0x4136f10de5520ba6, 0x4136b8dae719a000, 0x4136fd788bf635e4, - 0x4136c5207ecfb000, 0x413709e3329a6021, 0x4136d1661685c000, 0x4137164dd93e8a5f, 0x4136ddabae3bd000, 0x413722b87fe2b49c, 0x4136e9f145f1e000, 0x41372f232686deda, - 0x4136f636dda7f000, 0x41373b8dcd2b0917, 0x4137027c755e0000, 0x413747f873cf3355, 0x41370ec20d141000, 0x413754631a735d92, 0x41371b07a4ca2000, 0x413760cdc11787d0, - 0x4137274d3c803000, 0x41376d3867bbb20d, 0x41373392d4364000, 0x413779a30e5fdc4b, 0x41373fd86bec5000, 0x4137860db5040688, 0x41374c1e03a26000, 0x413792785ba830c6, - 0x413758639b587000, 0x41379ee3024c5b03, 0x413764a9330e8000, 0x4137ab4da8f08541, 0x413770eecac49000, 0x4137b7b84f94af7e, 0x41377d34627aa000, 0x4137c422f638d9bc, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3fefff7465b10c9e, 0x3fefaed6366c1da9, 0x3fefff73a0846daf, 0x3fe6b5f74fd453f7, 0x3fefff72daccf378, 0x3fc2e8a418d94c40, 0x3fefff72148a9dfb, 0xbfde43a7a6386fb6, - 0x3fefff714dbd6d3c, 0xbfecfcb6231ffa52, 0x3fefff708665613f, 0xbfef571de0b1b71c, 0x3fefff6fbe827a07, 0xbfe542037a2e9550, 0x3fefff6ef614b797, 0xbfb5ec81420db379, - 0x3fefff6e2d1c19f2, 0x3fe0dd4310ab1b46, 0x3fefff6d6398a11d, 0x3fedc70839ed820a, 0x3fefff6c998a4d1b, 0x3feee00b56292a50, 0x3fefff6bcef11dee, 0x3fe3b8cb88b01fdb, - 0x3fefff6b03cd139b, 0x3f97c72e9b8d1af3, 0x3fefff6a381e2e24, 0xbfe287d36177f5bb, 0x3fefff696be46d8e, 0xbfee73905916513c, 0x3fefff689f1fd1dc, 0xbfee4a15b528c019, - 0x3fefff67d1d05b11, 0xbfe21bd8d9dcaad4, 0x3fefff6703f60930, 0x3fa41db8a9e52238, 0x3fefff663590dc3e, 0x3fe41fda0b5a6a55, 0x3fefff6566a0d43d, 0x3fef01a1e763bbef, - 0x3fefff649725f132, 0x3fed95d3020725ba, 0x3fefff63c720331f, 0x3fe06cc8894ba818, 0x3fefff62f68f9a08, 0xbfba0574779fb320, 0x3fefff62257425f2, 0xbfe5a3bedf3ccb18, - 0x3fefff6153cdd6de, 0xbfef70aec557ee83, 0x3fefff60819cacd2, 0xbfecc3f7915301ef, 0x3fefff5faee0a7d0, 0xbfdd5a93a32c71c2, 0x3fefff5edb99c7db, 0x3fc4f1024a156e57, - 0x3fefff5e07c80cf9, 0x3fe711fdd23eb270, 0x3fefff5d336b772c, 0x3fefc047db14a6f1, 0x3fefff5c5e840677, 0x3febd5555312d162, 0x3fefff5b8911badf, 0x3fd9be38bb91a689, - 0x3fefff5ab3149467, 0xbfccca574614c849, 0x3fefff59dc8c9312, 0xbfe869288124e4f0, 0x3fefff590579b6e5, 0xbfeff01d87b559c1, 0x3fefff582ddbffe2, 0xbfeacadb0128bafd, - 0x3fefff5755b36e0e, 0xbfd6081d115a4767, 0x3fefff567d00016d, 0x3fd2436f89e1ff05, 0x3fefff55a3c1ba01, 0x3fe9a7e79f972104, 0x3fefff54c9f897cf, 0x3feffffff0d0484c, - 0x3fefff53efa49ada, 0x3fe9a593300a4264, 0x3fefff5314c5c327, 0x3fd23bf71e4fe143, 0x3fefff52395c10b7, 0xbfd60f6e3487db80, 0x3fefff515d678391, 0xbfeaccfc4ee357ce, - 0x3fefff5080e81bb6, 0xbfefefdf326d76da, 0x3fefff4fa3ddd92b, 0xbfe866a344964d1f, 0x3fefff4ec648bbf4, 0xbfccbb26cfff806a, 0x3fefff4de828c415, 0x3fd9c55b4406ee92, - 0x3fefff4d097df190, 0x3febd7415d8ad3d7, 0x3fefff4c2a48446a, 0x3fefbfcb6ee44bc2, 0x3fefff4b4a87bca7, 0x3fe70f4a4e176af4, 0x3fefff4a6a3c5a4b, 0x3fc4e1a167047cee, - 0x3fefff4989661d59, 0xbfdd61806de90132, 0x3fefff48a80505d5, 0xbfecc5ac6c4d6d86, 0x3fefff47c61913c3, 0xbfef6ff4beb59165, 0x3fefff46e3a24726, 0xbfe5a0dfc745237d, - 0x3fefff4600a0a004, 0xbfb9e6709c54d262, 0x3fefff451d141e5e, 0x3fe070209910d267, 0x3fefff4438fcc23a, 0x3fed974ef87df310, 0x3fefff43545a8b9b, 0x3fef00ab006851f7, - 0x3fefff426f2d7a86, 0x3fe41cd23ef2d3ae, 0x3fefff4189758efd, 0x3fa3df6ad6d1580c, 0x3fefff40a332c905, 0xbfe21f0f3ba49106, 0x3fefff3fbc6528a1, 0xbfee4b574b00000e, - 0x3fefff3ed50cadd7, 0xbfee725d88c13068, 0x3fefff3ded2958a9, 0xbfe284a5e8b94f31, 0x3fefff3d04bb291b, 0x3f9843d9d2c1fa26, 0x3fefff3c1bc21f32, 0x3fe3bbdd05c7e63f, - 0x3fefff3b323e3af1, 0x3feee11149ab55d0, 0x3fefff3a482f7c5d, 0x3fedc59ab32d3a86, 0x3fefff395d95e379, 0x3fe0d9f3195e567b, 0x3fefff3872717049, 0xbfb60b90c63de750, - 0x3fefff3786c222d1, 0xbfe544ed00cbb7f8, 0x3fefff369a87fb16, 0xbfef57e72bd175a5, 0x3fefff35adc2f91b, 0xbfecfb0f539f586c, 0x3fefff34c0731ce4, 0xbfde3cc95b186d85, - 0x3fefff33d2986676, 0x3fc2f80eacd8e160, 0x3fefff32e432d5d3, 0x3fe6b8b5f626b51b, 0x3fefff31f5426b02, 0x3fefaf620fca7b76, 0x3fefff3105c72604, 0x3fec138609553e7f, - 0x3fefff3015c106e0, 0x3fdaa76cbf3f3f8b, 0x3fefff2f25300d97, 0xbfcad75b09b10fe8, 0x3fefff2e34143a30, 0xbfe815c3f80ecf8c, 0x3fefff2d426d8cad, 0xbfefe72a721db1cd, - 0x3fefff2c503c0513, 0xbfeb0fe674891e86, 0x3fefff2b5d7fa366, 0xbfd6f76615c91dae, 0x3fefff2a6a3867a9, 0x3fd14de6b2d2b6e7, 0x3fefff29766651e2, 0x3fe95ab9d644e8f6, - 0x3fefff2882096215, 0x3fefff0884e215fd, 0x3fefff278d219845, 0x3fe9f1344e473e6f, 0x3fefff2697aef476, 0x3fd33065c2e49505, 0x3fefff25a1b176ad, 0xbfd51ed045a6c9f2, - 0x3fefff24ab291eee, 0xbfea86527ab9983a, 0x3fefff23b415ed3d, 0xbfeff6e467ad8bda, 0x3fefff22bc77e19f, 0xbfe8b88e651ca995, 0x3fefff21c44efc17, 0xbfceac664b7e5d30, - 0x3fefff20cb9b3ca9, 0x3fd8da98f2fad130, 0x3fefff1fd25ca35b, 0x3feb97622f54f429, 0x3fefff1ed8933030, 0x3fefcec63f6bbe5f, 0x3fefff1dde3ee32c, 0x3fe7672d7db35c32, - 0x3fefff1ce35fbc53, 0x3fc6d951a5514db5, 0x3fefff1be7f5bbab, 0xbfdc7d84942733c7, 0x3fefff1aec00e136, 0xbfec8cd7c985efbb, 0x3fefff19ef812cfa, 0xbfef86d62e39d3e6, - 0x3fefff18f2769efb, 0xbfe5fe631a1d7dbf, 0x3fefff17f4e1373d, 0xbfbddec2d9c66b93, 0x3fefff16f6c0f5c4, 0x3fe001f7f0fedff8, 0x3fefff15f815da94, 0x3fed65bdbb61591a, - 0x3fefff14f8dfe5b3, 0x3fef1f5c2b38f39f, 0x3fefff13f91f1723, 0x3fe47f98287c83ff, 0x3fefff12f8d36eea, 0x3fabda01668ac8a8, 0x3fefff11f7fced0d, 0xbfe1b52a0be55a9f, - 0x3fefff10f69b918e, 0xbfee213b09aebd25, 0x3fefff0ff4af5c73, 0xbfee98bfbaac59a7, 0x3fefff0ef2384dc0, 0xbfe2ec4b994e7ab3, 0x3fefff0def366579, 0x3f80957e92f03efc, - 0x3fefff0ceba9a3a3, 0x3fe356a53dfbd0ac, 0x3fefff0be7920842, 0x3feebe94248cf4ce, 0x3fefff0ae2ef935b, 0x3fedf3878638d474, 0x3fefff09ddc244f2, 0x3fe14610e1167a6a, - 0x3fefff08d80a1d0b, 0xbfb2104d74de3097, 0x3fefff07d1c71bab, 0xbfe4e4c7e2b495ef, 0x3fefff06caf940d6, 0xbfef3d2ba371eba3, 0x3fefff05c3a08c91, 0xbfed3058d670e9ba, - 0x3fefff04bbbcfee1, 0xbfdf1d1cc7eee79e, 0x3fefff03b34e97c9, 0x3fc0fdec8087f73b, 0x3fefff02aa55574e, 0x3fe65e03b05d4148, 0x3fefff01a0d13d74, 0x3fef9c82e2544a56, -] )) ), - -################ chunk 20480 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x41378979fa30b000, 0x4137d08d9cdd03f9, 0x413795bf91e6c000, 0x4137dcf843812e37, 0x4137a205299cd000, 0x4137e962ea255874, 0x4137ae4ac152e000, 0x4137f5cd90c982b2, - 0x4137ba905908f000, 0x41380238376dacef, 0x4137c6d5f0bf0000, 0x41380ea2de11d72d, 0x4137d31b88751000, 0x41381b0d84b6016a, 0x4137df61202b2000, 0x413827782b5a2ba8, - 0x4137eba6b7e13000, 0x413833e2d1fe55e5, 0x4137f7ec4f974000, 0x4138404d78a28023, 0x41380431e74d5000, 0x41384cb81f46aa60, 0x413810777f036000, 0x41385922c5ead49e, - 0x41381cbd16b97000, 0x4138658d6c8efedb, 0x41382902ae6f8000, 0x413871f813332919, 0x4138354846259000, 0x41387e62b9d75356, 0x4138418ddddba000, 0x41388acd607b7d94, - 0x41384dd37591b000, 0x41389738071fa7d1, 0x41385a190d47c000, 0x4138a3a2adc3d20f, 0x4138665ea4fdd000, 0x4138b00d5467fc4c, 0x413872a43cb3e000, 0x4138bc77fb0c268a, - 0x41387ee9d469f000, 0x4138c8e2a1b050c8, 0x41388b2f6c200000, 0x4138d54d48547b05, 0x4138977503d61000, 0x4138e1b7eef8a543, 0x4138a3ba9b8c2000, 0x4138ee22959ccf80, - 0x4138b00033423000, 0x4138fa8d3c40f9be, 0x4138bc45caf84000, 0x413906f7e2e523fb, 0x4138c88b62ae5000, 0x4139136289894e39, 0x4138d4d0fa646000, 0x41391fcd302d7876, - 0x4138e116921a7000, 0x41392c37d6d1a2b4, 0x4138ed5c29d08000, 0x413938a27d75ccf1, 0x4138f9a1c1869000, 0x4139450d2419f72f, 0x413905e7593ca000, 0x41395177cabe216c, - 0x4139122cf0f2b000, 0x41395de271624baa, 0x41391e7288a8c000, 0x41396a4d180675e7, 0x41392ab8205ed000, 0x413976b7beaaa025, 0x413936fdb814e000, 0x41398322654eca62, - 0x413943434fcaf000, 0x41398f8d0bf2f4a0, 0x41394f88e7810000, 0x41399bf7b2971edd, 0x41395bce7f371000, 0x4139a862593b491b, 0x4139681416ed2000, 0x4139b4ccffdf7358, - 0x41397459aea33000, 0x4139c137a6839d96, 0x4139809f46594000, 0x4139cda24d27c7d3, 0x41398ce4de0f5000, 0x4139da0cf3cbf211, 0x4139992a75c56000, 0x4139e6779a701c4e, - 0x4139a5700d7b7000, 0x4139f2e24114468c, 0x4139b1b5a5318000, 0x4139ff4ce7b870c9, 0x4139bdfb3ce79000, 0x413a0bb78e5c9b07, 0x4139ca40d49da000, 0x413a18223500c544, - 0x4139d6866c53b000, 0x413a248cdba4ef82, 0x4139e2cc0409c000, 0x413a30f7824919bf, 0x4139ef119bbfd000, 0x413a3d6228ed43fd, 0x4139fb573375e000, 0x413a49cccf916e3a, - 0x413a079ccb2bf000, 0x413a563776359878, 0x413a13e262e20000, 0x413a62a21cd9c2b5, 0x413a2027fa981000, 0x413a6f0cc37decf3, 0x413a2c6d924e2000, 0x413a7b776a221730, - 0x413a38b32a043000, 0x413a87e210c6416e, 0x413a44f8c1ba4000, 0x413a944cb76a6bab, 0x413a513e59705000, 0x413aa0b75e0e95e9, 0x413a5d83f1266000, 0x413aad2204b2c026, - 0x413a69c988dc7000, 0x413ab98cab56ea64, 0x413a760f20928000, 0x413ac5f751fb14a1, 0x413a8254b8489000, 0x413ad261f89f3edf, 0x413a8e9a4ffea000, 0x413adecc9f43691c, - 0x413a9adfe7b4b000, 0x413aeb3745e7935a, 0x413aa7257f6ac000, 0x413af7a1ec8bbd97, 0x413ab36b1720d000, 0x413b040c932fe7d5, 0x413abfb0aed6e000, 0x413b107739d41212, - 0x413acbf6468cf000, 0x413b1ce1e0783c50, 0x413ad83bde430000, 0x413b294c871c668d, 0x413ae48175f91000, 0x413b35b72dc090cb, 0x413af0c70daf2000, 0x413b4221d464bb09, - 0x413afd0ca5653000, 0x413b4e8c7b08e546, 0x413b09523d1b4000, 0x413b5af721ad0f84, 0x413b1597d4d15000, 0x413b6761c85139c1, 0x413b21dd6c876000, 0x413b73cc6ef563ff, - 0x413b2e23043d7000, 0x413b803715998e3c, 0x413b3a689bf38000, 0x413b8ca1bc3db87a, 0x413b46ae33a99000, 0x413b990c62e1e2b7, 0x413b52f3cb5fa000, 0x413ba57709860cf5, - 0x413b5f396315b000, 0x413bb1e1b02a3732, 0x413b6b7efacbc000, 0x413bbe4c56ce6170, 0x413b77c49281d000, 0x413bcab6fd728bad, 0x413b840a2a37e000, 0x413bd721a416b5eb, - 0x413b904fc1edf000, 0x413be38c4abae028, 0x413b9c9559a40000, 0x413beff6f15f0a66, 0x413ba8daf15a1000, 0x413bfc61980334a3, 0x413bb52089102000, 0x413c08cc3ea75ee1, - 0x413bc16620c63000, 0x413c1536e54b891e, 0x413bcdabb87c4000, 0x413c21a18befb35c, 0x413bd9f150325000, 0x413c2e0c3293dd99, 0x413be636e7e86000, 0x413c3a76d93807d7, - 0x413bf27c7f9e7000, 0x413c46e17fdc3214, 0x413bfec217548000, 0x413c534c26805c52, 0x413c0b07af0a9000, 0x413c5fb6cd24868f, 0x413c174d46c0a000, 0x413c6c2173c8b0cd, - 0x413c2392de76b000, 0x413c788c1a6cdb0a, 0x413c2fd8762cc000, 0x413c84f6c1110548, 0x413c3c1e0de2d000, 0x413c916167b52f85, 0x413c4863a598e000, 0x413c9dcc0e5959c3, - 0x413c54a93d4ef000, 0x413caa36b4fd8400, 0x413c60eed5050000, 0x413cb6a15ba1ae3e, 0x413c6d346cbb1000, 0x413cc30c0245d87b, 0x413c797a04712000, 0x413ccf76a8ea02b9, - 0x413c85bf9c273000, 0x413cdbe14f8e2cf6, 0x413c920533dd4000, 0x413ce84bf6325734, 0x413c9e4acb935000, 0x413cf4b69cd68171, 0x413caa9063496000, 0x413d0121437aabaf, - 0x413cb6d5faff7000, 0x413d0d8bea1ed5ec, 0x413cc31b92b58000, 0x413d19f690c3002a, 0x413ccf612a6b9000, 0x413d266137672a67, 0x413cdba6c221a000, 0x413d32cbde0b54a5, - 0x413ce7ec59d7b000, 0x413d3f3684af7ee2, 0x413cf431f18dc000, 0x413d4ba12b53a920, 0x413d00778943d000, 0x413d580bd1f7d35d, 0x413d0cbd20f9e000, 0x413d6476789bfd9b, - 0x413d1902b8aff000, 0x413d70e11f4027d8, 0x413d254850660000, 0x413d7d4bc5e45216, 0x413d318de81c1000, 0x413d89b66c887c53, 0x413d3dd37fd22000, 0x413d9621132ca691, - 0x413d4a1917883000, 0x413da28bb9d0d0ce, 0x413d565eaf3e4000, 0x413daef66074fb0c, 0x413d62a446f45000, 0x413dbb610719254a, 0x413d6ee9deaa6000, 0x413dc7cbadbd4f87, - 0x413d7b2f76607000, 0x413dd436546179c5, 0x413d87750e168000, 0x413de0a0fb05a402, 0x413d93baa5cc9000, 0x413ded0ba1a9ce40, 0x413da0003d82a000, 0x413df976484df87d, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3fefff0096c24a41, 0x3fec4ff6ed29a901, 0x3feffeff8c287db9, 0x3fdb8ef79ff18743, 0x3feffefe8103d7e0, 0xbfc8e2b2add0727d, 0x3feffefd755458ba, 0xbfe7c0df45c948c6, - 0x3feffefc691a004d, 0xbfefdc3a809b0d47, 0x3feffefb5c54ce9d, 0xbfeb53424286d44b, 0x3feffefa4f04c3ae, 0xbfd7e540c8a3bab3, 0x3feffef94129df84, 0x3fd05749d9f594b7, - 0x3feffef832c42226, 0x3fe90bf7a494516f, 0x3feffef723d38b96, 0x3feffc12c05804de, 0x3feffef614581bda, 0x3fea3b37a3fcd249, 0x3feffef50451d2f7, 0x3fd423a255c1d478, - 0x3feffef3f3c0b0f0, 0xbfd42ce177057618, 0x3feffef2e2a4b5cb, 0xbfea3e019392c849, 0x3feffef1d0fde18c, 0xbfeffbebc62bcab7, 0x3feffef0becc3437, 0xbfe908ef37e833e4, - 0x3feffeefac0fadd3, 0xbfd04dde441232c0, 0x3feffeee98c84e62, 0x3fd7ee4a353d02a2, 0x3feffeed84f615ea, 0x3feb55caead0a7f3, 0x3feffeec7099046f, 0x3fefdbc5b9146787, - 0x3feffeeb5bb119f7, 0x3fe7bd9b64d5aaac, 0x3feffeea463e5685, 0x3fc8cf9571d16eec, 0x3feffee93040ba1f, 0xbfdb97c24d560c10, 0x3feffee819b844c9, 0xbfec523bc53f2328, - 0x3feffee702a4f688, 0xbfef9bc0c24b3b7e, 0x3feffee5eb06cf60, 0xbfe65a879f2aabc9, 0x3feffee4d2ddcf57, 0xbfc0ea9c53eded48, 0x3feffee3ba29f672, 0x3fdf259feb06af50, - 0x3feffee2a0eb44b4, 0x3fed32579933955f, 0x3feffee18721ba22, 0x3fef3c1ced0fae2e, 0x3feffee06ccd56c3, 0x3fe4e1171dd9dd3b, 0x3feffedf51ee1a99, 0x3fb1e96ddca18a9c, - 0x3feffede368405ab, 0xbfe14a2a6b473c4e, 0x3feffedd1a8f17fc, 0xbfedf53e34cdbedb, 0x3feffedbfe0f5192, 0xbfeebd39e6b07870, 0x3feffedae104b272, 0xbfe352c3766a8d1f, - 0x3feffed9c36f3aa0, 0xbf7ebb7e083cb036, 0x3feffed8a54eea21, 0x3fe2f03902683612, 0x3feffed786a3c0fa, 0x3fee9a2c9e233704, 0x3feffed6676dbf30, 0x3fee1f969ea643eb, - 0x3feffed547ace4c7, 0x3fe1b11b23f9fb9f, 0x3feffed4276131c5, 0xbfac27d409e5e286, 0x3feffed3068aa62f, 0xbfe48355827f82f2, 0x3feffed1e5294209, 0xbfef207dd69d0576, - 0x3feffed0c33d0559, 0xbfed63d0c7d6e5f8, 0x3feffecfa0c5f022, 0xbfdffb7fefa5078e, 0x3feffece7dc4026b, 0x3fbe05769c216790, 0x3feffecd5a373c38, 0x3fe601eca7826718, - 0x3feffecc361f9d8e, 0x3fef87ab7fb451b4, 0x3feffecb117d2672, 0x3fec8aa43a84654c, 0x3feffec9ec4fd6e9, 0x3fdc74caf08268d9, 0x3feffec8c697aef7, 0xbfc6ec7d6409bcc4, - 0x3feffec7a054aea3, 0xbfe76a7fb4652449, 0x3feffec67986d5f0, 0xbfefcf4e61a1138b, 0x3feffec5522e24e4, 0xbfeb94ea38bfbfb3, 0x3feffec42a4a9b85, 0xbfd8d19e58175f65, - 0x3feffec301dc39d6, 0x3fcebf50b9a01c8c, 0x3feffec1d8e2ffdc, 0x3fe8bba5f2bc5b50, 0x3feffec0af5eed9e, 0x3feff71ed268a0b3, 0x3feffebf85500320, 0x3fea839894a53c60, - 0x3feffebe5ab64067, 0x3fd5159daf3b7f11, 0x3feffebd2f91a578, 0xbfd339b0db845bf9, 0x3feffebc03e23258, 0xbfe9f40e1ae36343, 0x3feffebad7a7e70d, 0xbfeffef4fdb2685d, - 0x3feffeb9aae2c39a, 0xbfe957c0baec7fa3, 0x3feffeb87d92c807, 0xbfd14485545e1748, 0x3feffeb74fb7f456, 0x3fd7007dc3f4a848, 0x3feffeb62152488f, 0x3feb127fa60d252e, - 0x3feffeb4f261c4b5, 0x3fefe6c90c8c630e, 0x3feffeb3c2e668ce, 0x3fe8128ea0d8b492, 0x3feffeb292e034df, 0x3fcac44d814b875d, 0x3feffeb1624f28ed, 0xbfdab047ea28be14, - 0x3feffeb0313344fe, 0xbfec15dc064e1446, 0x3feffeaeff8c8917, 0xbfefaeb32d4b3139, 0x3feffeadcd5af53c, 0xbfe6b54798bb198e, 0x3feffeac9a9e8973, 0xbfc2e4c968dedb3d, - 0x3feffeab675745c1, 0x3fde455f2729991e, 0x3feffeaa33852a2b, 0x3fecfd1fc5c78028, 0x3feffea8ff2836b7, 0x3fef56eb7b4ef75e, 0x3feffea7ca406b6a, 0x3fe541490bf68634, - 0x3feffea694cdc849, 0x3fb5e4bd537c1209, 0x3feffea55ed04d59, 0xbfe0de1704701cea, 0x3feffea42847faa0, 0xbfedc76389f98598, 0x3feffea2f134d022, 0xbfeedfc9c6fbd9f3, - 0x3feffea1b996cde5, 0xbfe3b8071daa15c6, 0x3feffea0816df3ef, 0xbf97a803c1923b5a, 0x3feffe9f48ba4245, 0x3fe2889eb4b702dd, 0x3feffe9e0f7bb8eb, 0x3fee73dcfb166358, - 0x3feffe9cd5b257e8, 0x3fee49c53db5b892, 0x3feffe9b9b5e1f40, 0x3fe21b0b36b9567d, 0x3feffe9a607f0ef9, 0xbfa42d4c13c43627, 0x3feffe9925152718, 0xbfe4209bf2782612, - 0x3feffe97e92067a3, 0xbfef01df8ec1eef6, 0x3feffe96aca0d09f, 0xbfed9573f2e26466, 0x3feffe956f966211, 0xbfe06bf27b8dc7ef, 0x3feffe9432011bfe, 0x3fba0d355e87fbf0, - 0x3feffe92f3e0fe6d, 0x3fe5a4769870a35e, 0x3feffe91b5360962, 0x3fef70dd3457061f, 0x3feffe9076003ce3, 0x3fecc38a497cb209, 0x3feffe8f363f98f6, 0x3fdd58d85f2eed81, - 0x3feffe8df5f41d9f, 0xbfc4f4da76aed55e, 0x3feffe8cb51dcae4, 0xbfe712aaa58e4967, 0x3feffe8b73bca0cb, 0xbfefc066e34cf49a, 0x3feffe8a31d09f58, 0xbfebd4da3ff98bda, - 0x3feffe88ef59c692, 0xbfd9bc700a1087f3, 0x3feffe87ac58167e, 0x3fccce235249c5f3, 0x3feffe8668cb8f22, 0x3fe869c9c1d824aa, 0x3feffe8524b43082, 0x3feff02d0a13a376, - 0x3feffe83e011faa5, 0x3feaca529dcc35c7, 0x3feffe829ae4ed8f, 0x3fd60648bba90b28, 0x3feffe81552d0947, 0xbfd2454d9a10beef, 0x3feffe800eea4dd2, 0xbfe9a87cac342495, - 0x3feffe7ec81cbb35, 0xbfefffffddd4a137, 0x3feffe7d80c45176, 0xbfe9a4fe04fe3a00, 0x3feffe7c38e1109b, 0xbfd23a18f87a71b3, 0x3feffe7af072f8a9, 0x3fd6114270111dd3, - 0x3feffe79a77a09a5, 0x3feacd849274fd05, 0x3feffe785df64396, 0x3fefefcf8a2ae15f, 0x3feffe7713e7a680, 0x3fe86601e6ee4df6, 0x3feffe75c94e326a, 0x3fccb75aa12e58df, - 0x3feffe747e29e759, 0xbfd9c723d6f8ecd1, 0x3feffe73327ac553, 0xbfebd7bc4facfb0e, 0x3feffe71e640cc5d, 0xbfefbfac410493a2, 0x3feffe70997bfc7c, 0xbfe70e9d5f54292e, - 0x3feffe6f4c2c55b8, 0xbfc4ddc92219fce0, 0x3feffe6dfe51d814, 0x3fdd633b8f47b428, 0x3feffe6cafec8397, 0x3fecc61991f3d479, 0x3feffe6b60fc5847, 0x3fef6fc62a63aec0, -] )) ), - -################ chunk 20992 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x413dac45d538b000, 0x413e05e0eef222bb, 0x413db88b6ceec000, 0x413e124b95964cf8, 0x413dc4d104a4d000, 0x413e1eb63c3a7736, 0x413dd1169c5ae000, 0x413e2b20e2dea173, - 0x413ddd5c3410f000, 0x413e378b8982cbb1, 0x413de9a1cbc70000, 0x413e43f63026f5ee, 0x413df5e7637d1000, 0x413e5060d6cb202c, 0x413e022cfb332000, 0x413e5ccb7d6f4a69, - 0x413e0e7292e93000, 0x413e6936241374a7, 0x413e1ab82a9f4000, 0x413e75a0cab79ee4, 0x413e26fdc2555000, 0x413e820b715bc922, 0x413e33435a0b6000, 0x413e8e7617fff35f, - 0x413e3f88f1c17000, 0x413e9ae0bea41d9d, 0x413e4bce89778000, 0x413ea74b654847da, 0x413e5814212d9000, 0x413eb3b60bec7218, 0x413e6459b8e3a000, 0x413ec020b2909c55, - 0x413e709f5099b000, 0x413ecc8b5934c693, 0x413e7ce4e84fc000, 0x413ed8f5ffd8f0d0, 0x413e892a8005d000, 0x413ee560a67d1b0e, 0x413e957017bbe000, 0x413ef1cb4d21454b, - 0x413ea1b5af71f000, 0x413efe35f3c56f89, 0x413eadfb47280000, 0x413f0aa09a6999c6, 0x413eba40dede1000, 0x413f170b410dc404, 0x413ec68676942000, 0x413f2375e7b1ee41, - 0x413ed2cc0e4a3000, 0x413f2fe08e56187f, 0x413edf11a6004000, 0x413f3c4b34fa42bc, 0x413eeb573db65000, 0x413f48b5db9e6cfa, 0x413ef79cd56c6000, 0x413f552082429737, - 0x413f03e26d227000, 0x413f618b28e6c175, 0x413f102804d88000, 0x413f6df5cf8aebb2, 0x413f1c6d9c8e9000, 0x413f7a60762f15f0, 0x413f28b33444a000, 0x413f86cb1cd3402d, - 0x413f34f8cbfab000, 0x413f9335c3776a6b, 0x413f413e63b0c000, 0x413f9fa06a1b94a8, 0x413f4d83fb66d000, 0x413fac0b10bfbee6, 0x413f59c9931ce000, 0x413fb875b763e923, - 0x413f660f2ad2f000, 0x413fc4e05e081361, 0x413f7254c2890000, 0x413fd14b04ac3d9e, 0x413f7e9a5a3f1000, 0x413fddb5ab5067dc, 0x413f8adff1f52000, 0x413fea2051f49219, - 0x413f972589ab3000, 0x413ff68af898bc57, 0x413fa36b21614000, 0x4140017acf9e734a, 0x413fafb0b9175000, 0x414007b022f08869, 0x413fbbf650cd6000, 0x41400de576429d88, - 0x413fc83be8837000, 0x4140141ac994b2a7, 0x413fd48180398000, 0x41401a501ce6c7c5, 0x413fe0c717ef9000, 0x414020857038dce4, 0x413fed0cafa5a000, 0x414026bac38af203, - 0x413ff952475bb000, 0x41402cf016dd0722, 0x414002cbef88e000, 0x414033256a2f1c40, 0x414008eebb63e800, 0x4140395abd81315f, 0x41400f11873ef000, 0x41403f9010d3467e, - 0x414015345319f800, 0x414045c564255b9d, 0x41401b571ef50000, 0x41404bfab77770bb, 0x41402179ead00800, 0x414052300ac985da, 0x4140279cb6ab1000, 0x414058655e1b9af9, - 0x41402dbf82861800, 0x41405e9ab16db018, 0x414033e24e612000, 0x414064d004bfc536, 0x41403a051a3c2800, 0x41406b055811da55, 0x41404027e6173000, 0x4140713aab63ef74, - 0x4140464ab1f23800, 0x4140776ffeb60493, 0x41404c6d7dcd4000, 0x41407da5520819b1, 0x4140529049a84800, 0x414083daa55a2ed0, 0x414058b315835000, 0x41408a0ff8ac43ef, - 0x41405ed5e15e5800, 0x414090454bfe590e, 0x414064f8ad396000, 0x4140967a9f506e2c, 0x41406b1b79146800, 0x41409caff2a2834b, 0x4140713e44ef7000, 0x4140a2e545f4986a, - 0x4140776110ca7800, 0x4140a91a9946ad89, 0x41407d83dca58000, 0x4140af4fec98c2a7, 0x414083a6a8808800, 0x4140b5853fead7c6, 0x414089c9745b9000, 0x4140bbba933cece5, - 0x41408fec40369800, 0x4140c1efe68f0204, 0x4140960f0c11a000, 0x4140c82539e11722, 0x41409c31d7eca800, 0x4140ce5a8d332c41, 0x4140a254a3c7b000, 0x4140d48fe0854160, - 0x4140a8776fa2b800, 0x4140dac533d7567f, 0x4140ae9a3b7dc000, 0x4140e0fa87296b9d, 0x4140b4bd0758c800, 0x4140e72fda7b80bc, 0x4140badfd333d000, 0x4140ed652dcd95db, - 0x4140c1029f0ed800, 0x4140f39a811faafa, 0x4140c7256ae9e000, 0x4140f9cfd471c018, 0x4140cd4836c4e800, 0x4141000527c3d537, 0x4140d36b029ff000, 0x4141063a7b15ea56, - 0x4140d98dce7af800, 0x41410c6fce67ff75, 0x4140dfb09a560000, 0x414112a521ba1493, 0x4140e5d366310800, 0x414118da750c29b2, 0x4140ebf6320c1000, 0x41411f0fc85e3ed1, - 0x4140f218fde71800, 0x414125451bb053f0, 0x4140f83bc9c22000, 0x41412b7a6f02690e, 0x4140fe5e959d2800, 0x414131afc2547e2d, 0x4141048161783000, 0x414137e515a6934c, - 0x41410aa42d533800, 0x41413e1a68f8a86b, 0x414110c6f92e4000, 0x4141444fbc4abd89, 0x414116e9c5094800, 0x41414a850f9cd2a8, 0x41411d0c90e45000, 0x414150ba62eee7c7, - 0x4141232f5cbf5800, 0x414156efb640fce6, 0x41412952289a6000, 0x41415d2509931205, 0x41412f74f4756800, 0x4141635a5ce52723, 0x41413597c0507000, 0x4141698fb0373c42, - 0x41413bba8c2b7800, 0x41416fc503895161, 0x414141dd58068000, 0x414175fa56db6680, 0x4141480023e18800, 0x41417c2faa2d7b9e, 0x41414e22efbc9000, 0x41418264fd7f90bd, - 0x41415445bb979800, 0x4141889a50d1a5dc, 0x41415a688772a000, 0x41418ecfa423bafb, 0x4141608b534da800, 0x41419504f775d019, 0x414166ae1f28b000, 0x41419b3a4ac7e538, - 0x41416cd0eb03b800, 0x4141a16f9e19fa57, 0x414172f3b6dec000, 0x4141a7a4f16c0f76, 0x4141791682b9c800, 0x4141adda44be2494, 0x41417f394e94d000, 0x4141b40f981039b3, - 0x4141855c1a6fd800, 0x4141ba44eb624ed2, 0x41418b7ee64ae000, 0x4141c07a3eb463f1, 0x414191a1b225e800, 0x4141c6af9206790f, 0x414197c47e00f000, 0x4141cce4e5588e2e, - 0x41419de749dbf800, 0x4141d31a38aaa34d, 0x4141a40a15b70000, 0x4141d94f8bfcb86c, 0x4141aa2ce1920800, 0x4141df84df4ecd8a, 0x4141b04fad6d1000, 0x4141e5ba32a0e2a9, - 0x4141b67279481800, 0x4141ebef85f2f7c8, 0x4141bc9545232000, 0x4141f224d9450ce7, 0x4141c2b810fe2800, 0x4141f85a2c972205, 0x4141c8dadcd93000, 0x4141fe8f7fe93724, - 0x4141cefda8b43800, 0x414204c4d33b4c43, 0x4141d520748f4000, 0x41420afa268d6162, 0x4141db43406a4800, 0x4142112f79df7680, 0x4141e1660c455000, 0x41421764cd318b9f, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3feffe6a11815629, 0x3fe5a027f47e03f9, 0x3feffe68c17b7d43, 0x3fb9deaf95a0db7d, 0x3feffe6770eacd9a, 0xbfe070f693348afb, 0x3feffe661fcf4735, 0xbfed97ade49424ff, - 0x3feffe64ce28ea18, 0xbfef006d34491c12, 0x3feffe637bf7b64a, 0xbfe41c103fdda85d, 0x3feffe62293babd1, 0xbfa3cfd757390396, 0x3feffe60d5f4cab2, 0x3fe21fdcc9643a35, - 0x3feffe5f822312f3, 0x3fee4ba79e783be4, 0x3feffe5e2dc68499, 0x3fee7210c2970a54, 0x3feffe5cd8df1fab, 0x3fe283da7f99fc07, 0x3feffe5b836ce42e, 0xbf986304943c8d9b, - 0x3feffe5a2d6fd229, 0xbfe3bca1594cd82f, 0x3feffe58d6e7e9a0, 0xbfeee152b43ecaaf, 0x3feffe577fd52a99, 0xbfedc53f3fd98975, 0x3feffe562837951b, 0xbfe0d91f117defb3, - 0x3feffe54d00f292c, 0x3fb6135499bb2b4e, 0x3feffe53775be6d0, 0x3fe545a755e15b1d, 0x3feffe521e1dce0f, 0x3fef58196bfe5c54, 0x3feffe50c454deed, 0x3fecfaa58e870811, - 0x3feffe4f6a011971, 0x3fde3b11b67ba21e, 0x3feffe4e0f227da0, 0xbfc2fbe946d9a69a, 0x3feffe4cb3b90b81, 0xbfe6b9659235dcef, 0x3feffe4b57c4c319, 0xbfefaf84f358918c, - 0x3feffe49fb45a46f, 0xbfec130e5c62eb07, 0x3feffe489e3baf87, 0xbfdaa5a73d25d147, 0x3feffe4740a6e468, 0x3fcadb2a77fc089d, 0x3feffe45e2874319, 0x3fe816682b9716d7, - 0x3feffe4483dccb9e, 0x3fefe73dd61d094f, 0x3feffe4324a77dfe, 0x3feb0f615756e005, 0x3feffe41c4e75a3f, 0x3fd6f5947c560051, 0x3feffe40649c6067, 0xbfd14fc6ecb2fbfc, - 0x3feffe3f03c6907b, 0xbfe95b51fcd88a0a, 0x3feffe3da265ea82, 0xbfefff0c55f1bd8f, 0x3feffe3c407a6e82, 0xbfe9f0a246217dd4, 0x3feffe3ade041c80, 0xbfd32e89e367e317, - 0x3feffe397b02f484, 0x3fd520a7215da32e, 0x3feffe381776f691, 0x3fea86ddfc49f75b, 0x3feffe36b36022b0, 0x3feff6d8a1fb1949, 0x3feffe354ebe78e5, 0x3fe8b7f003f48b7e, - 0x3feffe33e991f937, 0x3fcea89db9825bb3, 0x3feffe3283daa3ad, 0xbfd8dc6499f6b462, 0x3feffe311d98784b, 0xbfeb97e0803f3b46, 0x3feffe2fb6cb7718, 0xbfefceaaeebe8b09, - 0x3feffe2e4f73a01a, 0xbfe766836222363d, 0x3feffe2ce790f357, 0xbfc6d57c084c164f, 0x3feffe2b7f2370d6, 0x3fdc7f433a576be5, 0x3feffe2a162b189b, 0x3fec8d486b5e4ceb, - 0x3feffe28aca7eaaf, 0x3fef86ab6de53e52, 0x3feffe274299e716, 0x3fe5fdadee241397, 0x3feffe25d8010dd7, 0x3fbdd705369daf25, 0x3feffe246cdd5ef8, 0xbfe002cfe42c5547, - 0x3feffe23012eda7f, 0xbfed66203d8b0f0a, 0x3feffe2194f58072, 0xbfef1f2225fa1413, 0x3feffe20283150d8, 0xbfe47ed8a16e7f7b, 0x3feffe1ebae24bb6, 0xbfabca70ccc8f3fa, - 0x3feffe1d4d087113, 0x3fe1b5f9c73c599b, 0x3feffe1bdea3c0f5, 0x3fee218f09a8b1e0, 0x3feffe1a6fb43b62, 0x3fee9876aa93a4da, 0x3feffe190039e061, 0x3fe2eb8276df995d, - 0x3feffe179034aff7, 0xbf80d3d80720d39f, 0x3feffe161fa4aa2b, 0xbfe3576bf1c605c3, 0x3feffe14ae89cf04, 0xbfeebed94e42444e, 0x3feffe133ce41e86, 0xbfedf32fb468daf9, - 0x3feffe11cab398ba, 0xbfe1453eec646c50, 0x3feffe1057f83da4, 0x3fb21813ba15930f, 0x3feffe0ee4b20d4c, 0x3fe4e584c80ffa2c, 0x3feffe0d70e107b7, 0x3fef3d61b1ab1f3c, - 0x3feffe0bfc852cec, 0x3fed2ff29abac45f, 0x3feffe0a879e7cf1, 0x3fdf1b68dddf4b4d, 0x3feffe09122cf7cc, 0xbfc101c94a779ce9, 0x3feffe079c309d85, 0xbfe65eb60a3af7e3, - 0x3feffe0625a96e20, 0xbfef9ca99f06b4e3, 0x3feffe04ae9769a5, 0xbfec4f82adc43649, 0x3feffe0336fa901a, 0xbfdb8d3569815513, 0x3feffe01bed2e185, 0x3fc8e685416b156f, - 0x3feffe0046205ded, 0x3fe7c18661d61c01, 0x3feffdfecce30557, 0x3fefdc51c5092598, 0x3feffdfd531ad7cb, 0x3feb52c073ca0e8b, 0x3feffdfbd8c7d54f, 0x3fd7e3720871236f, - 0x3feffdfa5de9fde8, 0xbfd0592c1f5dcaf6, 0x3feffdf8e281519f, 0xbfe90c92dbb7a466, 0x3feffdf7668dd078, 0xbfeffc1a75361ac6, 0x3feffdf5ea0f7a7b, 0xbfea3aa8c7d6960d, - 0x3feffdf46d064fae, 0xbfd421c8da80e54f, 0x3feffdf2ef725017, 0x3fd42ebad5d059d6, 0x3feffdf171537bbd, 0x3fea3e904a70bae3, 0x3feffdeff2a9d2a7, 0x3feffbe3e3c5401f, - 0x3feffdee737554da, 0x3fe90853dd321555, 0x3feffdecf3b6025d, 0x3fd04bfbe72ef4d8, 0x3feffdeb736bdb38, 0xbfd7f018d39f3f32, 0x3feffde9f296df6f, 0xbfeb564c9293a7a8, - 0x3feffde871370f0b, 0xbfefdbae474d6790, 0x3feffde6ef4c6a11, 0xbfe7bcf426cec538, 0x3feffde56cd6f088, 0xbfc8cbc2ba58b778, 0x3feffde3e9d6a276, 0x3fdb99845c83a4b3, - 0x3feffde2664b7fe2, 0x3fec52afdc44f506, 0x3feffde0e23588d3, 0x3fef9b99d897dccb, 0x3feffddf5d94bd4f, 0x3fe659d5256046fd, 0x3feffdddd8691d5d, 0x3fc0e6bf71daed82, - 0x3feffddc52b2a903, 0xbfdf2753a88c300b, 0x3feffddacc716049, 0xbfed32bdab59c1f6, 0x3feffdd945a54334, 0xbfef3be6b2568378, 0x3feffdd7be4e51cb, 0xbfe4e05a1ac1e696, - 0x3feffdd6366c8c14, 0xbfb1e1a77ecd7626, 0x3feffdd4adfff218, 0x3fe14afc475e9362, 0x3feffdd3250883db, 0x3fedf595dc034dda, 0x3feffdd19b864166, 0x3feebcf4913692fa, - 0x3feffdd011792abe, 0x3fe351fca7344040, 0x3feffdce86e13fea, 0x3f7e3ecaf25e8e1a, 0x3feffdccfbbe80f0, 0xbfe2f10209fd26b7, 0x3feffdcb7010edd9, 0xbfee9a7582ab3794, - 0x3feffdc9e3d886a9, 0xbfee1f4273d2bf65, 0x3feffdc857154b69, 0xbfe1b04b4f6fe7f5, 0x3feffdc6c9c73c1e, 0x3fac37647dc86219, 0x3feffdc53bee58d0, 0x3fe48414ec5bbad1, - 0x3feffdc3ad8aa185, 0x3fef20b7af84538f, 0x3feffdc21e9c1643, 0x3fed636e1bd3fd0d, 0x3feffdc08f22b713, 0x3fdff9cfdb83eec6, 0x3feffdbeff1e83fa, 0xbfbe0d3414a7b23c, - 0x3feffdbd6e8f7cff, 0xbfe602a1b411f070, 0x3feffdbbdd75a229, 0xbfef87d61325acea, 0x3feffdba4bd0f37f, 0xbfec8a336ff95ae9, 0x3feffdb8b9a17108, 0xbfdc730c21c86def, - 0x3feffdb726e71aca, 0x3fc6f052dffb8c46, 0x3feffdb593a1f0cc, 0x3fe76b29aea22625, 0x3feffdb3ffd1f316, 0x3fefcf6985085201, 0x3feffdb26b7721ad, 0x3feb946bc08ee794, -] )) ), - -################ chunk 21504 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4141e788d8205800, 0x41421d9a2083a0be, 0x4141edaba3fb6000, 0x414223cf73d5b5dd, 0x4141f3ce6fd66800, 0x41422a04c727cafb, 0x4141f9f13bb17000, 0x4142303a1a79e01a, - 0x41420014078c7800, 0x4142366f6dcbf539, 0x41420636d3678000, 0x41423ca4c11e0a58, 0x41420c599f428800, 0x414242da14701f76, 0x4142127c6b1d9000, 0x4142490f67c23495, - 0x4142189f36f89800, 0x41424f44bb1449b4, 0x41421ec202d3a000, 0x4142557a0e665ed3, 0x414224e4ceaea800, 0x41425baf61b873f1, 0x41422b079a89b000, 0x414261e4b50a8910, - 0x4142312a6664b800, 0x4142681a085c9e2f, 0x4142374d323fc000, 0x41426e4f5baeb34e, 0x41423d6ffe1ac800, 0x41427484af00c86c, 0x41424392c9f5d000, 0x41427aba0252dd8b, - 0x414249b595d0d800, 0x414280ef55a4f2aa, 0x41424fd861abe000, 0x41428724a8f707c9, 0x414255fb2d86e800, 0x41428d59fc491ce8, 0x41425c1df961f000, 0x4142938f4f9b3206, - 0x41426240c53cf800, 0x414299c4a2ed4725, 0x4142686391180000, 0x41429ff9f63f5c44, 0x41426e865cf30800, 0x4142a62f49917163, 0x414274a928ce1000, 0x4142ac649ce38681, - 0x41427acbf4a91800, 0x4142b299f0359ba0, 0x414280eec0842000, 0x4142b8cf4387b0bf, 0x414287118c5f2800, 0x4142bf0496d9c5de, 0x41428d34583a3000, 0x4142c539ea2bdafc, - 0x4142935724153800, 0x4142cb6f3d7df01b, 0x41429979eff04000, 0x4142d1a490d0053a, 0x41429f9cbbcb4800, 0x4142d7d9e4221a59, 0x4142a5bf87a65000, 0x4142de0f37742f77, - 0x4142abe253815800, 0x4142e4448ac64496, 0x4142b2051f5c6000, 0x4142ea79de1859b5, 0x4142b827eb376800, 0x4142f0af316a6ed4, 0x4142be4ab7127000, 0x4142f6e484bc83f2, - 0x4142c46d82ed7800, 0x4142fd19d80e9911, 0x4142ca904ec88000, 0x4143034f2b60ae30, 0x4142d0b31aa38800, 0x414309847eb2c34f, 0x4142d6d5e67e9000, 0x41430fb9d204d86d, - 0x4142dcf8b2599800, 0x414315ef2556ed8c, 0x4142e31b7e34a000, 0x41431c2478a902ab, 0x4142e93e4a0fa800, 0x41432259cbfb17ca, 0x4142ef6115eab000, 0x4143288f1f4d2ce8, - 0x4142f583e1c5b800, 0x41432ec4729f4207, 0x4142fba6ada0c000, 0x414334f9c5f15726, 0x414301c9797bc800, 0x41433b2f19436c45, 0x414307ec4556d000, 0x414341646c958163, - 0x41430e0f1131d800, 0x41434799bfe79682, 0x41431431dd0ce000, 0x41434dcf1339aba1, 0x41431a54a8e7e800, 0x41435404668bc0c0, 0x4143207774c2f000, 0x41435a39b9ddd5de, - 0x4143269a409df800, 0x4143606f0d2feafd, 0x41432cbd0c790000, 0x414366a46082001c, 0x414332dfd8540800, 0x41436cd9b3d4153b, 0x41433902a42f1000, 0x4143730f07262a59, - 0x41433f25700a1800, 0x414379445a783f78, 0x414345483be52000, 0x41437f79adca5497, 0x41434b6b07c02800, 0x414385af011c69b6, 0x4143518dd39b3000, 0x41438be4546e7ed4, - 0x414357b09f763800, 0x41439219a7c093f3, 0x41435dd36b514000, 0x4143984efb12a912, 0x414363f6372c4800, 0x41439e844e64be31, 0x41436a1903075000, 0x4143a4b9a1b6d34f, - 0x4143703bcee25800, 0x4143aaeef508e86e, 0x4143765e9abd6000, 0x4143b124485afd8d, 0x41437c8166986800, 0x4143b7599bad12ac, 0x414382a432737000, 0x4143bd8eeeff27ca, - 0x414388c6fe4e7800, 0x4143c3c442513ce9, 0x41438ee9ca298000, 0x4143c9f995a35208, 0x4143950c96048800, 0x4143d02ee8f56727, 0x41439b2f61df9000, 0x4143d6643c477c46, - 0x4143a1522dba9800, 0x4143dc998f999164, 0x4143a774f995a000, 0x4143e2cee2eba683, 0x4143ad97c570a800, 0x4143e904363dbba2, 0x4143b3ba914bb000, 0x4143ef39898fd0c1, - 0x4143b9dd5d26b800, 0x4143f56edce1e5df, 0x4143c0002901c000, 0x4143fba43033fafe, 0x4143c622f4dcc800, 0x414401d98386101d, 0x4143cc45c0b7d000, 0x4144080ed6d8253c, - 0x4143d2688c92d800, 0x41440e442a2a3a5a, 0x4143d88b586de000, 0x414414797d7c4f79, 0x4143deae2448e800, 0x41441aaed0ce6498, 0x4143e4d0f023f000, 0x414420e4242079b7, - 0x4143eaf3bbfef800, 0x4144271977728ed5, 0x4143f11687da0000, 0x41442d4ecac4a3f4, 0x4143f73953b50800, 0x414433841e16b913, 0x4143fd5c1f901000, 0x414439b97168ce32, - 0x4144037eeb6b1800, 0x41443feec4bae350, 0x414409a1b7462000, 0x41444624180cf86f, 0x41440fc483212800, 0x41444c596b5f0d8e, 0x414415e74efc3000, 0x4144528ebeb122ad, - 0x41441c0a1ad73800, 0x414458c4120337cb, 0x4144222ce6b24000, 0x41445ef965554cea, 0x4144284fb28d4800, 0x4144652eb8a76209, 0x41442e727e685000, 0x41446b640bf97728, - 0x414434954a435800, 0x414471995f4b8c46, 0x41443ab8161e6000, 0x414477ceb29da165, 0x414440dae1f96800, 0x41447e0405efb684, 0x414446fdadd47000, 0x414484395941cba3, - 0x41444d2079af7800, 0x41448a6eac93e0c1, 0x41445343458a8000, 0x414490a3ffe5f5e0, 0x4144596611658800, 0x414496d953380aff, 0x41445f88dd409000, 0x41449d0ea68a201e, - 0x414465aba91b9800, 0x4144a343f9dc353c, 0x41446bce74f6a000, 0x4144a9794d2e4a5b, 0x414471f140d1a800, 0x4144afaea0805f7a, 0x414478140cacb000, 0x4144b5e3f3d27499, - 0x41447e36d887b800, 0x4144bc19472489b7, 0x41448459a462c000, 0x4144c24e9a769ed6, 0x41448a7c703dc800, 0x4144c883edc8b3f5, 0x4144909f3c18d000, 0x4144ceb9411ac914, - 0x414496c207f3d800, 0x4144d4ee946cde32, 0x41449ce4d3cee000, 0x4144db23e7bef351, 0x4144a3079fa9e800, 0x4144e1593b110870, 0x4144a92a6b84f000, 0x4144e78e8e631d8f, - 0x4144af4d375ff800, 0x4144edc3e1b532ad, 0x4144b570033b0000, 0x4144f3f9350747cc, 0x4144bb92cf160800, 0x4144fa2e88595ceb, 0x4144c1b59af11000, 0x41450063dbab720a, - 0x4144c7d866cc1800, 0x414506992efd8729, 0x4144cdfb32a72000, 0x41450cce824f9c47, 0x4144d41dfe822800, 0x41451303d5a1b166, 0x4144da40ca5d3000, 0x4145193928f3c685, - 0x4144e06396383800, 0x41451f6e7c45dba4, 0x4144e68662134000, 0x414525a3cf97f0c2, 0x4144eca92dee4800, 0x41452bd922ea05e1, 0x4144f2cbf9c95000, 0x4145320e763c1b00, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3feffdb0d6917c9a, 0x3fd8cfd28dfa45b9, 0x3feffdaf412103e2, 0xbfcec3191fe301de, 0x3feffdadab25b78c, 0xbfe8bc4430b023a8, 0x3feffdac149f97a0, 0xbfeff72a6a9a394e, - 0x3feffdaa7d8ea425, 0xbfea830ced65298f, 0x3feffda8e5f2dd20, 0xbfd513c6b5796374, 0x3feffda74dcc429a, 0x3fd33b8c9fa88717, 0x3feffda5b51ad498, 0x3fe9f49ffe2a96f1, - 0x3feffda41bde9323, 0x3feffef0ff1587a4, 0x3feffda282177e41, 0x3fe957287041fcdc, 0x3feffda0e7c595f8, 0x3fd142a501e187cd, 0x3feffd9f4ce8da51, 0xbfd7024f3cea620d, - 0x3feffd9db1814b51, 0xbfeb13049ca50baf, 0x3feffd9c158ee900, 0xbfefe6b57b218801, 0x3feffd9a7911b364, 0xbfe811ea4b0858ae, 0x3feffd98dc09aa85, 0xbfcac07dec5a099f, - 0x3feffd973e76ce6b, 0x3fdab20d46492e3f, 0x3feffd95a0591f1a, 0x3fec16538b45b280, 0x3feffd9401b09c9c, 0x3fefae901ca5b483, 0x3feffd92627d46f6, 0x3fe6b497dc3e735d, - 0x3feffd90c2bf1e31, 0x3fc2e0eeb3ea1bb6, 0x3feffd8f22762252, 0xbfde4716a0b38aec, 0x3feffd8d81a25361, 0xbfecfd89618e1654, 0x3feffd8be043b165, 0xbfef56b90e7c79b0, - 0x3feffd8a3e5a3c65, 0xbfe5408e989b6531, 0x3feffd889be5f468, 0xbfb5dcf960b7914b, 0x3feffd86f8e6d976, 0x3fe0deeaf4347e29, 0x3feffd85555ceb95, 0x3fedc7bed2f49902, - 0x3feffd83b1482acc, 0x3feedf883072a77f, 0x3feffd820ca89723, 0x3fe3b742ae0f6a20, 0x3feffd80677e30a1, 0x3f9788d8e1fa584e, 0x3feffd7ec1c8f74c, 0xbfe2896a039038b4, - 0x3feffd7d1b88eb2d, 0xbfee742995e66dc9, 0x3feffd7b74be0c4a, 0xbfee4974bf1d252b, 0x3feffd79cd685aaa, 0xbfe21a3d8f4a2c3f, 0x3feffd782587d654, 0x3fa43cdf78d9a075, - 0x3feffd767d1c7f51, 0x3fe4215dd4e81c2a, 0x3feffd74d42655a6, 0x3fef021d2ebcaa9c, 0x3feffd732aa5595b, 0x3fed9514dcb88e1f, 0x3feffd7180998a78, 0x3fe06b1c69ea5c08, - 0x3feffd6fd602e903, 0xbfba14f640406b8a, 0x3feffd6e2ae17504, 0xbfe5a52e4c6a3ab4, 0x3feffd6c7f352e81, 0xbfef710b9be039b6, 0x3feffd6ad2fe1584, 0xbfecc31cfad31aaf, - 0x3feffd69263c2a11, 0xbfdd571d1401d517, 0x3feffd6778ef6c32, 0x3fc4f8b29dd0f361, 0x3feffd65cb17dbec, 0x3fe7135773644d23, 0x3feffd641cb57948, 0x3fefc085e3fc7cbf, - 0x3feffd626dc8444c, 0x3febd45f2635d808, 0x3feffd60be503d01, 0x3fd9baa752aea7c8, 0x3feffd5f0e4d636c, 0xbfccd1ef57a8fa25, 0x3feffd5d5dbfb797, 0xbfe86a6afcc06499, - 0x3feffd5baca73987, 0xbfeff03c84dfcf7d, 0x3feffd59fb03e944, 0xbfeac9ca3425cbee, 0x3feffd5848d5c6d6, 0xbfd6047460bdeab4, 0x3feffd56961cd244, 0x3fd2472ba5e9a0c4, - 0x3feffd54e2d90b95, 0x3fe9a911b2cda8d5, 0x3feffd532f0a72d1, 0x3fefffffc341213d, 0x3feffd517ab107ff, 0x3fe9a468d3dc6813, 0x3feffd4fc5cccb27, 0x3fd2383ace51ccbf, - 0x3feffd4e105dbc50, 0xbfd61316a699f3ce, 0x3feffd4c5a63db80, 0xbfeace0ccf98fffc, 0x3feffd4aa3df28c1, 0xbfefefbfda544870, 0x3feffd48eccfa419, 0xbfe86560837c34ab, - 0x3feffd4735354d8f, 0xbfccb38e6b8cce22, 0x3feffd457d10252b, 0x3fd9c8ec63927233, 0x3feffd43c4602af5, 0x3febd8373b2409ee, 0x3feffd420b255ef4, 0x3fefbf8d0b944116, - 0x3feffd40515fc130, 0x3fe70df06b1848e7, 0x3feffd3e970f51af, 0x3fc4d9f0d7bda940, 0x3feffd3cdc34107a, 0xbfdd64f6a9746153, 0x3feffd3b20cdfd98, 0xbfecc686b0c65a3a, - 0x3feffd3964dd1910, 0xbfef6f978e9c2862, 0x3feffd37a86162eb, 0xbfe59f701c7da535, 0x3feffd35eb5adb2f, 0xbfb9d6ee89c81a2a, 0x3feffd342dc981e4, 0x3fe071cc8971881f, - 0x3feffd326fad5711, 0x3fed980cc9a4b8f1, 0x3feffd30b1065abf, 0x3fef002f60c6c103, 0x3feffd2ef1d48cf5, 0x3fe41b4e3c1bcf37, 0x3feffd2d3217edba, 0x3fa3c043d2ed33c2, - 0x3feffd2b71d07d16, 0xbfe220aa52d6e7aa, 0x3feffd29b0fe3b10, 0xbfee4bf7eaca73da, 0x3feffd27efa127b1, 0xbfee71c3f53d4f58, 0x3feffd262db942ff, 0xbfe2830f1215f43e, - 0x3feffd246b468d03, 0x3f98822f4fedbc87, 0x3feffd22a84905c4, 0x3fe3bd65a83c0d5d, 0x3feffd20e4c0ad49, 0x3feee194177605df, 0x3feffd1f20ad839b, 0x3fedc4e3c5756c2b, - 0x3feffd1d5c0f88c1, 0x3fe0d84b059e1550, 0x3feffd1b96e6bcc3, 0xbfb61b1868fa7dc9, 0x3feffd19d1331fa8, 0xbfe54661a5d2e6e3, 0x3feffd180af4b178, 0xbfef584ba4bb3f55, - 0x3feffd16442b723a, 0xbfecfa3bc28e5cc7, 0x3feffd147cd761f8, 0xbfde395a0a7a0b6b, 0x3feffd12b4f880b7, 0x3fc2ffc3dbdaa410, 0x3feffd10ec8ece80, 0x3fe6ba1528e0a043, - 0x3feffd0f239a4b5b, 0x3fefafa7cf61e3a9, 0x3feffd0d5a1af74f, 0x3fec1296a8b7d651, 0x3feffd0b9010d265, 0x3fdaa3e1b4f3e200, 0x3feffd09c57bdca3, 0xbfcadef9dfe79e26, - 0x3feffd07fa5c1612, 0xbfe8170c59682763, 0x3feffd062eb17eb9, 0xbfefe751328ce15a, 0x3feffd04627c16a1, 0xbfeb0edc33c9ee66, 0x3feffd0295bbddd1, 0xbfd6f3c2dd70369a, - 0x3feffd00c870d450, 0x3fd151a72277a5a4, 0x3feffcfefa9afa28, 0x3fe95bea1d7b6136, 0x3feffcfd2c3a4f5e, 0x3fefff101f694639, 0x3feffcfb5d4ed3fd, 0x3fe9f01037d400ce, - 0x3feffcf98dd8880a, 0x3fd32cadff5dfb06, 0x3feffcf7bdd76b8e, 0xbfd5227df84d7e1f, 0x3feffcf5ed4b7e92, 0xbfea8769777d0d75, 0x3feffcf41c34c11c, 0xbfeff6ccd4b2f7e2, - 0x3feffcf24a933335, 0xbfe8b7519ceee25d, 0x3feffcf07866d4e4, 0xbfcea4d51fc3b33f, 0x3feffceea5afa632, 0x3fd8de303ad16d71, 0x3feffcecd26da726, 0x3feb985eca8d2279, - 0x3feffceafea0d7c8, 0x3fefce8f967e2c3e, 0x3feffce92a493821, 0x3fe765d940d7eee3, 0x3feffce75566c838, 0x3fc6d1a66659c1eb, 0x3feffce57ff98815, 0xbfdc8101d98b42cc, - 0x3feffce3aa0177c0, 0xbfec8db90670444a, 0x3feffce1d37e9741, 0xbfef8680a60a9cd3, 0x3feffcdffc70e6a1, 0xbfe5fcf8bd0a0e58, 0x3feffcde24d865e6, 0xbfbdcf478d5e8f33, - 0x3feffcdc4cb51519, 0x3fe003a7d38d3253, 0x3feffcda7406f442, 0x3fed6682b8d42f78, 0x3feffcd89ace0369, 0x3fef1ee81960268a, 0x3feffcd6c10a4297, 0x3fe47e19159c0b6e, -] )) ), - -################ chunk 22016 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x4144f8eec5a45800, 0x41453843c98e301f, 0x4144ff11917f6000, 0x41453e791ce0453d, 0x414505345d5a6800, 0x414544ae70325a5c, 0x41450b5729357000, 0x41454ae3c3846f7b, - 0x41451179f5107800, 0x4145511916d6849a, 0x4145179cc0eb8000, 0x4145574e6a2899b8, 0x41451dbf8cc68800, 0x41455d83bd7aaed7, 0x414523e258a19000, 0x414563b910ccc3f6, - 0x41452a05247c9800, 0x414569ee641ed915, 0x41453027f057a000, 0x41457023b770ee33, 0x4145364abc32a800, 0x414576590ac30352, 0x41453c6d880db000, 0x41457c8e5e151871, - 0x4145429053e8b800, 0x414582c3b1672d90, 0x414548b31fc3c000, 0x414588f904b942ae, 0x41454ed5eb9ec800, 0x41458f2e580b57cd, 0x414554f8b779d000, 0x41459563ab5d6cec, - 0x41455b1b8354d800, 0x41459b98feaf820b, 0x4145613e4f2fe000, 0x4145a1ce52019729, 0x414567611b0ae800, 0x4145a803a553ac48, 0x41456d83e6e5f000, 0x4145ae38f8a5c167, - 0x414573a6b2c0f800, 0x4145b46e4bf7d686, 0x414579c97e9c0000, 0x4145baa39f49eba4, 0x41457fec4a770800, 0x4145c0d8f29c00c3, 0x4145860f16521000, 0x4145c70e45ee15e2, - 0x41458c31e22d1800, 0x4145cd4399402b01, 0x41459254ae082000, 0x4145d378ec92401f, 0x4145987779e32800, 0x4145d9ae3fe4553e, 0x41459e9a45be3000, 0x4145dfe393366a5d, - 0x4145a4bd11993800, 0x4145e618e6887f7c, 0x4145aadfdd744000, 0x4145ec4e39da949a, 0x4145b102a94f4800, 0x4145f2838d2ca9b9, 0x4145b725752a5000, 0x4145f8b8e07ebed8, - 0x4145bd4841055800, 0x4145feee33d0d3f7, 0x4145c36b0ce06000, 0x414605238722e915, 0x4145c98dd8bb6800, 0x41460b58da74fe34, 0x4145cfb0a4967000, 0x4146118e2dc71353, - 0x4145d5d370717800, 0x414617c381192872, 0x4145dbf63c4c8000, 0x41461df8d46b3d90, 0x4145e21908278800, 0x4146242e27bd52af, 0x4145e83bd4029000, 0x41462a637b0f67ce, - 0x4145ee5e9fdd9800, 0x41463098ce617ced, 0x4145f4816bb8a000, 0x414636ce21b3920b, 0x4145faa43793a800, 0x41463d037505a72a, 0x414600c7036eb000, 0x41464338c857bc49, - 0x414606e9cf49b800, 0x4146496e1ba9d168, 0x41460d0c9b24c000, 0x41464fa36efbe687, 0x4146132f66ffc800, 0x414655d8c24dfba5, 0x4146195232dad000, 0x41465c0e15a010c4, - 0x41461f74feb5d800, 0x4146624368f225e3, 0x41462597ca90e000, 0x41466878bc443b02, 0x41462bba966be800, 0x41466eae0f965020, 0x414631dd6246f000, 0x414674e362e8653f, - 0x414638002e21f800, 0x41467b18b63a7a5e, 0x41463e22f9fd0000, 0x4146814e098c8f7d, 0x41464445c5d80800, 0x414687835cdea49b, 0x41464a6891b31000, 0x41468db8b030b9ba, - 0x4146508b5d8e1800, 0x414693ee0382ced9, 0x414656ae29692000, 0x41469a2356d4e3f8, 0x41465cd0f5442800, 0x4146a058aa26f916, 0x414662f3c11f3000, 0x4146a68dfd790e35, - 0x414669168cfa3800, 0x4146acc350cb2354, 0x41466f3958d54000, 0x4146b2f8a41d3873, 0x4146755c24b04800, 0x4146b92df76f4d91, 0x41467b7ef08b5000, 0x4146bf634ac162b0, - 0x414681a1bc665800, 0x4146c5989e1377cf, 0x414687c488416000, 0x4146cbcdf1658cee, 0x41468de7541c6800, 0x4146d20344b7a20c, 0x4146940a1ff77000, 0x4146d8389809b72b, - 0x41469a2cebd27800, 0x4146de6deb5bcc4a, 0x4146a04fb7ad8000, 0x4146e4a33eade169, 0x4146a67283888800, 0x4146ead891fff687, 0x4146ac954f639000, 0x4146f10de5520ba6, - 0x4146b2b81b3e9800, 0x4146f74338a420c5, 0x4146b8dae719a000, 0x4146fd788bf635e4, 0x4146befdb2f4a800, 0x414703addf484b02, 0x4146c5207ecfb000, 0x414709e3329a6021, - 0x4146cb434aaab800, 0x4147101885ec7540, 0x4146d1661685c000, 0x4147164dd93e8a5f, 0x4146d788e260c800, 0x41471c832c909f7d, 0x4146ddabae3bd000, 0x414722b87fe2b49c, - 0x4146e3ce7a16d800, 0x414728edd334c9bb, 0x4146e9f145f1e000, 0x41472f232686deda, 0x4146f01411cce800, 0x4147355879d8f3f8, 0x4146f636dda7f000, 0x41473b8dcd2b0917, - 0x4146fc59a982f800, 0x414741c3207d1e36, 0x4147027c755e0000, 0x414747f873cf3355, 0x4147089f41390800, 0x41474e2dc7214873, 0x41470ec20d141000, 0x414754631a735d92, - 0x414714e4d8ef1800, 0x41475a986dc572b1, 0x41471b07a4ca2000, 0x414760cdc11787d0, 0x4147212a70a52800, 0x4147670314699cee, 0x4147274d3c803000, 0x41476d3867bbb20d, - 0x41472d70085b3800, 0x4147736dbb0dc72c, 0x41473392d4364000, 0x414779a30e5fdc4b, 0x414739b5a0114800, 0x41477fd861b1f16a, 0x41473fd86bec5000, 0x4147860db5040688, - 0x414745fb37c75800, 0x41478c4308561ba7, 0x41474c1e03a26000, 0x414792785ba830c6, 0x41475240cf7d6800, 0x414798adaefa45e5, 0x414758639b587000, 0x41479ee3024c5b03, - 0x41475e8667337800, 0x4147a518559e7022, 0x414764a9330e8000, 0x4147ab4da8f08541, 0x41476acbfee98800, 0x4147b182fc429a60, 0x414770eecac49000, 0x4147b7b84f94af7e, - 0x41477711969f9800, 0x4147bdeda2e6c49d, 0x41477d34627aa000, 0x4147c422f638d9bc, 0x414783572e55a800, 0x4147ca58498aeedb, 0x41478979fa30b000, 0x4147d08d9cdd03f9, - 0x41478f9cc60bb800, 0x4147d6c2f02f1918, 0x414795bf91e6c000, 0x4147dcf843812e37, 0x41479be25dc1c800, 0x4147e32d96d34356, 0x4147a205299cd000, 0x4147e962ea255874, - 0x4147a827f577d800, 0x4147ef983d776d93, 0x4147ae4ac152e000, 0x4147f5cd90c982b2, 0x4147b46d8d2de800, 0x4147fc02e41b97d1, 0x4147ba905908f000, 0x41480238376dacef, - 0x4147c0b324e3f800, 0x4148086d8abfc20e, 0x4147c6d5f0bf0000, 0x41480ea2de11d72d, 0x4147ccf8bc9a0800, 0x414814d83163ec4c, 0x4147d31b88751000, 0x41481b0d84b6016a, - 0x4147d93e54501800, 0x41482142d8081689, 0x4147df61202b2000, 0x414827782b5a2ba8, 0x4147e583ec062800, 0x41482dad7eac40c7, 0x4147eba6b7e13000, 0x414833e2d1fe55e5, - 0x4147f1c983bc3800, 0x41483a1825506b04, 0x4147f7ec4f974000, 0x4148404d78a28023, 0x4137f7ec53a8d491, 0x4137f7ec53a8d492, 0x4137f7ec53a8d490, 0x40fe240c9fbe76c9, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3feffcd4e6bbb1d2, 0x3fabbae02c6ef544, 0x3feffcd30be25123, 0xbfe1b6c97e94cad3, 0x3feffcd1307e2093, 0xbfee21e302718b59, 0x3feffccf548f2029, 0xbfee982d9341c4bd, - 0x3feffccd78154fed, 0xbfe2eab94ff36ac3, 0x3feffccb9b10afe7, 0x3f811231875311d6, 0x3feffcc9bd814020, 0x3fe35832a0dfd38f, 0x3feffcc7df6700a0, 0x3feebf1e70a30d36, - 0x3feffcc600c1f16e, 0x3fedf2d7db7d8ea9, 0x3feffcc421921293, 0x3fe1446cf363618c, 0x3feffcc241d76416, 0xbfb21fd9fa02772f, 0x3feffcc06191e601, 0xbfe4e641a85dc29a, - 0x3feffcbe80c1985b, 0xbfef3d97b87aa622, 0x3feffcbc9f667b2c, 0xbfed2f8c57fd6178, 0x3feffcbabd808e7d, 0xbfdf19b4eca5ff7e, 0x3feffcb8db0fd255, 0x3fc105a60fdf4bcf, - 0x3feffcb6f81446bd, 0x3fe65f685ec9cebe, 0x3feffcb5148debbe, 0x3fef9cd05442c4b1, 0x3feffcb3307cc15e, 0x3fec4f0e67b5effc, 0x3feffcb14be0c7a7, 0x3fdb8b732cc143ac, - 0x3feffcaf66b9fea0, 0xbfc8ea57cf1d2125, 0x3feffcad81086652, 0xbfe7c22d786abdc3, 0x3feffcab9acbfec5, 0xbfefdc6901e4ddbe, 0x3feffca9b404c802, 0xbfeb523e9ea22c8f, - 0x3feffca7ccb2c210, 0xbfd7e1a342936e91, 0x3feffca5e4d5ecf8, 0x3fd05b0e6160aada, 0x3feffca3fc6e48c2, 0x3fe90d2e0cd56dfd, 0x3feffca2137bd577, 0x3feffc22227c44e3, - 0x3feffca029fe931e, 0x3fea3a19e5770cb0, 0x3feffc9e3ff681c0, 0x3fd41fef59ff8744, 0x3feffc9c5563a166, 0xbfd430942f94818a, 0x3feffc9a6a45f217, 0xbfea3f1efb022333, - 0x3feffc987e9d73db, 0xbfeffbdbf9c7d44e, 0x3feffc96926a26bd, 0xbfe907b87c637a14, 0x3feffc94a5ac0ac2, 0xbfd04a1986aba53f, 0x3feffc92b8631ff5, 0x3fd7f1e76c18021c, - 0x3feffc90ca8f665d, 0x3feb56ce33da0c68, 0x3feffc8edc30de03, 0x3fefdb96cdf123ed, 0x3feffc8ced4786ee, 0x3fe7bc4ce350ce18, 0x3feffc8afdd36129, 0x3fc8c7effd7b54d8, - 0x3feffc890dd46cba, 0xbfdb9b4664eaf023, 0x3feffc871d4aa9aa, 0xbfec5323ecb0101d, 0x3feffc852c361802, 0xbfef9b72e75a76d9, 0x3feffc833a96b7ca, 0xbfe65922a65f10a9, - 0x3feffc81486c890a, 0xbfc0e2e28c441ffc, 0x3feffc7f55b78bcc, 0x3fdf29075ead3fcf, 0x3feffc7d6277c017, 0x3fed3323b6ac747f, 0x3feffc7b6ead25f4, 0x3fef3bb0703afabc, - 0x3feffc797a57bd6b, 0x3fe4df9d12ce0abe, 0x3feffc7785778685, 0x3fb1d9e11cbb29ee, 0x3feffc75900c814a, 0xbfe14bce1f914bb3, 0x3feffc739a16adc4, 0xbfedf5ed7c11b8c7, - 0x3feffc71a3960bf9, 0xbfeebcaf347a5f01, 0x3feffc6fac8a9bf4, 0xbfe35135d3685517, 0x3feffc6db4f45dbc, 0xbf7dc217b5535fc3, 0x3feffc6bbcd35159, 0x3fe2f1cb0cf9b0cb, - 0x3feffc69c42776d6, 0x3fee9abe5fe6d98e, 0x3feffc67caf0ce39, 0x3fee1eee41d972cb, 0x3feffc65d12f578c, 0x3fe1af7b767dfc86, 0x3feffc63d6e312d7, 0xbfac46f4e8f9a3a3, - 0x3feffc61dc0c0023, 0xbfe484d45141230c, 0x3feffc5fe0aa1f78, 0xbfef20f18108c22d, 0x3feffc5de4bd70df, 0xbfed630b68be8932, 0x3feffc5be845f460, 0xbfdff81fc003e291, - 0x3feffc59eb43aa05, 0x3fbe14f1850e41dd, 0x3feffc57edb691d6, 0x3fe60356bb687372, 0x3feffc55ef9eabdb, 0x3fef88009f269aac, 0x3feffc53f0fbf81d, 0x3fec89c29eb71e3a, - 0x3feffc51f1ce76a5, 0x3fdc714d4c879a4a, 0x3feffc4ff216277b, 0xbfc6f428567beeb9, 0x3feffc4df1d30aa8, 0xbfe76bd3a37c3111, 0x3feffc4bf1052035, 0xbfefcf84a0dfc136, - 0x3feffc49efac682b, 0xbfeb93ed41e2f078, 0x3feffc47edc8e292, 0xbfd8ce06bdf9f79e, 0x3feffc45eb5a8f72, 0x3fcec6e17fd1bc05, 0x3feffc43e8616ed5, 0x3fe8bce268b10d86, - 0x3feffc41e4dd80c4, 0x3feff735fb34925b, 0x3feffc3fe0cec546, 0x3fea82813fda9c2e, 0x3feffc3ddc353c66, 0x3fd511efb63e1198, 0x3feffc3bd710e62b, 0xbfd33d685eff5b9a, - 0x3feffc39d161c29e, 0xbfe9f531db36638a, 0x3feffc37cb27d1c8, 0xbfeffeecf8e10c57, 0x3feffc35c46313b2, 0xbfe956901f6d11f6, 0x3feffc33bd138865, 0xbfd140c4ab8a1c13, - 0x3feffc31b5392fea, 0x3fd70420b02eb0f6, 0x3feffc2facd40a48, 0x3feb13898cd04e3f, 0x3feffc2da3e4178a, 0x3fefe6a1e21fca04, 0x3feffc2b9a6957b8, 0x3fe81145ef96edc0, - 0x3feffc299063cadb, 0x3fcabcae518ca890, 0x3feffc2785d370fb, 0xbfdab3d29bd9d147, 0x3feffc257ab84a21, 0xbfec16cb09b1cde5, 0x3feffc236f125657, 0xbfefae6d0472ad78, - 0x3feffc2162e195a6, 0xbfe6b3e81a75185c, 0x3feffc1f56260815, 0xbfc2dd13faf92a80, 0x3feffc1d48dfadae, 0x3fde48ce130e413a, 0x3feffc1b3b0e867b, 0x3fecfdf2f68ebac5, - 0x3feffc192cb29283, 0x3fef56869a40c3bb, 0x3feffc171dcbd1d0, 0x3fe53fd4204d36d2, 0x3feffc150e5a446b, 0x3fb5d53568c2f9bc, 0x3feffc12fe5dea5c, 0xbfe0dfbee02e6dbc, - 0x3feffc10edd6c3ad, 0xbfedc81a14d2f1a2, 0x3feffc0edcc4d066, 0xbfeedf46929e771f, 0x3feffc0ccb281091, 0xbfe3b67e39c71845, 0x3feffc0ab9008436, 0xbf9769adf4cd6026, - 0x3feffc08a64e2b5f, 0x3fe28a354de95202, 0x3feffc0693110615, 0x3fee74762972b610, 0x3feffc047f49145f, 0x3fee49243954c671, 0x3feffc026af65649, 0x3fe2196fe35a9565, - 0x3feffc005618cbda, 0xbfa44c72d7221607, 0x3feffbfe40b0751b, 0xbfe4221fb2785df7, 0x3feffbfc2abd5216, 0xbfef025ac75bc9cc, 0x3feffbfa143f62d3, 0xbfed94b5bf715053, - 0x3feffbf7fd36a75d, 0xbfe06a46547d0f3d, 0x3feffbf5e5a31fbb, 0x3fba1cb71ac9d42e, 0x3feffbf3cd84cbf7, 0x3fe5a5e5fb40f868, 0x3feffbf1b4dbac1a, 0x3fef7139fbff63cd, - 0x3feffbef9ba7c02d, 0x3fecc2afa5645d6f, 0x3feffbed81e90839, 0x3fdd5561c2175287, 0x3feffbeb679f8447, 0xbfc4fc8abff92554, 0x3feffbe94ccb3461, 0xbfe714043becea63, - 0x3feffbe7316c188f, 0xbfefc0a4dd1f3f28, 0x3feffbe5158230db, 0xbfebd3e405e769da, 0x3feffbe2f90d7d4d, 0xbfd9b8de9531da40, 0x3feffbe0dc0dfdf0, 0x3fccd5bb572ae9ac, - 0x3feffbdebe83b2cc, 0x3fe86b0c31c8cfd5, 0x3feffbdca06e9bea, 0x3feff04bf815e146, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3faa74d27c41b22a, -] )) ), - -################ chunk 22528 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0x412e240ca45a1cac, 0x41132cbd0f5c28f6, 0x41109750ba5e353f, 0x41219d7f53f7ced9, 0x412a6dd2ce560419, 0x412594458fdf3b64, 0x4132d687e3d70a3d, 0x4162d687e6b851ec, - 0x4147f7ec53333333, 0x4144bd24e8f5c28f, 0x415604df28f5c28f, 0x416084a3c0f5c28f, 0x415af956f3d70a3d, 0x41678c29dccccccd, 0x41978c29e0666666, 0x417df5e768000000, - 0x4179ec6e23333333, 0x418b8616f3333333, 0x4194a5ccb1333333, 0x4190dbd658666666, 0x419d6f3454000000, 0x41cd6f3458800000, 0x41b2b9b0a1000000, 0x41b033c4d6000000, - 0x41c133ce58000000, 0x41c9cf3fdd800000, 0x41c512cbee800000, 0x41d26580b4800000, 0x42026580b7500000, 0x41e7681cc9400000, 0x41e440b60b800000, 0x41f580c1ee000000, - 0x42002187ea700000, 0x41fa577eea200000, 0x4206fee0e1a00000, 0x4236fee0e5240000, 0x421d4223fb900000, 0x421950e38e600000, 0x422ae0f269800000, 0x423429e9e50c0000, - 0x423076af52540000, 0x423cbe991a080000, 0x426cbe991e6d0000, 0x425249567d3a0000, 0x424fa51c71f80000, 0x4260cc9781f00000, 0x426934645e4f0000, 0x4264945b26e90000, - 0x4271f71fb0450000, 0x42a1f71fb3042000, 0x4286dbac1c888000, 0x4283c731c73b0000, 0x4294ffbd626c0000, 0x429f817d75e2c000, 0x4299b971f0a34000, 0x42a674e79c564000, - 0x42d674e79fc52800, 0x42bc929723aaa000, 0x42b8b8fe3909c000, 0x42ca3facbb070000, 0x42d3b0ee69adb800, 0x42d013e736660800, 0x42dc1221836bd000, 0x430c122187b67200, - 0x42f1db9e764aa400, 0x42eee73dc74c3000, 0x430067cbf4e46000, 0x43089d2a04192600, 0x430418e103ff8a00, 0x43118b54f2236200, 0x43418b54f4d20740, 0x4326528613dd4d00, - 0x432350869c8f9e00, 0x433481bef21d7800, 0x433ec474851f6f80, 0x43391f1944ff6c80, 0x4345ee2a2eac3a80, 0x4375ee2a32068910, 0x435be72798d4a040, 0x435824a843b38580, - 0x4369a22eaea4d600, 0x43733ac8d333a5b0, 0x436f66df963f47a0, 0xc073a28c59d5433b, 0xc073a28c59d5433b, 0xc073a28c59d5433b, 0xc073a28c59d5434d, 0xc073a28c59d54329, - 0xc083a28c59d5433b, 0xc083a28c59d5433b, 0xc083a28c59d5433b, 0xc083a28c59d54344, 0xc083a28c59d54332, 0xc08d73d286bfe4d8, 0xc08d73d286bfe4d8, 0xc08d73d286bfe4d8, - 0xc08d73d286bfe4e1, 0xc08d73d286bfe4d0, 0xc093a28c59d5433b, 0xc093a28c59d5433b, 0xc093a28c59d5433b, 0xc093a28c59d5433f, 0xc093a28c59d54337, 0xc0988b2f704a940a, - 0xc0988b2f704a940a, 0xc0988b2f704a940a, 0xc0988b2f704a940e, 0xc0988b2f704a9405, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4d8, 0xc09d73d286bfe4dd, - 0xc09d73d286bfe4d4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad4, 0xc0a12e3ace9a9ad6, 0xc0a12e3ace9a9ad1, 0xc0a3a28c59d5433b, 0xc0a3a28c59d5433b, - 0xc0a3a28c59d5433b, 0xc0a3a28c59d5433d, 0xc0a3a28c59d54339, 0xc0a616dde50feba2, 0xc0a616dde50feba2, 0xc0a616dde50feba2, 0xc0a616dde50feba5, 0xc0a616dde50feba0, - 0xc0a88b2f704a940a, 0xc0a88b2f704a940a, 0xc0a88b2f704a940a, 0xc0a88b2f704a940c, 0xc0a88b2f704a9408, 0xc0aaff80fb853c71, 0xc0aaff80fb853c71, 0xc0aaff80fb853c71, - 0xc0aaff80fb853c73, 0xc0aaff80fb853c6f, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4d8, 0xc0ad73d286bfe4db, 0xc0ad73d286bfe4d6, 0xc0afe82411fa8d40, - 0xc0afe82411fa8d40, 0xc0afe82411fa8d40, 0xc0afe82411fa8d42, 0xc0afe82411fa8d3e, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad4, 0xc0b12e3ace9a9ad5, - 0xc0b12e3ace9a9ad2, 0xc0b268639437ef07, 0xc0b268639437ef07, 0xc0b268639437ef07, 0xc0b268639437ef08, 0xc0b268639437ef06, 0xc0b3a28c59d5433b, 0xc0b3a28c59d5433b, - 0xc0b3a28c59d5433b, 0xc0b3a28c59d5433c, 0xc0b3a28c59d5433a, 0xc0b4dcb51f72976f, 0xc0b4dcb51f72976f, 0xc0b4dcb51f72976f, 0xc0b4dcb51f729770, 0xc0b4dcb51f72976e, - 0xc0b616dde50feba2, 0xc0b616dde50feba2, 0xc0b616dde50feba2, 0xc0b616dde50feba3, 0xc0b616dde50feba1, 0xc0b75106aaad3fd6, 0xc0b75106aaad3fd6, 0xc0b75106aaad3fd6, - 0xc0b75106aaad3fd7, 0xc0b75106aaad3fd5, 0xc0b88b2f704a940a, 0xc0b88b2f704a940a, 0xc0b88b2f704a940a, 0xc0b88b2f704a940b, 0xc0b88b2f704a9409, 0xc0b9c55835e7e83d, - 0xc0b9c55835e7e83d, 0xc0b9c55835e7e83d, 0xc0b9c55835e7e83e, 0xc0b9c55835e7e83c, 0xc0baff80fb853c71, 0xc0baff80fb853c71, 0xc0baff80fb853c71, 0xc0baff80fb853c72, - 0xc0baff80fb853c70, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a5, 0xc0bc39a9c12290a6, 0xc0bc39a9c12290a4, 0xc0bd73d286bfe4d8, 0xc0bd73d286bfe4d8, - 0xc0bd73d286bfe4d8, 0xc0bd73d286bfe4da, 0xc0bd73d286bfe4d7, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390c, 0xc0beadfb4c5d390d, 0xc0beadfb4c5d390b, - 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d40, 0xc0bfe82411fa8d41, 0xc0bfe82411fa8d3f, 0xc0c091266bcbf0ba, 0xc0c091266bcbf0ba, 0xc0c091266bcbf0ba, - 0xc0c091266bcbf0ba, 0xc0c091266bcbf0b9, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad4, 0xc0c12e3ace9a9ad3, 0xc0c1cb4f316944ed, - 0xc0c1cb4f316944ed, 0xc0c1cb4f316944ed, 0xc0c1cb4f316944ee, 0xc0c1cb4f316944ed, 0xc0c268639437ef07, 0xc0c268639437ef07, 0xc0c268639437ef07, 0xc0c268639437ef08, - 0xc0c268639437ef07, 0xc0c30577f7069921, 0xc0c30577f7069921, 0xc0c30577f7069921, 0xc0c30577f7069922, 0xc0c30577f7069921, 0xc0c3a28c59d5433b, 0xc0c3a28c59d5433b, - 0xc0c3a28c59d5433b, 0xc0c3a28c59d5433c, 0xc0c3a28c59d5433a, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed55, 0xc0c43fa0bca3ed54, - 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976f, 0xc0c4dcb51f72976e, 0xc0c579c982414188, 0xc0c579c982414188, 0xc0c579c982414188, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3fed2f6f0efb879c, 0x3fefffffdd6862d4, 0x3fd354ef4eeb296b, 0xbfc31ae721d88897, 0x3fc50803b072659b, 0xbfef051f1616c063, 0xbfebd188b4c3ea9a, 0xbfddefa201dc4365, - 0x3feffff27cc76e6c, 0x3fefea2338506f71, 0xbfb292946dd109b8, 0x3fb46586ce99c116, 0xbfe945c70b018cca, 0x3fdc4004c876f9c8, 0xbfc3c490795a3687, 0x3feffab8e2b22112, - 0x3fe7d465c9fd8b23, 0xbfe7ed91a1aa981e, 0xbfe659959aa37055, 0x3fee5ee96a2ae1ce, 0x3fc1f4077c91589f, 0xbf94b68580d20bf8, 0x3fedf5ceebb0e676, 0x3fe0a19cc105385e, - 0x3fe1dfffaf282c79, 0xbfbf205e48aa5e43, 0xbfefefaadcb31651, 0xbfc4d7a73594d7c1, 0xbfef58f5899ce4b0, 0xbfecd6dcca389e02, 0xbfe5e190f8ecbd22, 0xbfedfd830826ec89, - 0xbfd60f5459110aa5, 0x3fe9d3ca4864fb6a, 0x3fb093aa7555aa1a, 0xbfdbf556a3739319, 0xbfcd3a973e71e730, 0xbfd4697d9419ef57, 0xbfed338cf3702a43, 0x3fedbf5b217178e9, - 0x3feffbad8aab2368, 0xbfe9837e378fb1da, 0x3fc85b7332c205cb, 0x3fe5697f73d6a01e, 0x3fefd34f5ba66292, 0xbfdea0becf4bd6d8, 0xbfe9cd7d18c9cd11, 0x3fee538a233719ed, - 0x3fef62152aa93bce, 0x3fd59250bc766e05, 0xbfe0003bdcbb5867, 0x3fe00f77e53d2b20, 0xbfd18c960b364ae8, 0x3feff78554f1430f, 0xbfefd134af6e8276, 0xbfd8ae26649a794f, - 0x3fee9b0ff3d9ae3b, 0xbfe0025692312ac2, 0xbfe099cb4114749e, 0x3fede763c8ee17df, 0x3fecbe77dcb0cc2e, 0x3fdec395f14cad52, 0x3fe5e4e0f0f150d0, 0xbfef7d72968bb5b6, - 0xbfe0175c92d67335, 0xbfe59e76ee01d8ab, 0xbfec1d1d8d3591af, 0xbfc4aa11d86885a6, 0xbfd30910683f3a93, 0xbfd4135721db8fe3, 0xbfcb8b67f21fcee2, 0xbfe0e7926ce82753, - 0xbfdb0b733d217050, 0x3fd0e79ac03aeb41, 0x3fa9f2a3d88e7f28, 0x3fefc37ea5658871, 0x3feff6234baa481f, 0x3fe2049a95f69b22, 0xbfe81bca40e52323, 0x3fd5eb3320f09276, - 0x3fec8d3cee73e810, 0xbfebf97265c912a8, 0x3fd6399b4ab1a90d, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 23040 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0xc0c579c982414189, 0xc0c579c982414188, 0xc0c616dde50feba2, 0xc0c616dde50feba2, 0xc0c616dde50feba2, 0xc0c616dde50feba3, 0xc0c616dde50feba2, 0xc0c6b3f247de95bc, - 0xc0c6b3f247de95bc, 0xc0c6b3f247de95bc, 0xc0c6b3f247de95bd, 0xc0c6b3f247de95bc, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd6, 0xc0c75106aaad3fd7, - 0xc0c75106aaad3fd5, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9f0, 0xc0c7ee1b0d7be9ef, 0xc0c88b2f704a940a, 0xc0c88b2f704a940a, - 0xc0c88b2f704a940a, 0xc0c88b2f704a940a, 0xc0c88b2f704a9409, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e24, 0xc0c92843d3193e23, - 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83d, 0xc0c9c55835e7e83e, 0xc0c9c55835e7e83d, 0xc0ca626c98b69257, 0xc0ca626c98b69257, 0xc0ca626c98b69257, - 0xc0ca626c98b69258, 0xc0ca626c98b69257, 0xc0caff80fb853c71, 0xc0caff80fb853c71, 0xc0caff80fb853c71, 0xc0caff80fb853c72, 0xc0caff80fb853c71, 0xc0cb9c955e53e68b, - 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68b, 0xc0cb9c955e53e68a, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, 0xc0cc39a9c12290a5, - 0xc0cc39a9c12290a4, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abf, 0xc0ccd6be23f13abe, 0xc0cd73d286bfe4d8, 0xc0cd73d286bfe4d8, - 0xc0cd73d286bfe4d8, 0xc0cd73d286bfe4d9, 0xc0cd73d286bfe4d8, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef2, 0xc0ce10e6e98e8ef3, 0xc0ce10e6e98e8ef2, - 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390c, 0xc0ceadfb4c5d390d, 0xc0ceadfb4c5d390c, 0xc0cf4b0faf2be326, 0xc0cf4b0faf2be326, 0xc0cf4b0faf2be326, - 0xc0cf4b0faf2be327, 0xc0cf4b0faf2be325, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d40, 0xc0cfe82411fa8d3f, 0xc0d0429c3a649bad, - 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d0429c3a649bad, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, 0xc0d091266bcbf0ba, - 0xc0d091266bcbf0b9, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c7, 0xc0d0dfb09d3345c6, 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad4, - 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad4, 0xc0d12e3ace9a9ad3, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe1, 0xc0d17cc50001efe0, - 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ed, 0xc0d1cb4f316944ee, 0xc0d1cb4f316944ed, 0xc0d219d962d099fa, 0xc0d219d962d099fa, 0xc0d219d962d099fa, - 0xc0d219d962d099fb, 0xc0d219d962d099fa, 0xc0d268639437ef07, 0xc0d268639437ef07, 0xc0d268639437ef07, 0xc0d268639437ef08, 0xc0d268639437ef07, 0xc0d2b6edc59f4414, - 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d2b6edc59f4414, 0xc0d30577f7069921, 0xc0d30577f7069921, 0xc0d30577f7069921, 0xc0d30577f7069921, - 0xc0d30577f7069921, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d35402286dee2e, 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, - 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, 0xc0d3a28c59d5433b, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, 0xc0d3f1168b3c9848, - 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d43fa0bca3ed55, 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4262, - 0xc0d48e2aee0b4262, 0xc0d48e2aee0b4261, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976f, 0xc0d4dcb51f72976e, 0xc0d52b3f50d9ec7c, - 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7c, 0xc0d52b3f50d9ec7b, 0xc0d579c982414188, 0xc0d579c982414188, 0xc0d579c982414188, 0xc0d579c982414189, - 0xc0d579c982414188, 0xc0d5c853b3a89695, 0xc0d5c853b3a89695, 0xc0d5c853b3a89695, 0xc0d5c853b3a89696, 0xc0d5c853b3a89695, 0xc0d616dde50feba2, 0xc0d616dde50feba2, - 0xc0d616dde50feba2, 0xc0d616dde50feba3, 0xc0d616dde50feba2, 0xc0d66568167740af, 0xc0d66568167740af, 0xc0d66568167740af, 0xc0d66568167740b0, 0xc0d66568167740af, - 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d6b3f247de95bc, 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, - 0xc0d7027c7945eac9, 0xc0d7027c7945eac9, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d75106aaad3fd6, 0xc0d79f90dc1494e3, - 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d79f90dc1494e3, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, 0xc0d7ee1b0d7be9f0, - 0xc0d7ee1b0d7be9f0, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d83ca53ee33efd, 0xc0d88b2f704a940a, 0xc0d88b2f704a940a, - 0xc0d88b2f704a940a, 0xc0d88b2f704a940a, 0xc0d88b2f704a9409, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e917, 0xc0d8d9b9a1b1e916, - 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e24, 0xc0d92843d3193e23, 0xc0d976ce04809330, 0xc0d976ce04809330, 0xc0d976ce04809330, - 0xc0d976ce04809331, 0xc0d976ce04809330, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83d, 0xc0d9c55835e7e83e, 0xc0d9c55835e7e83d, 0xc0da13e2674f3d4a, - 0xc0da13e2674f3d4a, 0xc0da13e2674f3d4a, 0xc0da13e2674f3d4b, 0xc0da13e2674f3d4a, 0xc0da626c98b69257, 0xc0da626c98b69257, 0xc0da626c98b69257, 0xc0da626c98b69258, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), - -################ chunk 23552 ################ - ( bitcast(float64_t, Vec(uint64_t)( [ - 0xc0da626c98b69257, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0dab0f6ca1de764, 0xc0daff80fb853c71, 0xc0daff80fb853c71, - 0xc0daff80fb853c71, 0xc0daff80fb853c71, 0xc0daff80fb853c71, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, 0xc0db4e0b2cec917e, - 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0db9c955e53e68b, 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, - 0xc0dbeb1f8fbb3b98, 0xc0dbeb1f8fbb3b98, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a5, 0xc0dc39a9c12290a4, 0xc0dc8833f289e5b2, - 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b2, 0xc0dc8833f289e5b1, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, 0xc0dcd6be23f13abf, - 0xc0dcd6be23f13abe, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcc, 0xc0dd254855588fcb, 0xc0dd73d286bfe4d8, 0xc0dd73d286bfe4d8, - 0xc0dd73d286bfe4d8, 0xc0dd73d286bfe4d9, 0xc0dd73d286bfe4d8, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e5, 0xc0ddc25cb82739e6, 0xc0ddc25cb82739e5, - 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef2, 0xc0de10e6e98e8ef3, 0xc0de10e6e98e8ef2, 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, - 0xc0de5f711af5e3ff, 0xc0de5f711af5e3ff, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0deadfb4c5d390c, 0xc0defc857dc48e19, - 0x4330000000000000, 0x4330000000000001, 0x432ffffffffffffe, 0x4340000000000000, 0x433fffffffffffff, 0x43265286144ada42, 0x432350869d91c44a, 0x431418e104164f9c, - 0x401921fb54442d18, 0x402921fb54442d18, 0x403921fb54442d18, 0x4127f7eac1891f4d, 0x415df5e7364f130d, 0x5fe7dddf6b095ff1, 0x601dd55745cbb7ed, 0x6052a5568b9f52f4, - 0x7fefffffffffffff, 0x7fdfffffffffffff, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5433b, 0x4073a28c59d5434d, 0x4073a28c59d54329, 0x4083a28c59d5433b, - 0x4083a28c59d5433b, 0x4083a28c59d5433b, 0x4083a28c59d54344, 0x4083a28c59d54332, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4d8, 0x408d73d286bfe4e1, - 0x408d73d286bfe4d0, 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433b, 0x4093a28c59d5433f, 0x4093a28c59d54337, 0x40988b2f704a940a, 0x40988b2f704a940a, - 0x40988b2f704a940a, 0x40988b2f704a940e, 0x40988b2f704a9405, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4d8, 0x409d73d286bfe4dd, 0x409d73d286bfe4d4, - 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad4, 0x40a12e3ace9a9ad6, 0x40a12e3ace9a9ad1, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, 0x40a3a28c59d5433b, - 0x40a3a28c59d5433d, 0x40a3a28c59d54339, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba2, 0x40a616dde50feba5, 0x40a616dde50feba0, 0x40a88b2f704a940a, - 0x40a88b2f704a940a, 0x40a88b2f704a940a, 0x40a88b2f704a940c, 0x40a88b2f704a9408, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c71, 0x40aaff80fb853c73, - 0x40aaff80fb853c6f, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4d8, 0x40ad73d286bfe4db, 0x40ad73d286bfe4d6, 0x40afe82411fa8d40, 0x40afe82411fa8d40, - 0x40afe82411fa8d40, 0x40afe82411fa8d42, 0x40afe82411fa8d3e, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad4, 0x40b12e3ace9a9ad5, 0x40b12e3ace9a9ad2, - 0x40b268639437ef07, 0x40b268639437ef07, 0x40b268639437ef07, 0x40b268639437ef08, 0x40b268639437ef06, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, 0x40b3a28c59d5433b, - 0x40b3a28c59d5433c, 0x40b3a28c59d5433a, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f72976f, 0x40b4dcb51f729770, 0x40b4dcb51f72976e, 0x40b616dde50feba2, - 0x40b616dde50feba2, 0x40b616dde50feba2, 0x40b616dde50feba3, 0x40b616dde50feba1, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd6, 0x40b75106aaad3fd7, - 0x40b75106aaad3fd5, 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940a, 0x40b88b2f704a940b, 0x40b88b2f704a9409, 0x40b9c55835e7e83d, 0x40b9c55835e7e83d, - 0x40b9c55835e7e83d, 0x40b9c55835e7e83e, 0x40b9c55835e7e83c, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c71, 0x40baff80fb853c72, 0x40baff80fb853c70, - 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, 0x40bc39a9c12290a5, 0x40bc39a9c12290a6, 0x40bc39a9c12290a4, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, 0x40bd73d286bfe4d8, - 0x40bd73d286bfe4da, 0x40bd73d286bfe4d7, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390c, 0x40beadfb4c5d390d, 0x40beadfb4c5d390b, 0x40bfe82411fa8d40, - 0x40bfe82411fa8d40, 0x40bfe82411fa8d40, 0x40bfe82411fa8d41, 0x40bfe82411fa8d3f, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, 0x40c091266bcbf0ba, - 0x40c091266bcbf0b9, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad4, 0x40c12e3ace9a9ad3, 0x40c1cb4f316944ed, 0x40c1cb4f316944ed, - 0x40c1cb4f316944ed, 0x40c1cb4f316944ee, 0x40c1cb4f316944ed, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef07, 0x40c268639437ef08, 0x40c268639437ef07, - 0x40c30577f7069921, 0x40c30577f7069921, 0x40c30577f7069921, 0x40c30577f7069922, 0x40c30577f7069921, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, 0x40c3a28c59d5433b, - 0x40c3a28c59d5433c, 0x40c3a28c59d5433a, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed55, 0x40c43fa0bca3ed54, 0x40c4dcb51f72976f, -] )), bitcast(float64_t, Vec(uint64_t)( [ - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0xbfdf1300d681503f, 0xbfefef526a39c993, 0x3fde4a6e3ea69b14, 0xbfe0e9918bb35aac, 0xbfefff33f44e67c2, 0x3fef182f56d0a5a4, 0xbfeff9e26bf38768, 0xbfeff108c736c908, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3fe6a09e667cc390, 0x3fe6a09e66629663, 0x3feeac4e86fbcb5d, 0xbfeffb11b8b828dc, 0x3fc718b841bb6d99, - 0xbfefffe62ecfab75, 0x3f645300b2210ee6, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, - 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, 0x3ff0000000000000, -] )) ), -] -cos_float32_t = [ - -################ chunk 0 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x441d1463, 0x441d1463, 0x441d1463, - 0x441d1463, 0x441d1463, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x449d1463, - 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x44c4597c, 0x44c4597c, 0x44c4597c, 0x44c4597c, - 0x44c4597c, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x450971d6, 0x450971d6, - 0x450971d6, 0x450971d6, 0x450971d6, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, - 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4544597c, 0x4544597c, 0x4544597c, - 0x4544597c, 0x4544597c, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x456b9e94, - 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x457f4121, 0x457f4121, 0x457f4121, 0x457f4121, - 0x457f4121, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x4593431d, 0x4593431d, - 0x4593431d, 0x4593431d, 0x4593431d, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, - 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45b0b6ef, 0x45b0b6ef, 0x45b0b6ef, - 0x45b0b6ef, 0x45b0b6ef, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45c4597c, - 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, - 0x45ce2ac2, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45e1cd4e, 0x45e1cd4e, - 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, - 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45ff4121, 0x45ff4121, 0x45ff4121, - 0x45ff4121, 0x45ff4121, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x460971d6, - 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, - 0x460e5a7a, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x46182bc0, 0x46182bc0, - 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, - 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4626e5a9, 0x4626e5a9, 0x4626e5a9, - 0x4626e5a9, 0x4626e5a9, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x4630b6ef, - 0x4630b6ef, 0x4630b6ef, 0x4630b6ef, 0x4630b6ef, 0x46359f92, 0x46359f92, 0x46359f92, 0x46359f92, - 0x46359f92, 0x463a8835, 0x463a8835, 0x463a8835, 0x463a8835, 0x463a8835, 0x463f70d8, 0x463f70d8, - 0x463f70d8, 0x463f70d8, 0x463f70d8, 0x4644597c, 0x4644597c, 0x4644597c, 0x4644597c, 0x4644597c, - 0x4649421f, 0x4649421f, 0x4649421f, 0x4649421f, 0x4649421f, 0x464e2ac2, 0x464e2ac2, 0x464e2ac2, - 0x464e2ac2, 0x464e2ac2, 0x46531365, 0x46531365, 0x46531365, 0x46531365, 0x46531365, 0x4657fc08, - 0x4657fc08, 0x4657fc08, 0x4657fc08, 0x4657fc08, 0x465ce4ab, 0x465ce4ab, 0x465ce4ab, 0x465ce4ab, - 0x465ce4ab, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4661cd4e, 0x4666b5f1, 0x4666b5f1, - 0x4666b5f1, 0x4666b5f1, 0x4666b5f1, 0x466b9e94, 0x466b9e94, 0x466b9e94, 0x466b9e94, 0x466b9e94, - 0x46708737, 0x46708737, 0x46708737, 0x46708737, 0x46708737, 0x46756fda, 0x46756fda, 0x46756fda, - 0x46756fda, 0x46756fda, 0x467a587d, 0x467a587d, 0x467a587d, 0x467a587d, 0x467a587d, 0x467f4121, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, -] )) ), - -################ chunk 512 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x467f4121, 0x467f4121, 0x467f4121, 0x467f4121, 0x468214e2, 0x468214e2, 0x468214e2, 0x468214e2, - 0x468214e2, 0x46848933, 0x46848933, 0x46848933, 0x46848933, 0x46848933, 0x4686fd85, 0x4686fd85, - 0x4686fd85, 0x4686fd85, 0x4686fd85, 0x468971d6, 0x468971d6, 0x468971d6, 0x468971d6, 0x468971d6, - 0x468be628, 0x468be628, 0x468be628, 0x468be628, 0x468be628, 0x468e5a7a, 0x468e5a7a, 0x468e5a7a, - 0x468e5a7a, 0x468e5a7a, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4690cecb, 0x4693431d, - 0x4693431d, 0x4693431d, 0x4693431d, 0x4693431d, 0x4695b76e, 0x4695b76e, 0x4695b76e, 0x4695b76e, - 0x4695b76e, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x46982bc0, 0x469aa011, 0x469aa011, - 0x469aa011, 0x469aa011, 0x469aa011, 0x469d1463, 0x469d1463, 0x469d1463, 0x469d1463, 0x469d1463, - 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x469f88b4, 0x46a1fd06, 0x46a1fd06, 0x46a1fd06, - 0x46a1fd06, 0x46a1fd06, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a47157, 0x46a6e5a9, - 0x46a6e5a9, 0x46a6e5a9, 0x46a6e5a9, 0x46a6e5a9, 0x46a959fb, 0x46a959fb, 0x46a959fb, 0x46a959fb, - 0x46a959fb, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46abce4c, 0x46ae429e, 0x46ae429e, - 0x46ae429e, 0x46ae429e, 0x46ae429e, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, 0x46b0b6ef, - 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b32b41, 0x46b59f92, 0x46b59f92, 0x46b59f92, - 0x46b59f92, 0x46b59f92, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46b813e4, 0x46ba8835, - 0x46ba8835, 0x46ba8835, 0x46ba8835, 0x46ba8835, 0x46bcfc87, 0x46bcfc87, 0x46bcfc87, 0x46bcfc87, - 0x46bcfc87, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46bf70d8, 0x46c1e52a, 0x46c1e52a, - 0x46c1e52a, 0x46c1e52a, 0x46c1e52a, 0x46c4597c, 0x46c4597c, 0x46c4597c, 0x46c4597c, 0x46c4597c, - 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c6cdcd, 0x46c9421f, 0x46c9421f, 0x46c9421f, - 0x46c9421f, 0x46c9421f, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46cbb670, 0x46ce2ac2, - 0x46ce2ac2, 0x46ce2ac2, 0x46ce2ac2, 0x46ce2ac2, 0x46d09f13, 0x46d09f13, 0x46d09f13, 0x46d09f13, - 0x46d09f13, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d31365, 0x46d587b6, 0x46d587b6, - 0x46d587b6, 0x46d587b6, 0x46d587b6, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, 0x46d7fc08, - 0x46da7059, 0x46da7059, 0x46da7059, 0x46da7059, 0x46da7059, 0x46dce4ab, 0x46dce4ab, 0x46dce4ab, - 0x46dce4ab, 0x46dce4ab, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46df58fc, 0x46e1cd4e, - 0x46e1cd4e, 0x46e1cd4e, 0x46e1cd4e, 0x46e1cd4e, 0x46e441a0, 0x46e441a0, 0x46e441a0, 0x46e441a0, - 0x46e441a0, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e6b5f1, 0x46e92a43, 0x46e92a43, - 0x46e92a43, 0x46e92a43, 0x46e92a43, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, 0x46eb9e94, - 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46ee12e6, 0x46f08737, 0x46f08737, 0x46f08737, - 0x46f08737, 0x46f08737, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f2fb89, 0x46f56fda, - 0x46f56fda, 0x46f56fda, 0x46f56fda, 0x46f56fda, 0x46f7e42c, 0x46f7e42c, 0x46f7e42c, 0x46f7e42c, - 0x46f7e42c, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fa587d, 0x46fccccf, 0x46fccccf, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, - 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, - 0x3f7ffffb, 0x3f7ffffb, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffb, - 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, 0x3f800000, -] )) ), - -################ chunk 1024 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x46fccccf, 0x46fccccf, 0x46fccccf, 0x46ff4121, 0x46ff4121, 0x46ff4121, 0x46ff4121, 0x46ff4121, - 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x4700dab9, 0x470214e2, 0x470214e2, 0x470214e2, - 0x470214e2, 0x470214e2, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47034f0b, 0x47048933, - 0x47048933, 0x47048933, 0x47048933, 0x47048933, 0x4705c35c, 0x4705c35c, 0x4705c35c, 0x4705c35c, - 0x4705c35c, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x4706fd85, 0x470837ae, 0x470837ae, - 0x470837ae, 0x470837ae, 0x470837ae, 0x470971d6, 0x470971d6, 0x470971d6, 0x470971d6, 0x470971d6, - 0x470aabff, 0x470aabff, 0x470aabff, 0x470aabff, 0x470aabff, 0x470be628, 0x470be628, 0x470be628, - 0x470be628, 0x470be628, 0x470d2051, 0x470d2051, 0x470d2051, 0x470d2051, 0x470d2051, 0x470e5a7a, - 0x470e5a7a, 0x470e5a7a, 0x470e5a7a, 0x470e5a7a, 0x470f94a2, 0x470f94a2, 0x470f94a2, 0x470f94a2, - 0x470f94a2, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x4710cecb, 0x471208f4, 0x471208f4, - 0x471208f4, 0x471208f4, 0x471208f4, 0x4713431d, 0x4713431d, 0x4713431d, 0x4713431d, 0x4713431d, - 0x47147d45, 0x47147d45, 0x47147d45, 0x47147d45, 0x47147d45, 0x4715b76e, 0x4715b76e, 0x4715b76e, - 0x4715b76e, 0x4715b76e, 0x4716f197, 0x4716f197, 0x4716f197, 0x4716f197, 0x4716f197, 0x47182bc0, - 0x47182bc0, 0x47182bc0, 0x47182bc0, 0x47182bc0, 0x471965e8, 0x471965e8, 0x471965e8, 0x471965e8, - 0x471965e8, 0x471aa011, 0x471aa011, 0x471aa011, 0x471aa011, 0x471aa011, 0x471bda3a, 0x471bda3a, - 0x471bda3a, 0x471bda3a, 0x471bda3a, 0x471d1463, 0x471d1463, 0x471d1463, 0x471d1463, 0x471d1463, - 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471e4e8c, 0x471f88b4, 0x471f88b4, 0x471f88b4, - 0x471f88b4, 0x471f88b4, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4720c2dd, 0x4721fd06, - 0x4721fd06, 0x4721fd06, 0x4721fd06, 0x4721fd06, 0x4723372f, 0x4723372f, 0x4723372f, 0x4723372f, - 0x4723372f, 0x47247157, 0x47247157, 0x47247157, 0x47247157, 0x47247157, 0x4725ab80, 0x4725ab80, - 0x4725ab80, 0x4725ab80, 0x4725ab80, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, 0x4726e5a9, - 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x47281fd2, 0x472959fb, 0x472959fb, 0x472959fb, - 0x472959fb, 0x472959fb, 0x472a9423, 0x472a9423, 0x472a9423, 0x472a9423, 0x472a9423, 0x472bce4c, - 0x472bce4c, 0x472bce4c, 0x472bce4c, 0x472bce4c, 0x472d0875, 0x472d0875, 0x472d0875, 0x472d0875, - 0x472d0875, 0x472e429e, 0x472e429e, 0x472e429e, 0x472e429e, 0x472e429e, 0x472f7cc6, 0x472f7cc6, - 0x472f7cc6, 0x472f7cc6, 0x472f7cc6, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, 0x4730b6ef, - 0x4731f118, 0x4731f118, 0x4731f118, 0x4731f118, 0x4731f118, 0x47332b41, 0x47332b41, 0x47332b41, - 0x47332b41, 0x47332b41, 0x47346569, 0x47346569, 0x47346569, 0x47346569, 0x47346569, 0x47359f92, - 0x47359f92, 0x47359f92, 0x47359f92, 0x47359f92, 0x4736d9bb, 0x4736d9bb, 0x4736d9bb, 0x4736d9bb, - 0x4736d9bb, 0x473813e4, 0x473813e4, 0x473813e4, 0x473813e4, 0x473813e4, 0x47394e0d, 0x47394e0d, - 0x47394e0d, 0x47394e0d, 0x47394e0d, 0x473a8835, 0x473a8835, 0x473a8835, 0x473a8835, 0x473a8835, - 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473bc25e, 0x473cfc87, 0x473cfc87, 0x473cfc87, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffef, - 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffff3, 0x3f7ffff3, - 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, - 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7fffe5, - 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, - 0x3f7ffff3, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, - 0x3f7ffff2, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, - 0x3f7fffe3, 0x3f7fffe3, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, - 0x3f7ffff5, 0x3f7ffff5, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7ffff8, - 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffe7, 0x3f7fffe7, - 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, -] )) ), - -################ chunk 1536 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x473cfc87, 0x473cfc87, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473e36b0, 0x473f70d8, - 0x473f70d8, 0x473f70d8, 0x473f70d8, 0x473f70d8, 0x4740ab01, 0x4740ab01, 0x4740ab01, 0x4740ab01, - 0x4740ab01, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x4741e52a, 0x47431f53, 0x47431f53, - 0x47431f53, 0x47431f53, 0x47431f53, 0x4744597c, 0x4744597c, 0x4744597c, 0x4744597c, 0x4744597c, - 0x474593a4, 0x474593a4, 0x474593a4, 0x474593a4, 0x474593a4, 0x4746cdcd, 0x4746cdcd, 0x4746cdcd, - 0x4746cdcd, 0x4746cdcd, 0x474807f6, 0x474807f6, 0x474807f6, 0x474807f6, 0x474807f6, 0x4749421f, - 0x4749421f, 0x4749421f, 0x4749421f, 0x4749421f, 0x474a7c47, 0x474a7c47, 0x474a7c47, 0x474a7c47, - 0x474a7c47, 0x474bb670, 0x474bb670, 0x474bb670, 0x474bb670, 0x474bb670, 0x474cf099, 0x474cf099, - 0x474cf099, 0x474cf099, 0x474cf099, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, 0x474e2ac2, - 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x474f64ea, 0x47509f13, 0x47509f13, 0x47509f13, - 0x47509f13, 0x47509f13, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x4751d93c, 0x47531365, - 0x47531365, 0x47531365, 0x47531365, 0x47531365, 0x47544d8e, 0x47544d8e, 0x47544d8e, 0x47544d8e, - 0x47544d8e, 0x475587b6, 0x475587b6, 0x475587b6, 0x475587b6, 0x475587b6, 0x4756c1df, 0x4756c1df, - 0x4756c1df, 0x4756c1df, 0x4756c1df, 0x4757fc08, 0x4757fc08, 0x4757fc08, 0x4757fc08, 0x4757fc08, - 0x47593631, 0x47593631, 0x47593631, 0x47593631, 0x47593631, 0x475a7059, 0x475a7059, 0x475a7059, - 0x475a7059, 0x475a7059, 0x475baa82, 0x475baa82, 0x475baa82, 0x475baa82, 0x475baa82, 0x475ce4ab, - 0x475ce4ab, 0x475ce4ab, 0x475ce4ab, 0x475ce4ab, 0x475e1ed4, 0x475e1ed4, 0x475e1ed4, 0x475e1ed4, - 0x475e1ed4, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x475f58fc, 0x47609325, 0x47609325, - 0x47609325, 0x47609325, 0x47609325, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, 0x4761cd4e, - 0x47630777, 0x47630777, 0x47630777, 0x47630777, 0x47630777, 0x476441a0, 0x476441a0, 0x476441a0, - 0x476441a0, 0x476441a0, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x47657bc8, 0x4766b5f1, - 0x4766b5f1, 0x4766b5f1, 0x4766b5f1, 0x4766b5f1, 0x4767f01a, 0x4767f01a, 0x4767f01a, 0x4767f01a, - 0x4767f01a, 0x47692a43, 0x47692a43, 0x47692a43, 0x47692a43, 0x47692a43, 0x476a646b, 0x476a646b, - 0x476a646b, 0x476a646b, 0x476a646b, 0x476b9e94, 0x476b9e94, 0x476b9e94, 0x476b9e94, 0x476b9e94, - 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476cd8bd, 0x476e12e6, 0x476e12e6, 0x476e12e6, - 0x476e12e6, 0x476e12e6, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x476f4d0f, 0x47708737, - 0x47708737, 0x47708737, 0x47708737, 0x47708737, 0x4771c160, 0x4771c160, 0x4771c160, 0x4771c160, - 0x4771c160, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x4772fb89, 0x477435b2, 0x477435b2, - 0x477435b2, 0x477435b2, 0x477435b2, 0x47756fda, 0x47756fda, 0x47756fda, 0x47756fda, 0x47756fda, - 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4776aa03, 0x4777e42c, 0x4777e42c, 0x4777e42c, - 0x4777e42c, 0x4777e42c, 0x47791e55, 0x47791e55, 0x47791e55, 0x47791e55, 0x47791e55, 0x477a587d, - 0x477a587d, 0x477a587d, 0x477a587d, 0x477a587d, 0x477b92a6, 0x477b92a6, 0x477b92a6, 0x477b92a6, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, - 0x3f7ffffb, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffeb, - 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, - 0x3f7fffef, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, - 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, - 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, - 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, - 0x3f7fffeb, 0x3f7fffeb, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7ffff2, 0x3f7fffe7, 0x3f7fffe7, - 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, - 0x3f7ffff8, 0x3f7ffff8, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7ffff5, - 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7ffff5, 0x3f7fffe3, - 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, -] )) ), - -################ chunk 2048 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x477b92a6, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477e06f8, 0x477e06f8, - 0x477e06f8, 0x477e06f8, 0x477e06f8, 0x477f4121, 0x477f4121, 0x477f4121, 0x477f4121, 0x477f4121, - 0x47803da5, 0x47803da5, 0x47803da5, 0x47803da5, 0x47803da5, 0x4780dab9, 0x4780dab9, 0x4780dab9, - 0x4780dab9, 0x4780dab9, 0x478177cd, 0x478177cd, 0x478177cd, 0x478177cd, 0x478177cd, 0x478214e2, - 0x478214e2, 0x478214e2, 0x478214e2, 0x478214e2, 0x4782b1f6, 0x4782b1f6, 0x4782b1f6, 0x4782b1f6, - 0x4782b1f6, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x47834f0b, 0x4783ec1f, 0x4783ec1f, - 0x4783ec1f, 0x4783ec1f, 0x4783ec1f, 0x47848933, 0x47848933, 0x47848933, 0x47848933, 0x47848933, - 0x47852648, 0x47852648, 0x47852648, 0x47852648, 0x47852648, 0x4785c35c, 0x4785c35c, 0x4785c35c, - 0x4785c35c, 0x4785c35c, 0x47866071, 0x47866071, 0x47866071, 0x47866071, 0x47866071, 0x4786fd85, - 0x4786fd85, 0x4786fd85, 0x4786fd85, 0x4786fd85, 0x47879a99, 0x47879a99, 0x47879a99, 0x47879a99, - 0x47879a99, 0x478837ae, 0x478837ae, 0x478837ae, 0x478837ae, 0x478837ae, 0x4788d4c2, 0x4788d4c2, - 0x4788d4c2, 0x4788d4c2, 0x4788d4c2, 0x478971d6, 0x478971d6, 0x478971d6, 0x478971d6, 0x478971d6, - 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478a0eeb, 0x478aabff, 0x478aabff, 0x478aabff, - 0x478aabff, 0x478aabff, 0x478b4914, 0x478b4914, 0x478b4914, 0x478b4914, 0x478b4914, 0x478be628, - 0x478be628, 0x478be628, 0x478be628, 0x478be628, 0x478c833c, 0x478c833c, 0x478c833c, 0x478c833c, - 0x478c833c, 0x478d2051, 0x478d2051, 0x478d2051, 0x478d2051, 0x478d2051, 0x478dbd65, 0x478dbd65, - 0x478dbd65, 0x478dbd65, 0x478dbd65, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, 0x478e5a7a, - 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478ef78e, 0x478f94a2, 0x478f94a2, 0x478f94a2, - 0x478f94a2, 0x478f94a2, 0x479031b7, 0x479031b7, 0x479031b7, 0x479031b7, 0x479031b7, 0x4790cecb, - 0x4790cecb, 0x4790cecb, 0x4790cecb, 0x4790cecb, 0x47916bdf, 0x47916bdf, 0x47916bdf, 0x47916bdf, - 0x47916bdf, 0x479208f4, 0x479208f4, 0x479208f4, 0x479208f4, 0x479208f4, 0x4792a608, 0x4792a608, - 0x4792a608, 0x4792a608, 0x4792a608, 0x4793431d, 0x4793431d, 0x4793431d, 0x4793431d, 0x4793431d, - 0x4793e031, 0x4793e031, 0x4793e031, 0x4793e031, 0x4793e031, 0x47947d45, 0x47947d45, 0x47947d45, - 0x47947d45, 0x47947d45, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x47951a5a, 0x4795b76e, - 0x4795b76e, 0x4795b76e, 0x4795b76e, 0x4795b76e, 0x47965483, 0x47965483, 0x47965483, 0x47965483, - 0x47965483, 0x4796f197, 0x4796f197, 0x4796f197, 0x4796f197, 0x4796f197, 0x47978eab, 0x47978eab, - 0x47978eab, 0x47978eab, 0x47978eab, 0x47982bc0, 0x47982bc0, 0x47982bc0, 0x47982bc0, 0x47982bc0, - 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x4798c8d4, 0x479965e8, 0x479965e8, 0x479965e8, - 0x479965e8, 0x479965e8, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479a02fd, 0x479aa011, - 0x479aa011, 0x479aa011, 0x479aa011, 0x479aa011, 0x479b3d26, 0x479b3d26, 0x479b3d26, 0x479b3d26, - 0x479b3d26, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479bda3a, 0x479c774e, 0x479c774e, - 0x479c774e, 0x479c774e, 0x479c774e, 0x479d1463, 0x479d1463, 0x479d1463, 0x479d1463, 0x479d1463, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffff8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, 0x3f7fffe7, - 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, - 0x3f7fffd2, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, - 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, - 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, - 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, - 0x3f7fff8d, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, - 0x3f7fffad, 0x3f7fffad, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, - 0x3f7fff9e, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc7, 0x3f7fffc7, - 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, - 0x3f7fff84, 0x3f7fff84, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fffdc, - 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, -] )) ), - -################ chunk 2560 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x479db177, 0x479db177, 0x479db177, 0x479db177, 0x479db177, 0x479e4e8c, 0x479e4e8c, 0x479e4e8c, - 0x479e4e8c, 0x479e4e8c, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479eeba0, 0x479f88b4, - 0x479f88b4, 0x479f88b4, 0x479f88b4, 0x479f88b4, 0x47a025c9, 0x47a025c9, 0x47a025c9, 0x47a025c9, - 0x47a025c9, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a0c2dd, 0x47a15ff2, 0x47a15ff2, - 0x47a15ff2, 0x47a15ff2, 0x47a15ff2, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, 0x47a1fd06, - 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a29a1a, 0x47a3372f, 0x47a3372f, 0x47a3372f, - 0x47a3372f, 0x47a3372f, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a3d443, 0x47a47157, - 0x47a47157, 0x47a47157, 0x47a47157, 0x47a47157, 0x47a50e6c, 0x47a50e6c, 0x47a50e6c, 0x47a50e6c, - 0x47a50e6c, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a5ab80, 0x47a64895, 0x47a64895, - 0x47a64895, 0x47a64895, 0x47a64895, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, 0x47a6e5a9, - 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a782bd, 0x47a81fd2, 0x47a81fd2, 0x47a81fd2, - 0x47a81fd2, 0x47a81fd2, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a8bce6, 0x47a959fb, - 0x47a959fb, 0x47a959fb, 0x47a959fb, 0x47a959fb, 0x47a9f70f, 0x47a9f70f, 0x47a9f70f, 0x47a9f70f, - 0x47a9f70f, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47aa9423, 0x47ab3138, 0x47ab3138, - 0x47ab3138, 0x47ab3138, 0x47ab3138, 0x47abce4c, 0x47abce4c, 0x47abce4c, 0x47abce4c, 0x47abce4c, - 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ac6b60, 0x47ad0875, 0x47ad0875, 0x47ad0875, - 0x47ad0875, 0x47ad0875, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ada589, 0x47ae429e, - 0x47ae429e, 0x47ae429e, 0x47ae429e, 0x47ae429e, 0x47aedfb2, 0x47aedfb2, 0x47aedfb2, 0x47aedfb2, - 0x47aedfb2, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47af7cc6, 0x47b019db, 0x47b019db, - 0x47b019db, 0x47b019db, 0x47b019db, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, 0x47b0b6ef, - 0x47b15404, 0x47b15404, 0x47b15404, 0x47b15404, 0x47b15404, 0x47b1f118, 0x47b1f118, 0x47b1f118, - 0x47b1f118, 0x47b1f118, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b28e2c, 0x47b32b41, - 0x47b32b41, 0x47b32b41, 0x47b32b41, 0x47b32b41, 0x47b3c855, 0x47b3c855, 0x47b3c855, 0x47b3c855, - 0x47b3c855, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b46569, 0x47b5027e, 0x47b5027e, - 0x47b5027e, 0x47b5027e, 0x47b5027e, 0x47b59f92, 0x47b59f92, 0x47b59f92, 0x47b59f92, 0x47b59f92, - 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b63ca7, 0x47b6d9bb, 0x47b6d9bb, 0x47b6d9bb, - 0x47b6d9bb, 0x47b6d9bb, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b776cf, 0x47b813e4, - 0x47b813e4, 0x47b813e4, 0x47b813e4, 0x47b813e4, 0x47b8b0f8, 0x47b8b0f8, 0x47b8b0f8, 0x47b8b0f8, - 0x47b8b0f8, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b94e0d, 0x47b9eb21, 0x47b9eb21, - 0x47b9eb21, 0x47b9eb21, 0x47b9eb21, 0x47ba8835, 0x47ba8835, 0x47ba8835, 0x47ba8835, 0x47ba8835, - 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bb254a, 0x47bbc25e, 0x47bbc25e, 0x47bbc25e, - 0x47bbc25e, 0x47bbc25e, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bc5f72, 0x47bcfc87, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, - 0x3f7fffdd, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fff85, 0x3f7fff85, - 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, - 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fff9d, - 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffad, 0x3f7fffad, - 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff8d, - 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, - 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffb4, - 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffe5, 0x3f7fffe5, - 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, - 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffd3, - 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffff8, -] )) ), - -################ chunk 3072 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47bcfc87, 0x47bcfc87, 0x47bcfc87, 0x47bcfc87, 0x47bd999b, 0x47bd999b, 0x47bd999b, 0x47bd999b, - 0x47bd999b, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47be36b0, 0x47bed3c4, 0x47bed3c4, - 0x47bed3c4, 0x47bed3c4, 0x47bed3c4, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, 0x47bf70d8, - 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c00ded, 0x47c0ab01, 0x47c0ab01, 0x47c0ab01, - 0x47c0ab01, 0x47c0ab01, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c14816, 0x47c1e52a, - 0x47c1e52a, 0x47c1e52a, 0x47c1e52a, 0x47c1e52a, 0x47c2823e, 0x47c2823e, 0x47c2823e, 0x47c2823e, - 0x47c2823e, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c31f53, 0x47c3bc67, 0x47c3bc67, - 0x47c3bc67, 0x47c3bc67, 0x47c3bc67, 0x47c4597c, 0x47c4597c, 0x47c4597c, 0x47c4597c, 0x47c4597c, - 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c4f690, 0x47c593a4, 0x47c593a4, 0x47c593a4, - 0x47c593a4, 0x47c593a4, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c630b9, 0x47c6cdcd, - 0x47c6cdcd, 0x47c6cdcd, 0x47c6cdcd, 0x47c6cdcd, 0x47c76ae1, 0x47c76ae1, 0x47c76ae1, 0x47c76ae1, - 0x47c76ae1, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c807f6, 0x47c8a50a, 0x47c8a50a, - 0x47c8a50a, 0x47c8a50a, 0x47c8a50a, 0x47c9421f, 0x47c9421f, 0x47c9421f, 0x47c9421f, 0x47c9421f, - 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47c9df33, 0x47ca7c47, 0x47ca7c47, 0x47ca7c47, - 0x47ca7c47, 0x47ca7c47, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cb195c, 0x47cbb670, - 0x47cbb670, 0x47cbb670, 0x47cbb670, 0x47cbb670, 0x47cc5385, 0x47cc5385, 0x47cc5385, 0x47cc5385, - 0x47cc5385, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47ccf099, 0x47cd8dad, 0x47cd8dad, - 0x47cd8dad, 0x47cd8dad, 0x47cd8dad, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, 0x47ce2ac2, - 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cec7d6, 0x47cf64ea, 0x47cf64ea, 0x47cf64ea, - 0x47cf64ea, 0x47cf64ea, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d001ff, 0x47d09f13, - 0x47d09f13, 0x47d09f13, 0x47d09f13, 0x47d09f13, 0x47d13c28, 0x47d13c28, 0x47d13c28, 0x47d13c28, - 0x47d13c28, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d1d93c, 0x47d27650, 0x47d27650, - 0x47d27650, 0x47d27650, 0x47d27650, 0x47d31365, 0x47d31365, 0x47d31365, 0x47d31365, 0x47d31365, - 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d3b079, 0x47d44d8e, 0x47d44d8e, 0x47d44d8e, - 0x47d44d8e, 0x47d44d8e, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d4eaa2, 0x47d587b6, - 0x47d587b6, 0x47d587b6, 0x47d587b6, 0x47d587b6, 0x47d624cb, 0x47d624cb, 0x47d624cb, 0x47d624cb, - 0x47d624cb, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d6c1df, 0x47d75ef3, 0x47d75ef3, - 0x47d75ef3, 0x47d75ef3, 0x47d75ef3, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, 0x47d7fc08, - 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d8991c, 0x47d93631, 0x47d93631, 0x47d93631, - 0x47d93631, 0x47d93631, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47d9d345, 0x47da7059, - 0x47da7059, 0x47da7059, 0x47da7059, 0x47da7059, 0x47db0d6e, 0x47db0d6e, 0x47db0d6e, 0x47db0d6e, - 0x47db0d6e, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dbaa82, 0x47dc4797, 0x47dc4797, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, - 0x3f7fffdc, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7ffff8, 0x3f7ffff8, - 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, - 0x3f7fff9d, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, - 0x3f7fffba, 0x3f7fffba, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, - 0x3f7fff8d, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffd2, 0x3f7fffd2, - 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, - 0x3f7fff95, 0x3f7fff95, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, - 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, - 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, - 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, - 0x3f7fffd3, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fff8d, 0x3f7fff8d, - 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, - 0x3f7fffbb, 0x3f7fffbb, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffac, - 0x3f7fffac, 0x3f7fffac, 0x3f7fffac, 0x3f7fffac, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff9e, 0x3f7fff9e, -] )) ), - -################ chunk 3584 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47dc4797, 0x47dc4797, 0x47dc4797, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, 0x47dce4ab, - 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47dd81bf, 0x47de1ed4, 0x47de1ed4, 0x47de1ed4, - 0x47de1ed4, 0x47de1ed4, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47debbe8, 0x47df58fc, - 0x47df58fc, 0x47df58fc, 0x47df58fc, 0x47df58fc, 0x47dff611, 0x47dff611, 0x47dff611, 0x47dff611, - 0x47dff611, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e09325, 0x47e1303a, 0x47e1303a, - 0x47e1303a, 0x47e1303a, 0x47e1303a, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, 0x47e1cd4e, - 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e26a62, 0x47e30777, 0x47e30777, 0x47e30777, - 0x47e30777, 0x47e30777, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e3a48b, 0x47e441a0, - 0x47e441a0, 0x47e441a0, 0x47e441a0, 0x47e441a0, 0x47e4deb4, 0x47e4deb4, 0x47e4deb4, 0x47e4deb4, - 0x47e4deb4, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e57bc8, 0x47e618dd, 0x47e618dd, - 0x47e618dd, 0x47e618dd, 0x47e618dd, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, 0x47e6b5f1, - 0x47e75306, 0x47e75306, 0x47e75306, 0x47e75306, 0x47e75306, 0x47e7f01a, 0x47e7f01a, 0x47e7f01a, - 0x47e7f01a, 0x47e7f01a, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e88d2e, 0x47e92a43, - 0x47e92a43, 0x47e92a43, 0x47e92a43, 0x47e92a43, 0x47e9c757, 0x47e9c757, 0x47e9c757, 0x47e9c757, - 0x47e9c757, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47ea646b, 0x47eb0180, 0x47eb0180, - 0x47eb0180, 0x47eb0180, 0x47eb0180, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, 0x47eb9e94, - 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ec3ba9, 0x47ecd8bd, 0x47ecd8bd, 0x47ecd8bd, - 0x47ecd8bd, 0x47ecd8bd, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ed75d1, 0x47ee12e6, - 0x47ee12e6, 0x47ee12e6, 0x47ee12e6, 0x47ee12e6, 0x47eeaffa, 0x47eeaffa, 0x47eeaffa, 0x47eeaffa, - 0x47eeaffa, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47ef4d0f, 0x47efea23, 0x47efea23, - 0x47efea23, 0x47efea23, 0x47efea23, 0x47f08737, 0x47f08737, 0x47f08737, 0x47f08737, 0x47f08737, - 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1244c, 0x47f1c160, 0x47f1c160, 0x47f1c160, - 0x47f1c160, 0x47f1c160, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f25e74, 0x47f2fb89, - 0x47f2fb89, 0x47f2fb89, 0x47f2fb89, 0x47f2fb89, 0x47f3989d, 0x47f3989d, 0x47f3989d, 0x47f3989d, - 0x47f3989d, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f435b2, 0x47f4d2c6, 0x47f4d2c6, - 0x47f4d2c6, 0x47f4d2c6, 0x47f4d2c6, 0x47f56fda, 0x47f56fda, 0x47f56fda, 0x47f56fda, 0x47f56fda, - 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f60cef, 0x47f6aa03, 0x47f6aa03, 0x47f6aa03, - 0x47f6aa03, 0x47f6aa03, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f74718, 0x47f7e42c, - 0x47f7e42c, 0x47f7e42c, 0x47f7e42c, 0x47f7e42c, 0x47f88140, 0x47f88140, 0x47f88140, 0x47f88140, - 0x47f88140, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f91e55, 0x47f9bb69, 0x47f9bb69, - 0x47f9bb69, 0x47f9bb69, 0x47f9bb69, 0x47fa587d, 0x47fa587d, 0x47fa587d, 0x47fa587d, 0x47fa587d, - 0x47faf592, 0x47faf592, 0x47faf592, 0x47faf592, 0x47faf592, 0x47fb92a6, 0x47fb92a6, 0x47fb92a6, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, - 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, - 0x3f7ffff8, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffdc, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, - 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffdd, 0x3f7fffdd, - 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, - 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffc7, - 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffc7, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7fff9d, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f7fffad, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffba, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffff3, - 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, - 0x3f7fffe5, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7fffe5, 0x3f7ffff3, 0x3f7ffff3, 0x3f7ffff3, - 0x3f7ffff3, 0x3f7ffff3, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7fffd3, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, 0x3f7fff8d, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, -] )) ), - -################ chunk 4096 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47fb92a6, 0x47fb92a6, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fc2fbb, 0x47fccccf, - 0x47fccccf, 0x47fccccf, 0x47fccccf, 0x47fccccf, 0x47fd69e3, 0x47fd69e3, 0x47fd69e3, 0x47fd69e3, - 0x47fd69e3, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fe06f8, 0x47fea40c, 0x47fea40c, - 0x47fea40c, 0x47fea40c, 0x47fea40c, 0x47ff4121, 0x47ff4121, 0x47ff4121, 0x47ff4121, 0x47ff4121, - 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x47ffde35, 0x48003da5, 0x48003da5, 0x48003da5, - 0x48003da5, 0x48003da5, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x48008c2f, 0x4800dab9, - 0x4800dab9, 0x4800dab9, 0x4800dab9, 0x4800dab9, 0x48012943, 0x48012943, 0x48012943, 0x48012943, - 0x48012943, 0x480177cd, 0x480177cd, 0x480177cd, 0x480177cd, 0x480177cd, 0x4801c658, 0x4801c658, - 0x4801c658, 0x4801c658, 0x4801c658, 0x480214e2, 0x480214e2, 0x480214e2, 0x480214e2, 0x480214e2, - 0x4802636c, 0x4802636c, 0x4802636c, 0x4802636c, 0x4802636c, 0x4802b1f6, 0x4802b1f6, 0x4802b1f6, - 0x4802b1f6, 0x4802b1f6, 0x48030080, 0x48030080, 0x48030080, 0x48030080, 0x48030080, 0x48034f0b, - 0x48034f0b, 0x48034f0b, 0x48034f0b, 0x48034f0b, 0x48039d95, 0x48039d95, 0x48039d95, 0x48039d95, - 0x48039d95, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x4803ec1f, 0x48043aa9, 0x48043aa9, - 0x48043aa9, 0x48043aa9, 0x48043aa9, 0x48048933, 0x48048933, 0x48048933, 0x48048933, 0x48048933, - 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x4804d7be, 0x48052648, 0x48052648, 0x48052648, - 0x48052648, 0x48052648, 0x480574d2, 0x480574d2, 0x480574d2, 0x480574d2, 0x480574d2, 0x4805c35c, - 0x4805c35c, 0x4805c35c, 0x4805c35c, 0x4805c35c, 0x480611e6, 0x480611e6, 0x480611e6, 0x480611e6, - 0x480611e6, 0x48066071, 0x48066071, 0x48066071, 0x48066071, 0x48066071, 0x4806aefb, 0x4806aefb, - 0x4806aefb, 0x4806aefb, 0x4806aefb, 0x4806fd85, 0x4806fd85, 0x4806fd85, 0x4806fd85, 0x4806fd85, - 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48074c0f, 0x48079a99, 0x48079a99, 0x48079a99, - 0x48079a99, 0x48079a99, 0x4807e923, 0x4807e923, 0x4807e923, 0x4807e923, 0x4807e923, 0x480837ae, - 0x480837ae, 0x480837ae, 0x480837ae, 0x480837ae, 0x48088638, 0x48088638, 0x48088638, 0x48088638, - 0x48088638, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4808d4c2, 0x4809234c, 0x4809234c, - 0x4809234c, 0x4809234c, 0x4809234c, 0x480971d6, 0x480971d6, 0x480971d6, 0x480971d6, 0x480971d6, - 0x4809c061, 0x4809c061, 0x4809c061, 0x4809c061, 0x4809c061, 0x480a0eeb, 0x480a0eeb, 0x480a0eeb, - 0x480a0eeb, 0x480a0eeb, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480a5d75, 0x480aabff, - 0x480aabff, 0x480aabff, 0x480aabff, 0x480aabff, 0x480afa89, 0x480afa89, 0x480afa89, 0x480afa89, - 0x480afa89, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b4914, 0x480b979e, 0x480b979e, - 0x480b979e, 0x480b979e, 0x480b979e, 0x480be628, 0x480be628, 0x480be628, 0x480be628, 0x480be628, - 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c34b2, 0x480c833c, 0x480c833c, 0x480c833c, - 0x480c833c, 0x480c833c, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480cd1c7, 0x480d2051, - 0x480d2051, 0x480d2051, 0x480d2051, 0x480d2051, 0x480d6edb, 0x480d6edb, 0x480d6edb, 0x480d6edb, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f7fffbb, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffac, 0x3f7fffac, 0x3f7fffac, 0x3f7fffac, - 0x3f7fffac, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, 0x3f7fff9e, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, - 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, - 0x3f7fff84, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffeea, 0x3f7ffeea, - 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, - 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, - 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, - 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, - 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, - 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, - 0x3f7fff4a, 0x3f7fff4a, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, - 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, - 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, - 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, - 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, - 0x3f7ffe95, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, - 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7fff96, - 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, -] )) ), - -################ chunk 4608 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x480d6edb, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480dbd65, 0x480e0bef, 0x480e0bef, - 0x480e0bef, 0x480e0bef, 0x480e0bef, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, 0x480e5a7a, - 0x480ea904, 0x480ea904, 0x480ea904, 0x480ea904, 0x480ea904, 0x480ef78e, 0x480ef78e, 0x480ef78e, - 0x480ef78e, 0x480ef78e, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f4618, 0x480f94a2, - 0x480f94a2, 0x480f94a2, 0x480f94a2, 0x480f94a2, 0x480fe32d, 0x480fe32d, 0x480fe32d, 0x480fe32d, - 0x480fe32d, 0x481031b7, 0x481031b7, 0x481031b7, 0x481031b7, 0x481031b7, 0x48108041, 0x48108041, - 0x48108041, 0x48108041, 0x48108041, 0x4810cecb, 0x4810cecb, 0x4810cecb, 0x4810cecb, 0x4810cecb, - 0x48111d55, 0x48111d55, 0x48111d55, 0x48111d55, 0x48111d55, 0x48116bdf, 0x48116bdf, 0x48116bdf, - 0x48116bdf, 0x48116bdf, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x4811ba6a, 0x481208f4, - 0x481208f4, 0x481208f4, 0x481208f4, 0x481208f4, 0x4812577e, 0x4812577e, 0x4812577e, 0x4812577e, - 0x4812577e, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812a608, 0x4812f492, 0x4812f492, - 0x4812f492, 0x4812f492, 0x4812f492, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, - 0x481391a7, 0x481391a7, 0x481391a7, 0x481391a7, 0x481391a7, 0x4813e031, 0x4813e031, 0x4813e031, - 0x4813e031, 0x4813e031, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48142ebb, 0x48147d45, - 0x48147d45, 0x48147d45, 0x48147d45, 0x48147d45, 0x4814cbd0, 0x4814cbd0, 0x4814cbd0, 0x4814cbd0, - 0x4814cbd0, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x48151a5a, 0x481568e4, 0x481568e4, - 0x481568e4, 0x481568e4, 0x481568e4, 0x4815b76e, 0x4815b76e, 0x4815b76e, 0x4815b76e, 0x4815b76e, - 0x481605f8, 0x481605f8, 0x481605f8, 0x481605f8, 0x481605f8, 0x48165483, 0x48165483, 0x48165483, - 0x48165483, 0x48165483, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816a30d, 0x4816f197, - 0x4816f197, 0x4816f197, 0x4816f197, 0x4816f197, 0x48174021, 0x48174021, 0x48174021, 0x48174021, - 0x48174021, 0x48178eab, 0x48178eab, 0x48178eab, 0x48178eab, 0x48178eab, 0x4817dd36, 0x4817dd36, - 0x4817dd36, 0x4817dd36, 0x4817dd36, 0x48182bc0, 0x48182bc0, 0x48182bc0, 0x48182bc0, 0x48182bc0, - 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x48187a4a, 0x4818c8d4, 0x4818c8d4, 0x4818c8d4, - 0x4818c8d4, 0x4818c8d4, 0x4819175e, 0x4819175e, 0x4819175e, 0x4819175e, 0x4819175e, 0x481965e8, - 0x481965e8, 0x481965e8, 0x481965e8, 0x481965e8, 0x4819b473, 0x4819b473, 0x4819b473, 0x4819b473, - 0x4819b473, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a02fd, 0x481a5187, 0x481a5187, - 0x481a5187, 0x481a5187, 0x481a5187, 0x481aa011, 0x481aa011, 0x481aa011, 0x481aa011, 0x481aa011, - 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481aee9b, 0x481b3d26, 0x481b3d26, 0x481b3d26, - 0x481b3d26, 0x481b3d26, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481b8bb0, 0x481bda3a, - 0x481bda3a, 0x481bda3a, 0x481bda3a, 0x481bda3a, 0x481c28c4, 0x481c28c4, 0x481c28c4, 0x481c28c4, - 0x481c28c4, 0x481c774e, 0x481c774e, 0x481c774e, 0x481c774e, 0x481c774e, 0x481cc5d9, 0x481cc5d9, - 0x481cc5d9, 0x481cc5d9, 0x481cc5d9, 0x481d1463, 0x481d1463, 0x481d1463, 0x481d1463, 0x481d1463, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff04, 0x3f7fff04, - 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, - 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, - 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, - 0x3f7ffe12, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, - 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe76, 0x3f7ffe76, - 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, - 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, - 0x3f7ffeb3, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, - 0x3f7ffe76, 0x3f7ffe76, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, - 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7ffe11, - 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, - 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, - 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, - 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, - 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffecf, 0x3f7ffecf, - 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, -] )) ), - -################ chunk 5120 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481d62ed, 0x481db177, 0x481db177, 0x481db177, - 0x481db177, 0x481db177, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e0001, 0x481e4e8c, - 0x481e4e8c, 0x481e4e8c, 0x481e4e8c, 0x481e4e8c, 0x481e9d16, 0x481e9d16, 0x481e9d16, 0x481e9d16, - 0x481e9d16, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481eeba0, 0x481f3a2a, 0x481f3a2a, - 0x481f3a2a, 0x481f3a2a, 0x481f3a2a, 0x481f88b4, 0x481f88b4, 0x481f88b4, 0x481f88b4, 0x481f88b4, - 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x481fd73f, 0x482025c9, 0x482025c9, 0x482025c9, - 0x482025c9, 0x482025c9, 0x48207453, 0x48207453, 0x48207453, 0x48207453, 0x48207453, 0x4820c2dd, - 0x4820c2dd, 0x4820c2dd, 0x4820c2dd, 0x4820c2dd, 0x48211167, 0x48211167, 0x48211167, 0x48211167, - 0x48211167, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x48215ff2, 0x4821ae7c, 0x4821ae7c, - 0x4821ae7c, 0x4821ae7c, 0x4821ae7c, 0x4821fd06, 0x4821fd06, 0x4821fd06, 0x4821fd06, 0x4821fd06, - 0x48224b90, 0x48224b90, 0x48224b90, 0x48224b90, 0x48224b90, 0x48229a1a, 0x48229a1a, 0x48229a1a, - 0x48229a1a, 0x48229a1a, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4822e8a4, 0x4823372f, - 0x4823372f, 0x4823372f, 0x4823372f, 0x4823372f, 0x482385b9, 0x482385b9, 0x482385b9, 0x482385b9, - 0x482385b9, 0x4823d443, 0x4823d443, 0x4823d443, 0x4823d443, 0x4823d443, 0x482422cd, 0x482422cd, - 0x482422cd, 0x482422cd, 0x482422cd, 0x48247157, 0x48247157, 0x48247157, 0x48247157, 0x48247157, - 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x4824bfe2, 0x48250e6c, 0x48250e6c, 0x48250e6c, - 0x48250e6c, 0x48250e6c, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x48255cf6, 0x4825ab80, - 0x4825ab80, 0x4825ab80, 0x4825ab80, 0x4825ab80, 0x4825fa0a, 0x4825fa0a, 0x4825fa0a, 0x4825fa0a, - 0x4825fa0a, 0x48264895, 0x48264895, 0x48264895, 0x48264895, 0x48264895, 0x4826971f, 0x4826971f, - 0x4826971f, 0x4826971f, 0x4826971f, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, 0x4826e5a9, - 0x48273433, 0x48273433, 0x48273433, 0x48273433, 0x48273433, 0x482782bd, 0x482782bd, 0x482782bd, - 0x482782bd, 0x482782bd, 0x4827d148, 0x4827d148, 0x4827d148, 0x4827d148, 0x4827d148, 0x48281fd2, - 0x48281fd2, 0x48281fd2, 0x48281fd2, 0x48281fd2, 0x48286e5c, 0x48286e5c, 0x48286e5c, 0x48286e5c, - 0x48286e5c, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x4828bce6, 0x48290b70, 0x48290b70, - 0x48290b70, 0x48290b70, 0x48290b70, 0x482959fb, 0x482959fb, 0x482959fb, 0x482959fb, 0x482959fb, - 0x4829a885, 0x4829a885, 0x4829a885, 0x4829a885, 0x4829a885, 0x4829f70f, 0x4829f70f, 0x4829f70f, - 0x4829f70f, 0x4829f70f, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a4599, 0x482a9423, - 0x482a9423, 0x482a9423, 0x482a9423, 0x482a9423, 0x482ae2ad, 0x482ae2ad, 0x482ae2ad, 0x482ae2ad, - 0x482ae2ad, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b3138, 0x482b7fc2, 0x482b7fc2, - 0x482b7fc2, 0x482b7fc2, 0x482b7fc2, 0x482bce4c, 0x482bce4c, 0x482bce4c, 0x482bce4c, 0x482bce4c, - 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c1cd6, 0x482c6b60, 0x482c6b60, 0x482c6b60, - 0x482c6b60, 0x482c6b60, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482cb9eb, 0x482d0875, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0x3f7fffb4, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffe95, - 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, - 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, - 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, - 0x3f7fff72, 0x3f7fff72, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, - 0x3f7fff33, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7fff4a, 0x3f7fff4a, - 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, - 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, - 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, - 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, 0x3f7ffe76, - 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, - 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, - 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, - 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, - 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, - 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, - 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, - 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, - 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, -] )) ), - -################ chunk 5632 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x482d0875, 0x482d0875, 0x482d0875, 0x482d0875, 0x482d56ff, 0x482d56ff, 0x482d56ff, 0x482d56ff, - 0x482d56ff, 0x482da589, 0x482da589, 0x482da589, 0x482da589, 0x482da589, 0x482df413, 0x482df413, - 0x482df413, 0x482df413, 0x482df413, 0x482e429e, 0x482e429e, 0x482e429e, 0x482e429e, 0x482e429e, - 0x482e9128, 0x482e9128, 0x482e9128, 0x482e9128, 0x482e9128, 0x482edfb2, 0x482edfb2, 0x482edfb2, - 0x482edfb2, 0x482edfb2, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f2e3c, 0x482f7cc6, - 0x482f7cc6, 0x482f7cc6, 0x482f7cc6, 0x482f7cc6, 0x482fcb51, 0x482fcb51, 0x482fcb51, 0x482fcb51, - 0x482fcb51, 0x483019db, 0x483019db, 0x483019db, 0x483019db, 0x483019db, 0x48306865, 0x48306865, - 0x48306865, 0x48306865, 0x48306865, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, 0x4830b6ef, - 0x48310579, 0x48310579, 0x48310579, 0x48310579, 0x48310579, 0x48315404, 0x48315404, 0x48315404, - 0x48315404, 0x48315404, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831a28e, 0x4831f118, - 0x4831f118, 0x4831f118, 0x4831f118, 0x4831f118, 0x48323fa2, 0x48323fa2, 0x48323fa2, 0x48323fa2, - 0x48323fa2, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x48328e2c, 0x4832dcb7, 0x4832dcb7, - 0x4832dcb7, 0x4832dcb7, 0x4832dcb7, 0x48332b41, 0x48332b41, 0x48332b41, 0x48332b41, 0x48332b41, - 0x483379cb, 0x483379cb, 0x483379cb, 0x483379cb, 0x483379cb, 0x4833c855, 0x4833c855, 0x4833c855, - 0x4833c855, 0x4833c855, 0x483416df, 0x483416df, 0x483416df, 0x483416df, 0x483416df, 0x48346569, - 0x48346569, 0x48346569, 0x48346569, 0x48346569, 0x4834b3f4, 0x4834b3f4, 0x4834b3f4, 0x4834b3f4, - 0x4834b3f4, 0x4835027e, 0x4835027e, 0x4835027e, 0x4835027e, 0x4835027e, 0x48355108, 0x48355108, - 0x48355108, 0x48355108, 0x48355108, 0x48359f92, 0x48359f92, 0x48359f92, 0x48359f92, 0x48359f92, - 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x4835ee1c, 0x48363ca7, 0x48363ca7, 0x48363ca7, - 0x48363ca7, 0x48363ca7, 0x48368b31, 0x48368b31, 0x48368b31, 0x48368b31, 0x48368b31, 0x4836d9bb, - 0x4836d9bb, 0x4836d9bb, 0x4836d9bb, 0x4836d9bb, 0x48372845, 0x48372845, 0x48372845, 0x48372845, - 0x48372845, 0x483776cf, 0x483776cf, 0x483776cf, 0x483776cf, 0x483776cf, 0x4837c55a, 0x4837c55a, - 0x4837c55a, 0x4837c55a, 0x4837c55a, 0x483813e4, 0x483813e4, 0x483813e4, 0x483813e4, 0x483813e4, - 0x4838626e, 0x4838626e, 0x4838626e, 0x4838626e, 0x4838626e, 0x4838b0f8, 0x4838b0f8, 0x4838b0f8, - 0x4838b0f8, 0x4838b0f8, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x4838ff82, 0x48394e0d, - 0x48394e0d, 0x48394e0d, 0x48394e0d, 0x48394e0d, 0x48399c97, 0x48399c97, 0x48399c97, 0x48399c97, - 0x48399c97, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x4839eb21, 0x483a39ab, 0x483a39ab, - 0x483a39ab, 0x483a39ab, 0x483a39ab, 0x483a8835, 0x483a8835, 0x483a8835, 0x483a8835, 0x483a8835, - 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483ad6c0, 0x483b254a, 0x483b254a, 0x483b254a, - 0x483b254a, 0x483b254a, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483b73d4, 0x483bc25e, - 0x483bc25e, 0x483bc25e, 0x483bc25e, 0x483bc25e, 0x483c10e8, 0x483c10e8, 0x483c10e8, 0x483c10e8, - 0x483c10e8, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483c5f72, 0x483cadfd, 0x483cadfd, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, - 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, - 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, - 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, - 0x3f7ffe95, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7ffe56, 0x3f7ffe56, 0x3f7ffe56, - 0x3f7ffe56, 0x3f7ffe56, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffe12, 0x3f7ffe12, - 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, - 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, - 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, - 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, - 0x3f7ffeea, 0x3f7ffeea, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, - 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffe77, - 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, - 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd7, 0x3f7fffd7, - 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, - 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, - 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, - 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, -] )) ), - -################ chunk 6144 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x483cadfd, 0x483cadfd, 0x483cadfd, 0x483cfc87, 0x483cfc87, 0x483cfc87, 0x483cfc87, 0x483cfc87, - 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d4b11, 0x483d999b, 0x483d999b, 0x483d999b, - 0x483d999b, 0x483d999b, 0x483de825, 0x483de825, 0x483de825, 0x483de825, 0x483de825, 0x483e36b0, - 0x483e36b0, 0x483e36b0, 0x483e36b0, 0x483e36b0, 0x483e853a, 0x483e853a, 0x483e853a, 0x483e853a, - 0x483e853a, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483ed3c4, 0x483f224e, 0x483f224e, - 0x483f224e, 0x483f224e, 0x483f224e, 0x483f70d8, 0x483f70d8, 0x483f70d8, 0x483f70d8, 0x483f70d8, - 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x483fbf63, 0x48400ded, 0x48400ded, 0x48400ded, - 0x48400ded, 0x48400ded, 0x48405c77, 0x48405c77, 0x48405c77, 0x48405c77, 0x48405c77, 0x4840ab01, - 0x4840ab01, 0x4840ab01, 0x4840ab01, 0x4840ab01, 0x4840f98b, 0x4840f98b, 0x4840f98b, 0x4840f98b, - 0x4840f98b, 0x48414816, 0x48414816, 0x48414816, 0x48414816, 0x48414816, 0x484196a0, 0x484196a0, - 0x484196a0, 0x484196a0, 0x484196a0, 0x4841e52a, 0x4841e52a, 0x4841e52a, 0x4841e52a, 0x4841e52a, - 0x484233b4, 0x484233b4, 0x484233b4, 0x484233b4, 0x484233b4, 0x4842823e, 0x4842823e, 0x4842823e, - 0x4842823e, 0x4842823e, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x4842d0c9, 0x48431f53, - 0x48431f53, 0x48431f53, 0x48431f53, 0x48431f53, 0x48436ddd, 0x48436ddd, 0x48436ddd, 0x48436ddd, - 0x48436ddd, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x4843bc67, 0x48440af1, 0x48440af1, - 0x48440af1, 0x48440af1, 0x48440af1, 0x4844597c, 0x4844597c, 0x4844597c, 0x4844597c, 0x4844597c, - 0x4844a806, 0x4844a806, 0x4844a806, 0x4844a806, 0x4844a806, 0x4844f690, 0x4844f690, 0x4844f690, - 0x4844f690, 0x4844f690, 0x4845451a, 0x4845451a, 0x4845451a, 0x4845451a, 0x4845451a, 0x484593a4, - 0x484593a4, 0x484593a4, 0x484593a4, 0x484593a4, 0x4845e22e, 0x4845e22e, 0x4845e22e, 0x4845e22e, - 0x4845e22e, 0x484630b9, 0x484630b9, 0x484630b9, 0x484630b9, 0x484630b9, 0x48467f43, 0x48467f43, - 0x48467f43, 0x48467f43, 0x48467f43, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, 0x4846cdcd, - 0x48471c57, 0x48471c57, 0x48471c57, 0x48471c57, 0x48471c57, 0x48476ae1, 0x48476ae1, 0x48476ae1, - 0x48476ae1, 0x48476ae1, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x4847b96c, 0x484807f6, - 0x484807f6, 0x484807f6, 0x484807f6, 0x484807f6, 0x48485680, 0x48485680, 0x48485680, 0x48485680, - 0x48485680, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848a50a, 0x4848f394, 0x4848f394, - 0x4848f394, 0x4848f394, 0x4848f394, 0x4849421f, 0x4849421f, 0x4849421f, 0x4849421f, 0x4849421f, - 0x484990a9, 0x484990a9, 0x484990a9, 0x484990a9, 0x484990a9, 0x4849df33, 0x4849df33, 0x4849df33, - 0x4849df33, 0x4849df33, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a2dbd, 0x484a7c47, - 0x484a7c47, 0x484a7c47, 0x484a7c47, 0x484a7c47, 0x484acad2, 0x484acad2, 0x484acad2, 0x484acad2, - 0x484acad2, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b195c, 0x484b67e6, 0x484b67e6, - 0x484b67e6, 0x484b67e6, 0x484b67e6, 0x484bb670, 0x484bb670, 0x484bb670, 0x484bb670, 0x484bb670, - 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c04fa, 0x484c5385, 0x484c5385, 0x484c5385, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, - 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, - 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, - 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, - 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb3, - 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, - 0x3f7ffece, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7ffe95, 0x3f7fff96, 0x3f7fff96, - 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, - 0x3f7fff03, 0x3f7fff03, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7fff73, - 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, - 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, 0x3f7ffe12, - 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, - 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, - 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, - 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, - 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, - 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffeea, - 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, - 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, - 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, -] )) ), - -################ chunk 6656 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x484c5385, 0x484c5385, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484ca20f, 0x484cf099, - 0x484cf099, 0x484cf099, 0x484cf099, 0x484cf099, 0x484d3f23, 0x484d3f23, 0x484d3f23, 0x484d3f23, - 0x484d3f23, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484d8dad, 0x484ddc37, 0x484ddc37, - 0x484ddc37, 0x484ddc37, 0x484ddc37, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, 0x484e2ac2, - 0x484e794c, 0x484e794c, 0x484e794c, 0x484e794c, 0x484e794c, 0x484ec7d6, 0x484ec7d6, 0x484ec7d6, - 0x484ec7d6, 0x484ec7d6, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f1660, 0x484f64ea, - 0x484f64ea, 0x484f64ea, 0x484f64ea, 0x484f64ea, 0x484fb375, 0x484fb375, 0x484fb375, 0x484fb375, - 0x484fb375, 0x485001ff, 0x485001ff, 0x485001ff, 0x485001ff, 0x485001ff, 0x48505089, 0x48505089, - 0x48505089, 0x48505089, 0x48505089, 0x48509f13, 0x48509f13, 0x48509f13, 0x48509f13, 0x48509f13, - 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x4850ed9d, 0x48513c28, 0x48513c28, 0x48513c28, - 0x48513c28, 0x48513c28, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x48518ab2, 0x4851d93c, - 0x4851d93c, 0x4851d93c, 0x4851d93c, 0x4851d93c, 0x485227c6, 0x485227c6, 0x485227c6, 0x485227c6, - 0x485227c6, 0x48527650, 0x48527650, 0x48527650, 0x48527650, 0x48527650, 0x4852c4db, 0x4852c4db, - 0x4852c4db, 0x4852c4db, 0x4852c4db, 0x48531365, 0x48531365, 0x48531365, 0x48531365, 0x48531365, - 0x485361ef, 0x485361ef, 0x485361ef, 0x485361ef, 0x485361ef, 0x4853b079, 0x4853b079, 0x4853b079, - 0x4853b079, 0x4853b079, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x4853ff03, 0x48544d8e, - 0x48544d8e, 0x48544d8e, 0x48544d8e, 0x48544d8e, 0x48549c18, 0x48549c18, 0x48549c18, 0x48549c18, - 0x48549c18, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4854eaa2, 0x4855392c, 0x4855392c, - 0x4855392c, 0x4855392c, 0x4855392c, 0x485587b6, 0x485587b6, 0x485587b6, 0x485587b6, 0x485587b6, - 0x4855d641, 0x4855d641, 0x4855d641, 0x4855d641, 0x4855d641, 0x485624cb, 0x485624cb, 0x485624cb, - 0x485624cb, 0x485624cb, 0x48567355, 0x48567355, 0x48567355, 0x48567355, 0x48567355, 0x4856c1df, - 0x4856c1df, 0x4856c1df, 0x4856c1df, 0x4856c1df, 0x48571069, 0x48571069, 0x48571069, 0x48571069, - 0x48571069, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x48575ef3, 0x4857ad7e, 0x4857ad7e, - 0x4857ad7e, 0x4857ad7e, 0x4857ad7e, 0x4857fc08, 0x4857fc08, 0x4857fc08, 0x4857fc08, 0x4857fc08, - 0x48584a92, 0x48584a92, 0x48584a92, 0x48584a92, 0x48584a92, 0x4858991c, 0x4858991c, 0x4858991c, - 0x4858991c, 0x4858991c, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x4858e7a6, 0x48593631, - 0x48593631, 0x48593631, 0x48593631, 0x48593631, 0x485984bb, 0x485984bb, 0x485984bb, 0x485984bb, - 0x485984bb, 0x4859d345, 0x4859d345, 0x4859d345, 0x4859d345, 0x4859d345, 0x485a21cf, 0x485a21cf, - 0x485a21cf, 0x485a21cf, 0x485a21cf, 0x485a7059, 0x485a7059, 0x485a7059, 0x485a7059, 0x485a7059, - 0x485abee4, 0x485abee4, 0x485abee4, 0x485abee4, 0x485abee4, 0x485b0d6e, 0x485b0d6e, 0x485b0d6e, - 0x485b0d6e, 0x485b0d6e, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485b5bf8, 0x485baa82, - 0x485baa82, 0x485baa82, 0x485baa82, 0x485baa82, 0x485bf90c, 0x485bf90c, 0x485bf90c, 0x485bf90c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, - 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, - 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, - 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, - 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffecf, 0x3f7ffecf, 0x3f7ffecf, - 0x3f7ffecf, 0x3f7ffecf, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, - 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffe96, 0x3f7ffe96, - 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7ffe57, - 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, - 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, - 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, - 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, - 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, - 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, - 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffeeb, - 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, - 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, - 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, -] )) ), - -################ chunk 7168 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x485bf90c, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c4797, 0x485c9621, 0x485c9621, - 0x485c9621, 0x485c9621, 0x485c9621, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, 0x485ce4ab, - 0x485d3335, 0x485d3335, 0x485d3335, 0x485d3335, 0x485d3335, 0x485d81bf, 0x485d81bf, 0x485d81bf, - 0x485d81bf, 0x485d81bf, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485dd04a, 0x485e1ed4, - 0x485e1ed4, 0x485e1ed4, 0x485e1ed4, 0x485e1ed4, 0x485e6d5e, 0x485e6d5e, 0x485e6d5e, 0x485e6d5e, - 0x485e6d5e, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485ebbe8, 0x485f0a72, 0x485f0a72, - 0x485f0a72, 0x485f0a72, 0x485f0a72, 0x485f58fc, 0x485f58fc, 0x485f58fc, 0x485f58fc, 0x485f58fc, - 0x485fa787, 0x485fa787, 0x485fa787, 0x485fa787, 0x485fa787, 0x485ff611, 0x485ff611, 0x485ff611, - 0x485ff611, 0x485ff611, 0x4860449b, 0x4860449b, 0x4860449b, 0x4860449b, 0x4860449b, 0x48609325, - 0x48609325, 0x48609325, 0x48609325, 0x48609325, 0x4860e1af, 0x4860e1af, 0x4860e1af, 0x4860e1af, - 0x4860e1af, 0x4861303a, 0x4861303a, 0x4861303a, 0x4861303a, 0x4861303a, 0x48617ec4, 0x48617ec4, - 0x48617ec4, 0x48617ec4, 0x48617ec4, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, 0x4861cd4e, - 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48621bd8, 0x48626a62, 0x48626a62, 0x48626a62, - 0x48626a62, 0x48626a62, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x4862b8ed, 0x48630777, - 0x48630777, 0x48630777, 0x48630777, 0x48630777, 0x48635601, 0x48635601, 0x48635601, 0x48635601, - 0x48635601, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863a48b, 0x4863f315, 0x4863f315, - 0x4863f315, 0x4863f315, 0x4863f315, 0x486441a0, 0x486441a0, 0x486441a0, 0x486441a0, 0x486441a0, - 0x4864902a, 0x4864902a, 0x4864902a, 0x4864902a, 0x4864902a, 0x4864deb4, 0x4864deb4, 0x4864deb4, - 0x4864deb4, 0x4864deb4, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48652d3e, 0x48657bc8, - 0x48657bc8, 0x48657bc8, 0x48657bc8, 0x48657bc8, 0x4865ca53, 0x4865ca53, 0x4865ca53, 0x4865ca53, - 0x4865ca53, 0x486618dd, 0x486618dd, 0x486618dd, 0x486618dd, 0x486618dd, 0x48666767, 0x48666767, - 0x48666767, 0x48666767, 0x48666767, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, 0x4866b5f1, - 0x4867047b, 0x4867047b, 0x4867047b, 0x4867047b, 0x4867047b, 0x48675306, 0x48675306, 0x48675306, - 0x48675306, 0x48675306, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867a190, 0x4867f01a, - 0x4867f01a, 0x4867f01a, 0x4867f01a, 0x4867f01a, 0x48683ea4, 0x48683ea4, 0x48683ea4, 0x48683ea4, - 0x48683ea4, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x48688d2e, 0x4868dbb8, 0x4868dbb8, - 0x4868dbb8, 0x4868dbb8, 0x4868dbb8, 0x48692a43, 0x48692a43, 0x48692a43, 0x48692a43, 0x48692a43, - 0x486978cd, 0x486978cd, 0x486978cd, 0x486978cd, 0x486978cd, 0x4869c757, 0x4869c757, 0x4869c757, - 0x4869c757, 0x4869c757, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a15e1, 0x486a646b, - 0x486a646b, 0x486a646b, 0x486a646b, 0x486a646b, 0x486ab2f6, 0x486ab2f6, 0x486ab2f6, 0x486ab2f6, - 0x486ab2f6, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b0180, 0x486b500a, 0x486b500a, - 0x486b500a, 0x486b500a, 0x486b500a, 0x486b9e94, 0x486b9e94, 0x486b9e94, 0x486b9e94, 0x486b9e94, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffee9, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, - 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, - 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, - 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, - 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, - 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, - 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, - 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, - 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7fffb4, - 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, - 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, - 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, - 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, - 0x3f7ffe57, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, - 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, - 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, - 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, - 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, -] )) ), - -################ chunk 7680 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486bed1e, 0x486c3ba9, 0x486c3ba9, 0x486c3ba9, - 0x486c3ba9, 0x486c3ba9, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486c8a33, 0x486cd8bd, - 0x486cd8bd, 0x486cd8bd, 0x486cd8bd, 0x486cd8bd, 0x486d2747, 0x486d2747, 0x486d2747, 0x486d2747, - 0x486d2747, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486d75d1, 0x486dc45c, 0x486dc45c, - 0x486dc45c, 0x486dc45c, 0x486dc45c, 0x486e12e6, 0x486e12e6, 0x486e12e6, 0x486e12e6, 0x486e12e6, - 0x486e6170, 0x486e6170, 0x486e6170, 0x486e6170, 0x486e6170, 0x486eaffa, 0x486eaffa, 0x486eaffa, - 0x486eaffa, 0x486eaffa, 0x486efe84, 0x486efe84, 0x486efe84, 0x486efe84, 0x486efe84, 0x486f4d0f, - 0x486f4d0f, 0x486f4d0f, 0x486f4d0f, 0x486f4d0f, 0x486f9b99, 0x486f9b99, 0x486f9b99, 0x486f9b99, - 0x486f9b99, 0x486fea23, 0x486fea23, 0x486fea23, 0x486fea23, 0x486fea23, 0x487038ad, 0x487038ad, - 0x487038ad, 0x487038ad, 0x487038ad, 0x48708737, 0x48708737, 0x48708737, 0x48708737, 0x48708737, - 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4870d5c1, 0x4871244c, 0x4871244c, 0x4871244c, - 0x4871244c, 0x4871244c, 0x487172d6, 0x487172d6, 0x487172d6, 0x487172d6, 0x487172d6, 0x4871c160, - 0x4871c160, 0x4871c160, 0x4871c160, 0x4871c160, 0x48720fea, 0x48720fea, 0x48720fea, 0x48720fea, - 0x48720fea, 0x48725e74, 0x48725e74, 0x48725e74, 0x48725e74, 0x48725e74, 0x4872acff, 0x4872acff, - 0x4872acff, 0x4872acff, 0x4872acff, 0x4872fb89, 0x4872fb89, 0x4872fb89, 0x4872fb89, 0x4872fb89, - 0x48734a13, 0x48734a13, 0x48734a13, 0x48734a13, 0x48734a13, 0x4873989d, 0x4873989d, 0x4873989d, - 0x4873989d, 0x4873989d, 0x4873e727, 0x4873e727, 0x4873e727, 0x4873e727, 0x4873e727, 0x487435b2, - 0x487435b2, 0x487435b2, 0x487435b2, 0x487435b2, 0x4874843c, 0x4874843c, 0x4874843c, 0x4874843c, - 0x4874843c, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x4874d2c6, 0x48752150, 0x48752150, - 0x48752150, 0x48752150, 0x48752150, 0x48756fda, 0x48756fda, 0x48756fda, 0x48756fda, 0x48756fda, - 0x4875be65, 0x4875be65, 0x4875be65, 0x4875be65, 0x4875be65, 0x48760cef, 0x48760cef, 0x48760cef, - 0x48760cef, 0x48760cef, 0x48765b79, 0x48765b79, 0x48765b79, 0x48765b79, 0x48765b79, 0x4876aa03, - 0x4876aa03, 0x4876aa03, 0x4876aa03, 0x4876aa03, 0x4876f88d, 0x4876f88d, 0x4876f88d, 0x4876f88d, - 0x4876f88d, 0x48774718, 0x48774718, 0x48774718, 0x48774718, 0x48774718, 0x487795a2, 0x487795a2, - 0x487795a2, 0x487795a2, 0x487795a2, 0x4877e42c, 0x4877e42c, 0x4877e42c, 0x4877e42c, 0x4877e42c, - 0x487832b6, 0x487832b6, 0x487832b6, 0x487832b6, 0x487832b6, 0x48788140, 0x48788140, 0x48788140, - 0x48788140, 0x48788140, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x4878cfcb, 0x48791e55, - 0x48791e55, 0x48791e55, 0x48791e55, 0x48791e55, 0x48796cdf, 0x48796cdf, 0x48796cdf, 0x48796cdf, - 0x48796cdf, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x4879bb69, 0x487a09f3, 0x487a09f3, - 0x487a09f3, 0x487a09f3, 0x487a09f3, 0x487a587d, 0x487a587d, 0x487a587d, 0x487a587d, 0x487a587d, - 0x487aa708, 0x487aa708, 0x487aa708, 0x487aa708, 0x487aa708, 0x487af592, 0x487af592, 0x487af592, - 0x487af592, 0x487af592, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b441c, 0x487b92a6, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, - 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffe77, 0x3f7ffe77, - 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, - 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7ffe35, - 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, - 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, - 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, - 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7ffff6, - 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, - 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7fff04, 0x3f7fff04, - 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, - 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffed0, - 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffb3, 0x3f7fffb3, - 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, - 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, - 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, - 0x3f7fff03, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7fff73, 0x3f7fff73, - 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, - 0x3f7fff33, 0x3f7fff33, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, - 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, - 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, - 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fff84, -] )) ), - -################ chunk 8192 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x487b92a6, 0x487b92a6, 0x487b92a6, 0x487b92a6, 0x487be130, 0x487be130, 0x487be130, 0x487be130, - 0x487be130, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c2fbb, 0x487c7e45, 0x487c7e45, - 0x487c7e45, 0x487c7e45, 0x487c7e45, 0x487ccccf, 0x487ccccf, 0x487ccccf, 0x487ccccf, 0x487ccccf, - 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d1b59, 0x487d69e3, 0x487d69e3, 0x487d69e3, - 0x487d69e3, 0x487d69e3, 0x487db86e, 0x487db86e, 0x487db86e, 0x487db86e, 0x487db86e, 0x487e06f8, - 0x487e06f8, 0x487e06f8, 0x487e06f8, 0x487e06f8, 0x487e5582, 0x487e5582, 0x487e5582, 0x487e5582, - 0x487e5582, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ea40c, 0x487ef296, 0x487ef296, - 0x487ef296, 0x487ef296, 0x487ef296, 0x487f4121, 0x487f4121, 0x487f4121, 0x487f4121, 0x487f4121, - 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487f8fab, 0x487fde35, 0x487fde35, 0x487fde35, - 0x487fde35, 0x487fde35, 0x48801660, 0x48801660, 0x48801660, 0x48801660, 0x48801660, 0x48803da5, - 0x48803da5, 0x48803da5, 0x48803da5, 0x48803da5, 0x488064ea, 0x488064ea, 0x488064ea, 0x488064ea, - 0x488064ea, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x48808c2f, 0x4880b374, 0x4880b374, - 0x4880b374, 0x4880b374, 0x4880b374, 0x4880dab9, 0x4880dab9, 0x4880dab9, 0x4880dab9, 0x4880dab9, - 0x488101fe, 0x488101fe, 0x488101fe, 0x488101fe, 0x488101fe, 0x48812943, 0x48812943, 0x48812943, - 0x48812943, 0x48812943, 0x48815088, 0x48815088, 0x48815088, 0x48815088, 0x48815088, 0x488177cd, - 0x488177cd, 0x488177cd, 0x488177cd, 0x488177cd, 0x48819f13, 0x48819f13, 0x48819f13, 0x48819f13, - 0x48819f13, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881c658, 0x4881ed9d, 0x4881ed9d, - 0x4881ed9d, 0x4881ed9d, 0x4881ed9d, 0x488214e2, 0x488214e2, 0x488214e2, 0x488214e2, 0x488214e2, - 0x48823c27, 0x48823c27, 0x48823c27, 0x48823c27, 0x48823c27, 0x4882636c, 0x4882636c, 0x4882636c, - 0x4882636c, 0x4882636c, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x48828ab1, 0x4882b1f6, - 0x4882b1f6, 0x4882b1f6, 0x4882b1f6, 0x4882b1f6, 0x4882d93b, 0x4882d93b, 0x4882d93b, 0x4882d93b, - 0x4882d93b, 0x48830080, 0x48830080, 0x48830080, 0x48830080, 0x48830080, 0x488327c6, 0x488327c6, - 0x488327c6, 0x488327c6, 0x488327c6, 0x48834f0b, 0x48834f0b, 0x48834f0b, 0x48834f0b, 0x48834f0b, - 0x48837650, 0x48837650, 0x48837650, 0x48837650, 0x48837650, 0x48839d95, 0x48839d95, 0x48839d95, - 0x48839d95, 0x48839d95, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883c4da, 0x4883ec1f, - 0x4883ec1f, 0x4883ec1f, 0x4883ec1f, 0x4883ec1f, 0x48841364, 0x48841364, 0x48841364, 0x48841364, - 0x48841364, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x48843aa9, 0x488461ee, 0x488461ee, - 0x488461ee, 0x488461ee, 0x488461ee, 0x48848933, 0x48848933, 0x48848933, 0x48848933, 0x48848933, - 0x4884b078, 0x4884b078, 0x4884b078, 0x4884b078, 0x4884b078, 0x4884d7be, 0x4884d7be, 0x4884d7be, - 0x4884d7be, 0x4884d7be, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x4884ff03, 0x48852648, - 0x48852648, 0x48852648, 0x48852648, 0x48852648, 0x48854d8d, 0x48854d8d, 0x48854d8d, 0x48854d8d, - 0x48854d8d, 0x488574d2, 0x488574d2, 0x488574d2, 0x488574d2, 0x488574d2, 0x48859c17, 0x48859c17, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, - 0x3f7ffe75, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, - 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7fffa6, - 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7ffee9, 0x3f7ffee9, - 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, - 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffc73, - 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, - 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7ffff0, 0x3f7ffff0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, - 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ff9d7, - 0x3f7ff9d7, 0x3f7ff9d7, 0x3f7ff9d7, 0x3f7ff9d7, 0x3f7ff917, 0x3f7ff917, 0x3f7ff917, 0x3f7ff917, - 0x3f7ff917, 0x3f7ffba9, 0x3f7ffba9, 0x3f7ffba9, 0x3f7ffba9, 0x3f7ffba9, 0x3f7ffda3, 0x3f7ffda3, - 0x3f7ffda3, 0x3f7ffda3, 0x3f7ffda3, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, 0x3f7fff04, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7ffe94, - 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffcfb, 0x3f7ffcfb, 0x3f7ffcfb, 0x3f7ffcfb, - 0x3f7ffcfb, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ff802, 0x3f7ff802, - 0x3f7ff802, 0x3f7ff802, 0x3f7ff802, 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffacc, - 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, - 0x3f7ffe96, 0x3f7ffe96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7ffda1, 0x3f7ffda1, - 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffba7, 0x3f7ffba7, 0x3f7ffba7, 0x3f7ffba7, 0x3f7ffba7, - 0x3f7ff914, 0x3f7ff914, 0x3f7ff914, 0x3f7ff914, 0x3f7ff914, 0x3f7ff9da, 0x3f7ff9da, 0x3f7ff9da, - 0x3f7ff9da, 0x3f7ff9da, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffe13, - 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, - 0x3f7fff4a, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7ffff0, 0x3f7ffff0, -] )) ), - -################ chunk 8704 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x48859c17, 0x48859c17, 0x48859c17, 0x4885c35c, 0x4885c35c, 0x4885c35c, 0x4885c35c, 0x4885c35c, - 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x4885eaa1, 0x488611e6, 0x488611e6, 0x488611e6, - 0x488611e6, 0x488611e6, 0x4886392b, 0x4886392b, 0x4886392b, 0x4886392b, 0x4886392b, 0x48866071, - 0x48866071, 0x48866071, 0x48866071, 0x48866071, 0x488687b6, 0x488687b6, 0x488687b6, 0x488687b6, - 0x488687b6, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886aefb, 0x4886d640, 0x4886d640, - 0x4886d640, 0x4886d640, 0x4886d640, 0x4886fd85, 0x4886fd85, 0x4886fd85, 0x4886fd85, 0x4886fd85, - 0x488724ca, 0x488724ca, 0x488724ca, 0x488724ca, 0x488724ca, 0x48874c0f, 0x48874c0f, 0x48874c0f, - 0x48874c0f, 0x48874c0f, 0x48877354, 0x48877354, 0x48877354, 0x48877354, 0x48877354, 0x48879a99, - 0x48879a99, 0x48879a99, 0x48879a99, 0x48879a99, 0x4887c1de, 0x4887c1de, 0x4887c1de, 0x4887c1de, - 0x4887c1de, 0x4887e923, 0x4887e923, 0x4887e923, 0x4887e923, 0x4887e923, 0x48881069, 0x48881069, - 0x48881069, 0x48881069, 0x48881069, 0x488837ae, 0x488837ae, 0x488837ae, 0x488837ae, 0x488837ae, - 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48885ef3, 0x48888638, 0x48888638, 0x48888638, - 0x48888638, 0x48888638, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888ad7d, 0x4888d4c2, - 0x4888d4c2, 0x4888d4c2, 0x4888d4c2, 0x4888d4c2, 0x4888fc07, 0x4888fc07, 0x4888fc07, 0x4888fc07, - 0x4888fc07, 0x4889234c, 0x4889234c, 0x4889234c, 0x4889234c, 0x4889234c, 0x48894a91, 0x48894a91, - 0x48894a91, 0x48894a91, 0x48894a91, 0x488971d6, 0x488971d6, 0x488971d6, 0x488971d6, 0x488971d6, - 0x4889991c, 0x4889991c, 0x4889991c, 0x4889991c, 0x4889991c, 0x4889c061, 0x4889c061, 0x4889c061, - 0x4889c061, 0x4889c061, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x4889e7a6, 0x488a0eeb, - 0x488a0eeb, 0x488a0eeb, 0x488a0eeb, 0x488a0eeb, 0x488a3630, 0x488a3630, 0x488a3630, 0x488a3630, - 0x488a3630, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a5d75, 0x488a84ba, 0x488a84ba, - 0x488a84ba, 0x488a84ba, 0x488a84ba, 0x488aabff, 0x488aabff, 0x488aabff, 0x488aabff, 0x488aabff, - 0x488ad344, 0x488ad344, 0x488ad344, 0x488ad344, 0x488ad344, 0x488afa89, 0x488afa89, 0x488afa89, - 0x488afa89, 0x488afa89, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b21cf, 0x488b4914, - 0x488b4914, 0x488b4914, 0x488b4914, 0x488b4914, 0x488b7059, 0x488b7059, 0x488b7059, 0x488b7059, - 0x488b7059, 0x488b979e, 0x488b979e, 0x488b979e, 0x488b979e, 0x488b979e, 0x488bbee3, 0x488bbee3, - 0x488bbee3, 0x488bbee3, 0x488bbee3, 0x488be628, 0x488be628, 0x488be628, 0x488be628, 0x488be628, - 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c0d6d, 0x488c34b2, 0x488c34b2, 0x488c34b2, - 0x488c34b2, 0x488c34b2, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c5bf7, 0x488c833c, - 0x488c833c, 0x488c833c, 0x488c833c, 0x488c833c, 0x488caa81, 0x488caa81, 0x488caa81, 0x488caa81, - 0x488caa81, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cd1c7, 0x488cf90c, 0x488cf90c, - 0x488cf90c, 0x488cf90c, 0x488cf90c, 0x488d2051, 0x488d2051, 0x488d2051, 0x488d2051, 0x488d2051, - 0x488d4796, 0x488d4796, 0x488d4796, 0x488d4796, 0x488d4796, 0x488d6edb, 0x488d6edb, 0x488d6edb, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, - 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffe34, 0x3f7ffc71, 0x3f7ffc71, 0x3f7ffc71, - 0x3f7ffc71, 0x3f7ffc71, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ff8d4, - 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ffb74, 0x3f7ffb74, 0x3f7ffb74, 0x3f7ffb74, - 0x3f7ffb74, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffeeb, 0x3f7ffeeb, - 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffd26, - 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffb02, 0x3f7ffb02, 0x3f7ffb02, 0x3f7ffb02, - 0x3f7ffb02, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ffa91, 0x3f7ffa91, - 0x3f7ffa91, 0x3f7ffa91, 0x3f7ffa91, 0x3f7ffcd0, 0x3f7ffcd0, 0x3f7ffcd0, 0x3f7ffcd0, 0x3f7ffcd0, - 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7ffe77, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, - 0x3f7fff85, 0x3f7fff85, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7fffd7, - 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fffd7, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, 0x3f7fff1c, - 0x3f7fff1c, 0x3f7ffdc8, 0x3f7ffdc8, 0x3f7ffdc8, 0x3f7ffdc8, 0x3f7ffdc8, 0x3f7ffbdb, 0x3f7ffbdb, - 0x3f7ffbdb, 0x3f7ffbdb, 0x3f7ffbdb, 0x3f7ff956, 0x3f7ff956, 0x3f7ff956, 0x3f7ff956, 0x3f7ff956, - 0x3f7ff99a, 0x3f7ff99a, 0x3f7ff99a, 0x3f7ff99a, 0x3f7ff99a, 0x3f7ffc11, 0x3f7ffc11, 0x3f7ffc11, - 0x3f7ffc11, 0x3f7ffc11, 0x3f7ffdef, 0x3f7ffdef, 0x3f7ffdef, 0x3f7ffdef, 0x3f7ffdef, 0x3f7fff34, - 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fff34, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, - 0x3f7fffe1, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7fff72, 0x3f7fff72, - 0x3f7fff72, 0x3f7fff72, 0x3f7fff72, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, 0x3f7ffe55, - 0x3f7ffca0, 0x3f7ffca0, 0x3f7ffca0, 0x3f7ffca0, 0x3f7ffca0, 0x3f7ffa52, 0x3f7ffa52, 0x3f7ffa52, - 0x3f7ffa52, 0x3f7ffa52, 0x3f7ff88f, 0x3f7ff88f, 0x3f7ff88f, 0x3f7ff88f, 0x3f7ff88f, 0x3f7ffb3d, - 0x3f7ffb3d, 0x3f7ffb3d, 0x3f7ffb3d, 0x3f7ffb3d, 0x3f7ffd53, 0x3f7ffd53, 0x3f7ffd53, 0x3f7ffd53, - 0x3f7ffd53, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7ffed0, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7ffece, 0x3f7ffece, 0x3f7ffece, - 0x3f7ffece, 0x3f7ffece, 0x3f7ffd50, 0x3f7ffd50, 0x3f7ffd50, 0x3f7ffd50, 0x3f7ffd50, 0x3f7ffb3a, - 0x3f7ffb3a, 0x3f7ffb3a, 0x3f7ffb3a, 0x3f7ffb3a, 0x3f7ff88b, 0x3f7ff88b, 0x3f7ff88b, 0x3f7ff88b, - 0x3f7ff88b, 0x3f7ffa55, 0x3f7ffa55, 0x3f7ffa55, 0x3f7ffa55, 0x3f7ffa55, 0x3f7ffca2, 0x3f7ffca2, - 0x3f7ffca2, 0x3f7ffca2, 0x3f7ffca2, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, 0x3f7ffe57, - 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7fff73, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, -] )) ), - -################ chunk 9216 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x488d6edb, 0x488d6edb, 0x488d9620, 0x488d9620, 0x488d9620, 0x488d9620, 0x488d9620, 0x488dbd65, - 0x488dbd65, 0x488dbd65, 0x488dbd65, 0x488dbd65, 0x488de4aa, 0x488de4aa, 0x488de4aa, 0x488de4aa, - 0x488de4aa, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e0bef, 0x488e3334, 0x488e3334, - 0x488e3334, 0x488e3334, 0x488e3334, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, 0x488e5a7a, - 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488e81bf, 0x488ea904, 0x488ea904, 0x488ea904, - 0x488ea904, 0x488ea904, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ed049, 0x488ef78e, - 0x488ef78e, 0x488ef78e, 0x488ef78e, 0x488ef78e, 0x488f1ed3, 0x488f1ed3, 0x488f1ed3, 0x488f1ed3, - 0x488f1ed3, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f4618, 0x488f6d5d, 0x488f6d5d, - 0x488f6d5d, 0x488f6d5d, 0x488f6d5d, 0x488f94a2, 0x488f94a2, 0x488f94a2, 0x488f94a2, 0x488f94a2, - 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fbbe7, 0x488fe32d, 0x488fe32d, 0x488fe32d, - 0x488fe32d, 0x488fe32d, 0x48900a72, 0x48900a72, 0x48900a72, 0x48900a72, 0x48900a72, 0x489031b7, - 0x489031b7, 0x489031b7, 0x489031b7, 0x489031b7, 0x489058fc, 0x489058fc, 0x489058fc, 0x489058fc, - 0x489058fc, 0x48908041, 0x48908041, 0x48908041, 0x48908041, 0x48908041, 0x4890a786, 0x4890a786, - 0x4890a786, 0x4890a786, 0x4890a786, 0x4890cecb, 0x4890cecb, 0x4890cecb, 0x4890cecb, 0x4890cecb, - 0x4890f610, 0x4890f610, 0x4890f610, 0x4890f610, 0x4890f610, 0x48911d55, 0x48911d55, 0x48911d55, - 0x48911d55, 0x48911d55, 0x4891449a, 0x4891449a, 0x4891449a, 0x4891449a, 0x4891449a, 0x48916bdf, - 0x48916bdf, 0x48916bdf, 0x48916bdf, 0x48916bdf, 0x48919325, 0x48919325, 0x48919325, 0x48919325, - 0x48919325, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891ba6a, 0x4891e1af, 0x4891e1af, - 0x4891e1af, 0x4891e1af, 0x4891e1af, 0x489208f4, 0x489208f4, 0x489208f4, 0x489208f4, 0x489208f4, - 0x48923039, 0x48923039, 0x48923039, 0x48923039, 0x48923039, 0x4892577e, 0x4892577e, 0x4892577e, - 0x4892577e, 0x4892577e, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x48927ec3, 0x4892a608, - 0x4892a608, 0x4892a608, 0x4892a608, 0x4892a608, 0x4892cd4d, 0x4892cd4d, 0x4892cd4d, 0x4892cd4d, - 0x4892cd4d, 0x4892f492, 0x4892f492, 0x4892f492, 0x4892f492, 0x4892f492, 0x48931bd8, 0x48931bd8, - 0x48931bd8, 0x48931bd8, 0x48931bd8, 0x4893431d, 0x4893431d, 0x4893431d, 0x4893431d, 0x4893431d, - 0x48936a62, 0x48936a62, 0x48936a62, 0x48936a62, 0x48936a62, 0x489391a7, 0x489391a7, 0x489391a7, - 0x489391a7, 0x489391a7, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893b8ec, 0x4893e031, - 0x4893e031, 0x4893e031, 0x4893e031, 0x4893e031, 0x48940776, 0x48940776, 0x48940776, 0x48940776, - 0x48940776, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48942ebb, 0x48945600, 0x48945600, - 0x48945600, 0x48945600, 0x48945600, 0x48947d45, 0x48947d45, 0x48947d45, 0x48947d45, 0x48947d45, - 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894a48b, 0x4894cbd0, 0x4894cbd0, 0x4894cbd0, - 0x4894cbd0, 0x4894cbd0, 0x4894f315, 0x4894f315, 0x4894f315, 0x4894f315, 0x4894f315, 0x48951a5a, - 0x48951a5a, 0x48951a5a, 0x48951a5a, 0x48951a5a, 0x4895419f, 0x4895419f, 0x4895419f, 0x4895419f, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffff6, 0x3f7ffff6, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fffe1, 0x3f7fff33, - 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7fff33, 0x3f7ffded, 0x3f7ffded, 0x3f7ffded, 0x3f7ffded, - 0x3f7ffded, 0x3f7ffc0e, 0x3f7ffc0e, 0x3f7ffc0e, 0x3f7ffc0e, 0x3f7ffc0e, 0x3f7ff997, 0x3f7ff997, - 0x3f7ff997, 0x3f7ff997, 0x3f7ff997, 0x3f7ff959, 0x3f7ff959, 0x3f7ff959, 0x3f7ff959, 0x3f7ff959, - 0x3f7ffbde, 0x3f7ffbde, 0x3f7ffbde, 0x3f7ffbde, 0x3f7ffbde, 0x3f7ffdca, 0x3f7ffdca, 0x3f7ffdca, - 0x3f7ffdca, 0x3f7ffdca, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fff1d, 0x3f7fffd8, - 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7fffd8, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7fff84, 0x3f7ffe75, 0x3f7ffe75, - 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffe75, 0x3f7ffcce, 0x3f7ffcce, 0x3f7ffcce, 0x3f7ffcce, 0x3f7ffcce, - 0x3f7ffa8e, 0x3f7ffa8e, 0x3f7ffa8e, 0x3f7ffa8e, 0x3f7ffa8e, 0x3f7ff849, 0x3f7ff849, 0x3f7ff849, - 0x3f7ff849, 0x3f7ff849, 0x3f7ffb05, 0x3f7ffb05, 0x3f7ffb05, 0x3f7ffb05, 0x3f7ffb05, 0x3f7ffd29, - 0x3f7ffd29, 0x3f7ffd29, 0x3f7ffd29, 0x3f7ffd29, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, 0x3f7ffeb3, - 0x3f7ffeb3, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffa6, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffee9, 0x3f7ffd79, 0x3f7ffd79, 0x3f7ffd79, - 0x3f7ffd79, 0x3f7ffd79, 0x3f7ffb71, 0x3f7ffb71, 0x3f7ffb71, 0x3f7ffb71, 0x3f7ffb71, 0x3f7ff8d0, - 0x3f7ff8d0, 0x3f7ff8d0, 0x3f7ff8d0, 0x3f7ff8d0, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, 0x3f7ffa18, - 0x3f7ffa18, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffc73, 0x3f7ffe35, 0x3f7ffe35, - 0x3f7ffe35, 0x3f7ffe35, 0x3f7ffe35, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, 0x3f7fff5f, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fffe9, 0x3f7fffe9, 0x3f7fffe9, - 0x3f7fffe9, 0x3f7fffe9, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7fff49, 0x3f7ffe11, - 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffe11, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, 0x3f7ffc40, - 0x3f7ffc40, 0x3f7ff9d6, 0x3f7ff9d6, 0x3f7ff9d6, 0x3f7ff9d6, 0x3f7ff9d6, 0x3f7ff917, 0x3f7ff917, - 0x3f7ff917, 0x3f7ff917, 0x3f7ff917, 0x3f7ffbaa, 0x3f7ffbaa, 0x3f7ffbaa, 0x3f7ffbaa, 0x3f7ffbaa, - 0x3f7ffda3, 0x3f7ffda3, 0x3f7ffda3, 0x3f7ffda3, 0x3f7ffda3, 0x3f7fff05, 0x3f7fff05, 0x3f7fff05, - 0x3f7fff05, 0x3f7fff05, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, 0x3f7fff95, - 0x3f7fff95, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffe94, 0x3f7ffcfb, 0x3f7ffcfb, - 0x3f7ffcfb, 0x3f7ffcfb, 0x3f7ffcfb, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, 0x3f7ffac9, - 0x3f7ff802, 0x3f7ff802, 0x3f7ff802, 0x3f7ff802, 0x3f7ff802, 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffacc, - 0x3f7ffacc, 0x3f7ffacc, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffcfd, 0x3f7ffe96, - 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7ffe96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, 0x3f7fff96, -] )) ), - -################ chunk 9728 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4895419f, 0x489568e4, 0x489568e4, 0x489568e4, 0x489568e4, 0x489568e4, 0x48959029, 0x48959029, - 0x48959029, 0x48959029, 0x48959029, 0x4895b76e, 0x4895b76e, 0x4895b76e, 0x4895b76e, 0x4895b76e, - 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x4895deb3, 0x489605f8, 0x489605f8, 0x489605f8, - 0x489605f8, 0x489605f8, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48962d3d, 0x48965483, - 0x48965483, 0x48965483, 0x48965483, 0x48965483, 0x48967bc8, 0x48967bc8, 0x48967bc8, 0x48967bc8, - 0x48967bc8, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896a30d, 0x4896ca52, 0x4896ca52, - 0x4896ca52, 0x4896ca52, 0x4896ca52, 0x4896f197, 0x4896f197, 0x4896f197, 0x4896f197, 0x4896f197, - 0x489718dc, 0x489718dc, 0x489718dc, 0x489718dc, 0x489718dc, 0x48974021, 0x48974021, 0x48974021, - 0x48974021, 0x48974021, 0x48976766, 0x48976766, 0x48976766, 0x48976766, 0x48976766, 0x48978eab, - 0x48978eab, 0x48978eab, 0x48978eab, 0x48978eab, 0x4897b5f0, 0x4897b5f0, 0x4897b5f0, 0x4897b5f0, - 0x4897b5f0, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4897dd36, 0x4898047b, 0x4898047b, - 0x4898047b, 0x4898047b, 0x4898047b, 0x48982bc0, 0x48982bc0, 0x48982bc0, 0x48982bc0, 0x48982bc0, - 0x48985305, 0x48985305, 0x48985305, 0x48985305, 0x48985305, 0x48987a4a, 0x48987a4a, 0x48987a4a, - 0x48987a4a, 0x48987a4a, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898a18f, 0x4898c8d4, - 0x4898c8d4, 0x4898c8d4, 0x4898c8d4, 0x4898c8d4, 0x4898f019, 0x4898f019, 0x4898f019, 0x4898f019, - 0x4898f019, 0x4899175e, 0x4899175e, 0x4899175e, 0x4899175e, 0x4899175e, 0x48993ea3, 0x48993ea3, - 0x48993ea3, 0x48993ea3, 0x48993ea3, 0x489965e8, 0x489965e8, 0x489965e8, 0x489965e8, 0x489965e8, - 0x431d1463, 0x431d1463, 0x431d1463, 0x431d1463, 0x431d1463, 0x43ba23ad, 0x43ba23ad, 0x43ba23ad, - 0x43ba23ad, 0x43ba23ad, 0x4412de95, 0x4412de95, 0x4412de95, 0x4412de95, 0x4412de95, 0x4448ab53, - 0x4448ab53, 0x4448ab53, 0x4448ab53, 0x4448ab53, 0x447e7811, 0x447e7811, 0x447e7811, 0x447e7811, - 0x447e7811, 0x449a2267, 0x449a2267, 0x449a2267, 0x449a2267, 0x449a2267, 0x44b508c6, 0x44b508c6, - 0x44b508c6, 0x44b508c6, 0x44b508c6, 0x44cfef25, 0x44cfef25, 0x44cfef25, 0x44cfef25, 0x44cfef25, - 0x44ead584, 0x44ead584, 0x44ead584, 0x44ead584, 0x44ead584, 0x4502ddf2, 0x4502ddf2, 0x4502ddf2, - 0x4502ddf2, 0x4502ddf2, 0x45105121, 0x45105121, 0x45105121, 0x45105121, 0x45105121, 0x451dc451, - 0x451dc451, 0x451dc451, 0x451dc451, 0x451dc451, 0x452b3780, 0x452b3780, 0x452b3780, 0x452b3780, - 0x452b3780, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x4538aab0, 0x45461ddf, 0x45461ddf, - 0x45461ddf, 0x45461ddf, 0x45461ddf, 0x4553910f, 0x4553910f, 0x4553910f, 0x4553910f, 0x4553910f, - 0x4561043e, 0x4561043e, 0x4561043e, 0x4561043e, 0x4561043e, 0x456e776e, 0x456e776e, 0x456e776e, - 0x456e776e, 0x456e776e, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x457bea9d, 0x4584aee6, - 0x4584aee6, 0x4584aee6, 0x4584aee6, 0x4584aee6, 0x458b687e, 0x458b687e, 0x458b687e, 0x458b687e, - 0x458b687e, 0x45922216, 0x45922216, 0x45922216, 0x45922216, 0x45922216, 0x4598dbae, 0x4598dbae, - 0x4598dbae, 0x4598dbae, 0x4598dbae, 0x459f9545, 0x459f9545, 0x459f9545, 0x459f9545, 0x459f9545, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fff96, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffcd, 0x3f7fffcd, - 0x3f7fffcd, 0x3f7fffcd, 0x3f7fffcd, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, 0x3f7fff03, - 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffda1, 0x3f7ffba7, 0x3f7ffba7, 0x3f7ffba7, - 0x3f7ffba7, 0x3f7ffba7, 0x3f7ff913, 0x3f7ff913, 0x3f7ff913, 0x3f7ff913, 0x3f7ff913, 0x3f7ff9da, - 0x3f7ff9da, 0x3f7ff9da, 0x3f7ff9da, 0x3f7ff9da, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, 0x3f7ffc43, - 0x3f7ffc43, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7ffe13, 0x3f7fff4a, 0x3f7fff4a, - 0x3f7fff4a, 0x3f7fff4a, 0x3f7fff4a, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, 0x3f7fffea, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7fff5e, 0x3f7fff5e, 0x3f7fff5e, - 0x3f7fff5e, 0x3f7fff5e, 0x3f7ffe33, 0x3f7ffe33, 0x3f7ffe33, 0x3f7ffe33, 0x3f7ffe33, 0x3f7ffc70, - 0x3f7ffc70, 0x3f7ffc70, 0x3f7ffc70, 0x3f7ffc70, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, 0x3f7ffa15, - 0x3f7ffa15, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ff8d4, 0x3f7ffb74, 0x3f7ffb74, - 0x3f7ffb74, 0x3f7ffb74, 0x3f7ffb74, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, 0x3f7ffd7c, - 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7ffeeb, 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffc1, - 0x3f7fffc1, 0x3f7fffc1, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffa5, - 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7fffa5, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, 0x3f7ffeb2, - 0x3f7ffeb2, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffd26, 0x3f7ffb02, 0x3f7ffb02, - 0x3f7ffb02, 0x3f7ffb02, 0x3f7ffb02, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, 0x3f7ff845, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x375031dc, 0x375031dc, 0x375031dc, - 0x375031dc, 0x375031dc, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x37965f50, - 0x37965f50, 0x37965f50, 0x37965f50, 0x37965f50, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x38359439, 0x38359439, 0x38359439, 0x38359439, 0x38359439, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xb836581a, 0xb836581a, 0xb836581a, 0xb836581a, 0xb836581a, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb8a47202, 0xb8a47202, 0xb8a47202, - 0xb8a47202, 0xb8a47202, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0x38a41012, - 0x38a41012, 0x38a41012, 0x38a41012, 0x38a41012, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb8a3ae21, 0xb8a3ae21, 0xb8a3ae21, 0xb8a3ae21, 0xb8a3ae21, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x38a34c31, 0x38a34c31, 0x38a34c31, 0x38a34c31, 0x38a34c31, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb8a2ea40, 0xb8a2ea40, 0xb8a2ea40, - 0xb8a2ea40, 0xb8a2ea40, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb92ebbd8, - 0xb92ebbd8, 0xb92ebbd8, 0xb92ebbd8, 0xb92ebbd8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb8a2265f, 0xb8a2265f, 0xb8a2265f, 0xb8a2265f, 0xb8a2265f, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xb92f1dc9, 0xb92f1dc9, 0xb92f1dc9, 0xb92f1dc9, 0xb92f1dc9, -] )) ), - -################ chunk 10240 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45a64edd, 0x45ad0875, 0x45ad0875, 0x45ad0875, - 0x45ad0875, 0x45ad0875, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45b3c20d, 0x45ba7ba4, - 0x45ba7ba4, 0x45ba7ba4, 0x45ba7ba4, 0x45ba7ba4, 0x45c1353c, 0x45c1353c, 0x45c1353c, 0x45c1353c, - 0x45c1353c, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45c7eed4, 0x45cea86c, 0x45cea86c, - 0x45cea86c, 0x45cea86c, 0x45cea86c, 0x45d56203, 0x45d56203, 0x45d56203, 0x45d56203, 0x45d56203, - 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45dc1b9b, 0x45e2d533, 0x45e2d533, 0x45e2d533, - 0x45e2d533, 0x45e2d533, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45e98ecb, 0x45f04862, - 0x45f04862, 0x45f04862, 0x45f04862, 0x45f04862, 0x45f701fa, 0x45f701fa, 0x45f701fa, 0x45f701fa, - 0x45f701fa, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x45fdbb92, 0x46023a95, 0x46023a95, - 0x46023a95, 0x46023a95, 0x46023a95, 0x46059761, 0x46059761, 0x46059761, 0x46059761, 0x46059761, - 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x4608f42d, 0x460c50f8, 0x460c50f8, 0x460c50f8, - 0x460c50f8, 0x460c50f8, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x460fadc4, 0x46130a90, - 0x46130a90, 0x46130a90, 0x46130a90, 0x46130a90, 0x4616675c, 0x4616675c, 0x4616675c, 0x4616675c, - 0x4616675c, 0x4619c428, 0x4619c428, 0x4619c428, 0x4619c428, 0x4619c428, 0x461d20f4, 0x461d20f4, - 0x461d20f4, 0x461d20f4, 0x461d20f4, 0x46207dc0, 0x46207dc0, 0x46207dc0, 0x46207dc0, 0x46207dc0, - 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x4623da8c, 0x46273757, 0x46273757, 0x46273757, - 0x46273757, 0x46273757, 0x462a9423, 0x462a9423, 0x462a9423, 0x462a9423, 0x462a9423, 0x462df0ef, - 0x462df0ef, 0x462df0ef, 0x462df0ef, 0x462df0ef, 0x46314dbb, 0x46314dbb, 0x46314dbb, 0x46314dbb, - 0x46314dbb, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x4634aa87, 0x46380753, 0x46380753, - 0x46380753, 0x46380753, 0x46380753, 0x463b641f, 0x463b641f, 0x463b641f, 0x463b641f, 0x463b641f, - 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x463ec0eb, 0x46421db6, 0x46421db6, 0x46421db6, - 0x46421db6, 0x46421db6, 0x46457a82, 0x46457a82, 0x46457a82, 0x46457a82, 0x46457a82, 0x4648d74e, - 0x4648d74e, 0x4648d74e, 0x4648d74e, 0x4648d74e, 0x464c341a, 0x464c341a, 0x464c341a, 0x464c341a, - 0x464c341a, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x464f90e6, 0x4652edb2, 0x4652edb2, - 0x4652edb2, 0x4652edb2, 0x4652edb2, 0x46564a7e, 0x46564a7e, 0x46564a7e, 0x46564a7e, 0x46564a7e, - 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x4659a74a, 0x465d0415, 0x465d0415, 0x465d0415, - 0x465d0415, 0x465d0415, 0x466060e1, 0x466060e1, 0x466060e1, 0x466060e1, 0x466060e1, 0x4663bdad, - 0x4663bdad, 0x4663bdad, 0x4663bdad, 0x4663bdad, 0x46671a79, 0x46671a79, 0x46671a79, 0x46671a79, - 0x46671a79, 0x466a7745, 0x466a7745, 0x466a7745, 0x466a7745, 0x466a7745, 0x466dd411, 0x466dd411, - 0x466dd411, 0x466dd411, 0x466dd411, 0x467130dd, 0x467130dd, 0x467130dd, 0x467130dd, 0x467130dd, - 0x46748da9, 0x46748da9, 0x46748da9, 0x46748da9, 0x46748da9, 0x4677ea74, 0x4677ea74, 0x4677ea74, - 0x4677ea74, 0x4677ea74, 0x467b4740, 0x467b4740, 0x467b4740, 0x467b4740, 0x467b4740, 0x467ea40c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb8a1627e, 0xb8a1627e, 0xb8a1627e, - 0xb8a1627e, 0xb8a1627e, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb92f7fb9, - 0xb92f7fb9, 0xb92f7fb9, 0xb92f7fb9, 0xb92f7fb9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb8a09e9d, 0xb8a09e9d, 0xb8a09e9d, 0xb8a09e9d, 0xb8a09e9d, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xb92fe1aa, 0xb92fe1aa, 0xb92fe1aa, 0xb92fe1aa, 0xb92fe1aa, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0xb89fdabc, 0xb89fdabc, 0xb89fdabc, - 0xb89fdabc, 0xb89fdabc, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xbf800000, 0xb930439a, - 0xb930439a, 0xb930439a, 0xb930439a, 0xb930439a, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb89f16db, 0xb89f16db, 0xb89f16db, 0xb89f16db, 0xb89f16db, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a7ad3a, 0x39a7ad3a, 0x39a7ad3a, 0x39a7ad3a, 0x39a7ad3a, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d86b41, 0x39d86b41, 0x39d86b41, - 0x39d86b41, 0x39d86b41, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb931077b, - 0xb931077b, 0xb931077b, 0xb931077b, 0xb931077b, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb89d8f19, 0xb89d8f19, 0xb89d8f19, 0xb89d8f19, 0xb89d8f19, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a74b4a, 0x39a74b4a, 0x39a74b4a, 0x39a74b4a, 0x39a74b4a, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d8cd32, 0x39d8cd32, 0x39d8cd32, - 0x39d8cd32, 0x39d8cd32, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb931cb5c, - 0xb931cb5c, 0xb931cb5c, 0xb931cb5c, 0xb931cb5c, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb89c0757, 0xb89c0757, 0xb89c0757, 0xb89c0757, 0xb89c0757, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a6e959, 0x39a6e959, 0x39a6e959, 0x39a6e959, 0x39a6e959, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d92f22, 0x39d92f22, 0x39d92f22, - 0x39d92f22, 0x39d92f22, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9328f3d, - 0xb9328f3d, 0xb9328f3d, 0xb9328f3d, 0xb9328f3d, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb89a7f95, 0xb89a7f95, 0xb89a7f95, 0xb89a7f95, 0xb89a7f95, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a68769, 0x39a68769, 0x39a68769, 0x39a68769, 0x39a68769, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d99113, 0x39d99113, 0x39d99113, - 0x39d99113, 0x39d99113, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb933531e, - 0xb933531e, 0xb933531e, 0xb933531e, 0xb933531e, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb898f7d2, 0xb898f7d2, 0xb898f7d2, 0xb898f7d2, 0xb898f7d2, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a62578, 0x39a62578, 0x39a62578, 0x39a62578, 0x39a62578, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39d9f303, 0x39d9f303, 0x39d9f303, - 0x39d9f303, 0x39d9f303, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9341700, -] )) ), - -################ chunk 10752 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x467ea40c, 0x467ea40c, 0x467ea40c, 0x467ea40c, 0x4681006c, 0x4681006c, 0x4681006c, 0x4681006c, - 0x4681006c, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x4682aed2, 0x46845d38, 0x46845d38, - 0x46845d38, 0x46845d38, 0x46845d38, 0x46860b9e, 0x46860b9e, 0x46860b9e, 0x46860b9e, 0x46860b9e, - 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4687ba04, 0x4689686a, 0x4689686a, 0x4689686a, - 0x4689686a, 0x4689686a, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468b16d0, 0x468cc536, - 0x468cc536, 0x468cc536, 0x468cc536, 0x468cc536, 0x468e739c, 0x468e739c, 0x468e739c, 0x468e739c, - 0x468e739c, 0x46902201, 0x46902201, 0x46902201, 0x46902201, 0x46902201, 0x4691d067, 0x4691d067, - 0x4691d067, 0x4691d067, 0x4691d067, 0x46937ecd, 0x46937ecd, 0x46937ecd, 0x46937ecd, 0x46937ecd, - 0x46952d33, 0x46952d33, 0x46952d33, 0x46952d33, 0x46952d33, 0x4696db99, 0x4696db99, 0x4696db99, - 0x4696db99, 0x4696db99, 0x469889ff, 0x469889ff, 0x469889ff, 0x469889ff, 0x469889ff, 0x469a3865, - 0x469a3865, 0x469a3865, 0x469a3865, 0x469a3865, 0x469be6cb, 0x469be6cb, 0x469be6cb, 0x469be6cb, - 0x469be6cb, 0x469d9531, 0x469d9531, 0x469d9531, 0x469d9531, 0x469d9531, 0x469f4397, 0x469f4397, - 0x469f4397, 0x469f4397, 0x469f4397, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, 0x46a0f1fd, - 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a2a063, 0x46a44ec9, 0x46a44ec9, 0x46a44ec9, - 0x46a44ec9, 0x46a44ec9, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a5fd2f, 0x46a7ab95, - 0x46a7ab95, 0x46a7ab95, 0x46a7ab95, 0x46a7ab95, 0x46a959fb, 0x46a959fb, 0x46a959fb, 0x46a959fb, - 0x46a959fb, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46ab0860, 0x46acb6c6, 0x46acb6c6, - 0x46acb6c6, 0x46acb6c6, 0x46acb6c6, 0x46ae652c, 0x46ae652c, 0x46ae652c, 0x46ae652c, 0x46ae652c, - 0x46b01392, 0x46b01392, 0x46b01392, 0x46b01392, 0x46b01392, 0x46b1c1f8, 0x46b1c1f8, 0x46b1c1f8, - 0x46b1c1f8, 0x46b1c1f8, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b3705e, 0x46b51ec4, - 0x46b51ec4, 0x46b51ec4, 0x46b51ec4, 0x46b51ec4, 0x46b6cd2a, 0x46b6cd2a, 0x46b6cd2a, 0x46b6cd2a, - 0x46b6cd2a, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46b87b90, 0x46ba29f6, 0x46ba29f6, - 0x46ba29f6, 0x46ba29f6, 0x46ba29f6, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, 0x46bbd85c, - 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bd86c2, 0x46bf3528, 0x46bf3528, 0x46bf3528, - 0x46bf3528, 0x46bf3528, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c0e38e, 0x46c291f4, - 0x46c291f4, 0x46c291f4, 0x46c291f4, 0x46c291f4, 0x46c4405a, 0x46c4405a, 0x46c4405a, 0x46c4405a, - 0x46c4405a, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c5eebf, 0x46c79d25, 0x46c79d25, - 0x46c79d25, 0x46c79d25, 0x46c79d25, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, 0x46c94b8b, - 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46caf9f1, 0x46cca857, 0x46cca857, 0x46cca857, - 0x46cca857, 0x46cca857, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46ce56bd, 0x46d00523, - 0x46d00523, 0x46d00523, 0x46d00523, 0x46d00523, 0x46d1b389, 0x46d1b389, 0x46d1b389, 0x46d1b389, - 0x46d1b389, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d361ef, 0x46d51055, 0x46d51055, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xb9341700, 0xb9341700, 0xb9341700, 0xb9341700, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb8977010, 0xb8977010, 0xb8977010, 0xb8977010, 0xb8977010, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a5c388, 0x39a5c388, 0x39a5c388, 0x39a5c388, 0x39a5c388, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba12d585, 0xba12d585, 0xba12d585, - 0xba12d585, 0xba12d585, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a52c946, - 0x3a52c946, 0x3a52c946, 0x3a52c946, 0x3a52c946, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3a6d42f4, 0x3a6d42f4, 0x3a6d42f4, 0x3a6d42f4, 0x3a6d42f4, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2d4f33, 0xba2d4f33, 0xba2d4f33, 0xba2d4f33, 0xba2d4f33, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39dab6e4, 0x39dab6e4, 0x39dab6e4, - 0x39dab6e4, 0x39dab6e4, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9359ec2, - 0xb9359ec2, 0xb9359ec2, 0xb9359ec2, 0xb9359ec2, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb894608c, 0xb894608c, 0xb894608c, 0xb894608c, 0xb894608c, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a4ffa7, 0x39a4ffa7, 0x39a4ffa7, 0x39a4ffa7, 0x39a4ffa7, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba127395, 0xba127395, 0xba127395, - 0xba127395, 0xba127395, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a526756, - 0x3a526756, 0x3a526756, 0x3a526756, 0x3a526756, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3a6da4e5, 0x3a6da4e5, 0x3a6da4e5, 0x3a6da4e5, 0x3a6da4e5, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2db124, 0xba2db124, 0xba2db124, 0xba2db124, 0xba2db124, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39db7ac5, 0x39db7ac5, 0x39db7ac5, - 0x39db7ac5, 0x39db7ac5, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9372684, - 0xb9372684, 0xb9372684, 0xb9372684, 0xb9372684, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb8915108, 0xb8915108, 0xb8915108, 0xb8915108, 0xb8915108, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a43bc6, 0x39a43bc6, 0x39a43bc6, 0x39a43bc6, 0x39a43bc6, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba1211a4, 0xba1211a4, 0xba1211a4, - 0xba1211a4, 0xba1211a4, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a520565, - 0x3a520565, 0x3a520565, 0x3a520565, 0x3a520565, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3a6e06d5, 0x3a6e06d5, 0x3a6e06d5, 0x3a6e06d5, 0x3a6e06d5, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2e1315, 0xba2e1315, 0xba2e1315, 0xba2e1315, 0xba2e1315, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39dc3ea6, 0x39dc3ea6, 0x39dc3ea6, - 0x39dc3ea6, 0x39dc3ea6, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb938ae46, - 0xb938ae46, 0xb938ae46, 0xb938ae46, 0xb938ae46, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb88e4184, 0xb88e4184, 0xb88e4184, 0xb88e4184, 0xb88e4184, 0xbf800000, 0xbf800000, -] )) ), - -################ chunk 11264 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x46d51055, 0x46d51055, 0x46d51055, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, 0x46d6bebb, - 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46d86d21, 0x46da1b87, 0x46da1b87, 0x46da1b87, - 0x46da1b87, 0x46da1b87, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dbc9ed, 0x46dd7853, - 0x46dd7853, 0x46dd7853, 0x46dd7853, 0x46dd7853, 0x46df26b9, 0x46df26b9, 0x46df26b9, 0x46df26b9, - 0x46df26b9, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e0d51e, 0x46e28384, 0x46e28384, - 0x46e28384, 0x46e28384, 0x46e28384, 0x46e431ea, 0x46e431ea, 0x46e431ea, 0x46e431ea, 0x46e431ea, - 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e5e050, 0x46e78eb6, 0x46e78eb6, 0x46e78eb6, - 0x46e78eb6, 0x46e78eb6, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46e93d1c, 0x46eaeb82, - 0x46eaeb82, 0x46eaeb82, 0x46eaeb82, 0x46eaeb82, 0x46ec99e8, 0x46ec99e8, 0x46ec99e8, 0x46ec99e8, - 0x46ec99e8, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46ee484e, 0x46eff6b4, 0x46eff6b4, - 0x46eff6b4, 0x46eff6b4, 0x46eff6b4, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, 0x46f1a51a, - 0x46f35380, 0x46f35380, 0x46f35380, 0x46f35380, 0x46f35380, 0x46f501e6, 0x46f501e6, 0x46f501e6, - 0x46f501e6, 0x46f501e6, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f6b04c, 0x46f85eb2, - 0x46f85eb2, 0x46f85eb2, 0x46f85eb2, 0x46f85eb2, 0x46fa0d18, 0x46fa0d18, 0x46fa0d18, 0x46fa0d18, - 0x46fa0d18, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fbbb7d, 0x46fd69e3, 0x46fd69e3, - 0x46fd69e3, 0x46fd69e3, 0x46fd69e3, 0x46ff1849, 0x46ff1849, 0x46ff1849, 0x46ff1849, 0x46ff1849, - 0x47006358, 0x47006358, 0x47006358, 0x47006358, 0x47006358, 0x47013a8b, 0x47013a8b, 0x47013a8b, - 0x47013a8b, 0x47013a8b, 0x470211be, 0x470211be, 0x470211be, 0x470211be, 0x470211be, 0x4702e8f1, - 0x4702e8f1, 0x4702e8f1, 0x4702e8f1, 0x4702e8f1, 0x4703c024, 0x4703c024, 0x4703c024, 0x4703c024, - 0x4703c024, 0x47049756, 0x47049756, 0x47049756, 0x47049756, 0x47049756, 0x47056e89, 0x47056e89, - 0x47056e89, 0x47056e89, 0x47056e89, 0x470645bc, 0x470645bc, 0x470645bc, 0x470645bc, 0x470645bc, - 0x47071cef, 0x47071cef, 0x47071cef, 0x47071cef, 0x47071cef, 0x4707f422, 0x4707f422, 0x4707f422, - 0x4707f422, 0x4707f422, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4708cb55, 0x4709a288, - 0x4709a288, 0x4709a288, 0x4709a288, 0x4709a288, 0x470a79bb, 0x470a79bb, 0x470a79bb, 0x470a79bb, - 0x470a79bb, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470b50ee, 0x470c2821, 0x470c2821, - 0x470c2821, 0x470c2821, 0x470c2821, 0x470cff54, 0x470cff54, 0x470cff54, 0x470cff54, 0x470cff54, - 0x470dd687, 0x470dd687, 0x470dd687, 0x470dd687, 0x470dd687, 0x470eadba, 0x470eadba, 0x470eadba, - 0x470eadba, 0x470eadba, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x470f84ed, 0x47105c20, - 0x47105c20, 0x47105c20, 0x47105c20, 0x47105c20, 0x47113353, 0x47113353, 0x47113353, 0x47113353, - 0x47113353, 0x47120a86, 0x47120a86, 0x47120a86, 0x47120a86, 0x47120a86, 0x4712e1b9, 0x4712e1b9, - 0x4712e1b9, 0x4712e1b9, 0x4712e1b9, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, 0x4713b8ec, - 0x4714901f, 0x4714901f, 0x4714901f, 0x4714901f, 0x4714901f, 0x47156752, 0x47156752, 0x47156752, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a377e5, 0x39a377e5, 0x39a377e5, 0x39a377e5, 0x39a377e5, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba11afb4, 0xba11afb4, 0xba11afb4, - 0xba11afb4, 0xba11afb4, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a51a375, - 0x3a51a375, 0x3a51a375, 0x3a51a375, 0x3a51a375, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3a6e68c6, 0x3a6e68c6, 0x3a6e68c6, 0x3a6e68c6, 0x3a6e68c6, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2e7505, 0xba2e7505, 0xba2e7505, 0xba2e7505, 0xba2e7505, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x39dd0287, 0x39dd0287, 0x39dd0287, - 0x39dd0287, 0x39dd0287, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb93a3608, - 0xb93a3608, 0xb93a3608, 0xb93a3608, 0xb93a3608, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb88b31ff, 0xb88b31ff, 0xb88b31ff, 0xb88b31ff, 0xb88b31ff, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a2b404, 0x39a2b404, 0x39a2b404, 0x39a2b404, 0x39a2b404, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba114dc3, 0xba114dc3, 0xba114dc3, - 0xba114dc3, 0xba114dc3, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a514184, - 0x3a514184, 0x3a514184, 0x3a514184, 0x3a514184, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3a6ecab6, 0x3a6ecab6, 0x3a6ecab6, 0x3a6ecab6, 0x3a6ecab6, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2ed6f6, 0xba2ed6f6, 0xba2ed6f6, 0xba2ed6f6, 0xba2ed6f6, - 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0xbac88e61, 0xbac88e61, 0xbac88e61, - 0xbac88e61, 0xbac88e61, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae8883f, - 0x3ae8883f, 0x3ae8883f, 0x3ae8883f, 0x3ae8883f, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, - 0x3f7fffe2, 0x3af77dcf, 0x3af77dcf, 0x3af77dcf, 0x3af77dcf, 0x3af77dcf, 0xbf7fffe6, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbad783f1, 0xbad783f1, 0xbad783f1, 0xbad783f1, 0xbad783f1, - 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3f7fffed, 0x3ab78a12, 0x3ab78a12, 0x3ab78a12, - 0x3ab78a12, 0x3ab78a12, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba979033, - 0xba979033, 0xba979033, 0xba979033, 0xba979033, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0x3a6f2ca7, 0x3a6f2ca7, 0x3a6f2ca7, 0x3a6f2ca7, 0x3a6f2ca7, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2f38e6, 0xba2f38e6, 0xba2f38e6, 0xba2f38e6, 0xba2f38e6, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39de8a4a, 0x39de8a4a, 0x39de8a4a, - 0x39de8a4a, 0x39de8a4a, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb93d458c, - 0xb93d458c, 0xb93d458c, 0xb93d458c, 0xb93d458c, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb88512f7, 0xb88512f7, 0xb88512f7, 0xb88512f7, 0xb88512f7, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x39a12c41, 0x39a12c41, 0x39a12c41, 0x39a12c41, 0x39a12c41, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba1089e2, 0xba1089e2, 0xba1089e2, -] )) ), - -################ chunk 11776 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47156752, 0x47156752, 0x47163e85, 0x47163e85, 0x47163e85, 0x47163e85, 0x47163e85, 0x471715b8, - 0x471715b8, 0x471715b8, 0x471715b8, 0x471715b8, 0x4717eceb, 0x4717eceb, 0x4717eceb, 0x4717eceb, - 0x4717eceb, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x4718c41e, 0x47199b51, 0x47199b51, - 0x47199b51, 0x47199b51, 0x47199b51, 0x471a7284, 0x471a7284, 0x471a7284, 0x471a7284, 0x471a7284, - 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471b49b7, 0x471c20ea, 0x471c20ea, 0x471c20ea, - 0x471c20ea, 0x471c20ea, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471cf81d, 0x471dcf50, - 0x471dcf50, 0x471dcf50, 0x471dcf50, 0x471dcf50, 0x471ea683, 0x471ea683, 0x471ea683, 0x471ea683, - 0x471ea683, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x471f7db5, 0x472054e8, 0x472054e8, - 0x472054e8, 0x472054e8, 0x472054e8, 0x47212c1b, 0x47212c1b, 0x47212c1b, 0x47212c1b, 0x47212c1b, - 0x4722034e, 0x4722034e, 0x4722034e, 0x4722034e, 0x4722034e, 0x4722da81, 0x4722da81, 0x4722da81, - 0x4722da81, 0x4722da81, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x4723b1b4, 0x472488e7, - 0x472488e7, 0x472488e7, 0x472488e7, 0x472488e7, 0x4725601a, 0x4725601a, 0x4725601a, 0x4725601a, - 0x4725601a, 0x4726374d, 0x4726374d, 0x4726374d, 0x4726374d, 0x4726374d, 0x47270e80, 0x47270e80, - 0x47270e80, 0x47270e80, 0x47270e80, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, 0x4727e5b3, - 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x4728bce6, 0x47299419, 0x47299419, 0x47299419, - 0x47299419, 0x47299419, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472a6b4c, 0x472b427f, - 0x472b427f, 0x472b427f, 0x472b427f, 0x472b427f, 0x472c19b2, 0x472c19b2, 0x472c19b2, 0x472c19b2, - 0x472c19b2, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472cf0e5, 0x472dc818, 0x472dc818, - 0x472dc818, 0x472dc818, 0x472dc818, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, 0x472e9f4b, - 0x472f767e, 0x472f767e, 0x472f767e, 0x472f767e, 0x472f767e, 0x47304db1, 0x47304db1, 0x47304db1, - 0x47304db1, 0x47304db1, 0x473124e4, 0x473124e4, 0x473124e4, 0x473124e4, 0x473124e4, 0x4731fc17, - 0x4731fc17, 0x4731fc17, 0x4731fc17, 0x4731fc17, 0x4732d34a, 0x4732d34a, 0x4732d34a, 0x4732d34a, - 0x4732d34a, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x4733aa7d, 0x473481b0, 0x473481b0, - 0x473481b0, 0x473481b0, 0x473481b0, 0x473558e3, 0x473558e3, 0x473558e3, 0x473558e3, 0x473558e3, - 0x47363016, 0x47363016, 0x47363016, 0x47363016, 0x47363016, 0x47370749, 0x47370749, 0x47370749, - 0x47370749, 0x47370749, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4737de7c, 0x4738b5af, - 0x4738b5af, 0x4738b5af, 0x4738b5af, 0x4738b5af, 0x47398ce2, 0x47398ce2, 0x47398ce2, 0x47398ce2, - 0x47398ce2, 0x473a6414, 0x473a6414, 0x473a6414, 0x473a6414, 0x473a6414, 0x473b3b47, 0x473b3b47, - 0x473b3b47, 0x473b3b47, 0x473b3b47, 0x473c127a, 0x473c127a, 0x473c127a, 0x473c127a, 0x473c127a, - 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473ce9ad, 0x473dc0e0, 0x473dc0e0, 0x473dc0e0, - 0x473dc0e0, 0x473dc0e0, 0x473e9813, 0x473e9813, 0x473e9813, 0x473e9813, 0x473e9813, 0x473f6f46, - 0x473f6f46, 0x473f6f46, 0x473f6f46, 0x473f6f46, 0x47404679, 0x47404679, 0x47404679, 0x47404679, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xba1089e2, 0xba1089e2, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a507da3, - 0x3a507da3, 0x3a507da3, 0x3a507da3, 0x3a507da3, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0xba8838b2, 0xba8838b2, 0xba8838b2, 0xba8838b2, 0xba8838b2, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0x3aa83291, 0x3aa83291, 0x3aa83291, 0x3aa83291, 0x3aa83291, - 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0x3f7fffef, 0xbac82c70, 0xbac82c70, 0xbac82c70, - 0xbac82c70, 0xbac82c70, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae8264e, - 0x3ae8264e, 0x3ae8264e, 0x3ae8264e, 0x3ae8264e, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, - 0x3f7fffe2, 0x3af7dfbf, 0x3af7dfbf, 0x3af7dfbf, 0x3af7dfbf, 0x3af7dfbf, 0xbf7fffe6, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbad7e5e1, 0xbad7e5e1, 0xbad7e5e1, 0xbad7e5e1, 0xbad7e5e1, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3ab7ec03, 0x3ab7ec03, 0x3ab7ec03, - 0x3ab7ec03, 0x3ab7ec03, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba97f224, - 0xba97f224, 0xba97f224, 0xba97f224, 0xba97f224, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0x3a6ff088, 0x3a6ff088, 0x3a6ff088, 0x3a6ff088, 0x3a6ff088, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba2ffcc7, 0xba2ffcc7, 0xba2ffcc7, 0xba2ffcc7, 0xba2ffcc7, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39e0120c, 0x39e0120c, 0x39e0120c, - 0x39e0120c, 0x39e0120c, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9405510, - 0xb9405510, 0xb9405510, 0xb9405510, 0xb9405510, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb87de7dd, 0xb87de7dd, 0xb87de7dd, 0xb87de7dd, 0xb87de7dd, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x399fa47f, 0x399fa47f, 0x399fa47f, 0x399fa47f, 0x399fa47f, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba0fc601, 0xba0fc601, 0xba0fc601, - 0xba0fc601, 0xba0fc601, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a4fb9c2, - 0x3a4fb9c2, 0x3a4fb9c2, 0x3a4fb9c2, 0x3a4fb9c2, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0xba87d6c1, 0xba87d6c1, 0xba87d6c1, 0xba87d6c1, 0xba87d6c1, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0x3aa7d0a1, 0x3aa7d0a1, 0x3aa7d0a1, 0x3aa7d0a1, 0x3aa7d0a1, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0xbac7ca80, 0xbac7ca80, 0xbac7ca80, - 0xbac7ca80, 0xbac7ca80, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae7c45e, - 0x3ae7c45e, 0x3ae7c45e, 0x3ae7c45e, 0x3ae7c45e, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, - 0x3f7fffe2, 0x3af841b0, 0x3af841b0, 0x3af841b0, 0x3af841b0, 0x3af841b0, 0xbf7fffe6, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbad847d2, 0xbad847d2, 0xbad847d2, 0xbad847d2, 0xbad847d2, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3ab84df3, 0x3ab84df3, 0x3ab84df3, - 0x3ab84df3, 0x3ab84df3, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba985414, - 0xba985414, 0xba985414, 0xba985414, 0xba985414, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, -] )) ), - -################ chunk 12288 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47404679, 0x47411dac, 0x47411dac, 0x47411dac, 0x47411dac, 0x47411dac, 0x4741f4df, 0x4741f4df, - 0x4741f4df, 0x4741f4df, 0x4741f4df, 0x4742cc12, 0x4742cc12, 0x4742cc12, 0x4742cc12, 0x4742cc12, - 0x4743a345, 0x4743a345, 0x4743a345, 0x4743a345, 0x4743a345, 0x47447a78, 0x47447a78, 0x47447a78, - 0x47447a78, 0x47447a78, 0x474551ab, 0x474551ab, 0x474551ab, 0x474551ab, 0x474551ab, 0x474628de, - 0x474628de, 0x474628de, 0x474628de, 0x474628de, 0x47470011, 0x47470011, 0x47470011, 0x47470011, - 0x47470011, 0x4747d744, 0x4747d744, 0x4747d744, 0x4747d744, 0x4747d744, 0x4748ae77, 0x4748ae77, - 0x4748ae77, 0x4748ae77, 0x4748ae77, 0x474985aa, 0x474985aa, 0x474985aa, 0x474985aa, 0x474985aa, - 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474a5cdd, 0x474b3410, 0x474b3410, 0x474b3410, - 0x474b3410, 0x474b3410, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474c0b43, 0x474ce276, - 0x474ce276, 0x474ce276, 0x474ce276, 0x474ce276, 0x474db9a9, 0x474db9a9, 0x474db9a9, 0x474db9a9, - 0x474db9a9, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474e90dc, 0x474f680f, 0x474f680f, - 0x474f680f, 0x474f680f, 0x474f680f, 0x47503f42, 0x47503f42, 0x47503f42, 0x47503f42, 0x47503f42, - 0x47511675, 0x47511675, 0x47511675, 0x47511675, 0x47511675, 0x4751eda8, 0x4751eda8, 0x4751eda8, - 0x4751eda8, 0x4751eda8, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x4752c4db, 0x47539c0e, - 0x47539c0e, 0x47539c0e, 0x47539c0e, 0x47539c0e, 0x47547341, 0x47547341, 0x47547341, 0x47547341, - 0x47547341, 0x47554a73, 0x47554a73, 0x47554a73, 0x47554a73, 0x47554a73, 0x475621a6, 0x475621a6, - 0x475621a6, 0x475621a6, 0x475621a6, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, 0x4756f8d9, - 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4757d00c, 0x4758a73f, 0x4758a73f, 0x4758a73f, - 0x4758a73f, 0x4758a73f, 0x47597e72, 0x47597e72, 0x47597e72, 0x47597e72, 0x47597e72, 0x475a55a5, - 0x475a55a5, 0x475a55a5, 0x475a55a5, 0x475a55a5, 0x475b2cd8, 0x475b2cd8, 0x475b2cd8, 0x475b2cd8, - 0x475b2cd8, 0x475c040b, 0x475c040b, 0x475c040b, 0x475c040b, 0x475c040b, 0x475cdb3e, 0x475cdb3e, - 0x475cdb3e, 0x475cdb3e, 0x475cdb3e, 0x475db271, 0x475db271, 0x475db271, 0x475db271, 0x475db271, - 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475e89a4, 0x475f60d7, 0x475f60d7, 0x475f60d7, - 0x475f60d7, 0x475f60d7, 0x4760380a, 0x4760380a, 0x4760380a, 0x4760380a, 0x4760380a, 0x47610f3d, - 0x47610f3d, 0x47610f3d, 0x47610f3d, 0x47610f3d, 0x4761e670, 0x4761e670, 0x4761e670, 0x4761e670, - 0x4761e670, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x4762bda3, 0x476394d6, 0x476394d6, - 0x476394d6, 0x476394d6, 0x476394d6, 0x47646c09, 0x47646c09, 0x47646c09, 0x47646c09, 0x47646c09, - 0x4765433c, 0x4765433c, 0x4765433c, 0x4765433c, 0x4765433c, 0x47661a6f, 0x47661a6f, 0x47661a6f, - 0x47661a6f, 0x47661a6f, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4766f1a2, 0x4767c8d5, - 0x4767c8d5, 0x4767c8d5, 0x4767c8d5, 0x4767c8d5, 0x4768a008, 0x4768a008, 0x4768a008, 0x4768a008, - 0x4768a008, 0x4769773b, 0x4769773b, 0x4769773b, 0x4769773b, 0x4769773b, 0x476a4e6e, 0x476a4e6e, - 0x476a4e6e, 0x476a4e6e, 0x476a4e6e, 0x476b25a1, 0x476b25a1, 0x476b25a1, 0x476b25a1, 0x476b25a1, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffff7, 0x3a70b469, 0x3a70b469, 0x3a70b469, 0x3a70b469, 0x3a70b469, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba30c0a8, 0xba30c0a8, 0xba30c0a8, 0xba30c0a8, 0xba30c0a8, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39e199ce, 0x39e199ce, 0x39e199ce, - 0x39e199ce, 0x39e199ce, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9436495, - 0xb9436495, 0xb9436495, 0xb9436495, 0xb9436495, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb871a9cc, 0xb871a9cc, 0xb871a9cc, 0xb871a9cc, 0xb871a9cc, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x399e1cbd, 0x399e1cbd, 0x399e1cbd, 0x399e1cbd, 0x399e1cbd, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0xba0f0220, 0xba0f0220, 0xba0f0220, - 0xba0f0220, 0xba0f0220, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a4ef5e1, - 0x3a4ef5e1, 0x3a4ef5e1, 0x3a4ef5e1, 0x3a4ef5e1, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0xba8774d1, 0xba8774d1, 0xba8774d1, 0xba8774d1, 0xba8774d1, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0x3aa76eb0, 0x3aa76eb0, 0x3aa76eb0, 0x3aa76eb0, 0x3aa76eb0, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0xbac7688f, 0xbac7688f, 0xbac7688f, - 0xbac7688f, 0xbac7688f, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae7626d, - 0x3ae7626d, 0x3ae7626d, 0x3ae7626d, 0x3ae7626d, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, - 0x3f7fffe2, 0x3af8a3a0, 0x3af8a3a0, 0x3af8a3a0, 0x3af8a3a0, 0x3af8a3a0, 0xbf7fffe6, 0xbf7fffe6, - 0xbf7fffe6, 0xbf7fffe6, 0xbf7fffe6, 0xbad8a9c2, 0xbad8a9c2, 0xbad8a9c2, 0xbad8a9c2, 0xbad8a9c2, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3ab8afe4, 0x3ab8afe4, 0x3ab8afe4, - 0x3ab8afe4, 0x3ab8afe4, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba98b605, - 0xba98b605, 0xba98b605, 0xba98b605, 0xba98b605, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0x3a71784a, 0x3a71784a, 0x3a71784a, 0x3a71784a, 0x3a71784a, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba318489, 0xba318489, 0xba318489, 0xba318489, 0xba318489, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39e32190, 0x39e32190, 0x39e32190, - 0x39e32190, 0x39e32190, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb9467419, - 0xb9467419, 0xb9467419, 0xb9467419, 0xb9467419, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb8656bbb, 0xb8656bbb, 0xb8656bbb, 0xb8656bbb, 0xb8656bbb, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x399c94fb, 0x399c94fb, 0x399c94fb, 0x399c94fb, 0x399c94fb, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0xba0e3e3f, 0xba0e3e3f, 0xba0e3e3f, - 0xba0e3e3f, 0xba0e3e3f, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0x3a4e3200, - 0x3a4e3200, 0x3a4e3200, 0x3a4e3200, 0x3a4e3200, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0xba8712e0, 0xba8712e0, 0xba8712e0, 0xba8712e0, 0xba8712e0, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0x3aa70cc0, 0x3aa70cc0, 0x3aa70cc0, 0x3aa70cc0, 0x3aa70cc0, -] )) ), - -################ chunk 12800 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476bfcd4, 0x476cd407, 0x476cd407, 0x476cd407, - 0x476cd407, 0x476cd407, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476dab3a, 0x476e826d, - 0x476e826d, 0x476e826d, 0x476e826d, 0x476e826d, 0x476f59a0, 0x476f59a0, 0x476f59a0, 0x476f59a0, - 0x476f59a0, 0x477030d2, 0x477030d2, 0x477030d2, 0x477030d2, 0x477030d2, 0x47710805, 0x47710805, - 0x47710805, 0x47710805, 0x47710805, 0x4771df38, 0x4771df38, 0x4771df38, 0x4771df38, 0x4771df38, - 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x4772b66b, 0x47738d9e, 0x47738d9e, 0x47738d9e, - 0x47738d9e, 0x47738d9e, 0x477464d1, 0x477464d1, 0x477464d1, 0x477464d1, 0x477464d1, 0x47753c04, - 0x47753c04, 0x47753c04, 0x47753c04, 0x47753c04, 0x47761337, 0x47761337, 0x47761337, 0x47761337, - 0x47761337, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4776ea6a, 0x4777c19d, 0x4777c19d, - 0x4777c19d, 0x4777c19d, 0x4777c19d, 0x477898d0, 0x477898d0, 0x477898d0, 0x477898d0, 0x477898d0, - 0x47797003, 0x47797003, 0x47797003, 0x47797003, 0x47797003, 0x477a4736, 0x477a4736, 0x477a4736, - 0x477a4736, 0x477a4736, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477b1e69, 0x477bf59c, - 0x477bf59c, 0x477bf59c, 0x477bf59c, 0x477bf59c, 0x477ccccf, 0x477ccccf, 0x477ccccf, 0x477ccccf, - 0x477ccccf, 0x477da402, 0x477da402, 0x477da402, 0x477da402, 0x477da402, 0x477e7b35, 0x477e7b35, - 0x477e7b35, 0x477e7b35, 0x477e7b35, 0x477f5268, 0x477f5268, 0x477f5268, 0x477f5268, 0x477f5268, - 0x478014cd, 0x478014cd, 0x478014cd, 0x478014cd, 0x478014cd, 0x47808067, 0x47808067, 0x47808067, - 0x47808067, 0x47808067, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4780ec00, 0x4781579a, - 0x4781579a, 0x4781579a, 0x4781579a, 0x4781579a, 0x4781c333, 0x4781c333, 0x4781c333, 0x4781c333, - 0x4781c333, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47822ecd, 0x47829a66, 0x47829a66, - 0x47829a66, 0x47829a66, 0x47829a66, 0x47830600, 0x47830600, 0x47830600, 0x47830600, 0x47830600, - 0x47837199, 0x47837199, 0x47837199, 0x47837199, 0x47837199, 0x4783dd33, 0x4783dd33, 0x4783dd33, - 0x4783dd33, 0x4783dd33, 0x478448cc, 0x478448cc, 0x478448cc, 0x478448cc, 0x478448cc, 0x4784b466, - 0x4784b466, 0x4784b466, 0x4784b466, 0x4784b466, 0x47851fff, 0x47851fff, 0x47851fff, 0x47851fff, - 0x47851fff, 0x47858b99, 0x47858b99, 0x47858b99, 0x47858b99, 0x47858b99, 0x4785f732, 0x4785f732, - 0x4785f732, 0x4785f732, 0x4785f732, 0x478662cc, 0x478662cc, 0x478662cc, 0x478662cc, 0x478662cc, - 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x4786ce65, 0x478739ff, 0x478739ff, 0x478739ff, - 0x478739ff, 0x478739ff, 0x4787a598, 0x4787a598, 0x4787a598, 0x4787a598, 0x4787a598, 0x47881132, - 0x47881132, 0x47881132, 0x47881132, 0x47881132, 0x47887ccb, 0x47887ccb, 0x47887ccb, 0x47887ccb, - 0x47887ccb, 0x4788e865, 0x4788e865, 0x4788e865, 0x4788e865, 0x4788e865, 0x478953fe, 0x478953fe, - 0x478953fe, 0x478953fe, 0x478953fe, 0x4789bf98, 0x4789bf98, 0x4789bf98, 0x4789bf98, 0x4789bf98, - 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a2b31, 0x478a96cb, 0x478a96cb, 0x478a96cb, - 0x478a96cb, 0x478a96cb, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b0264, 0x478b6dfe, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0xbac7069f, 0xbac7069f, 0xbac7069f, - 0xbac7069f, 0xbac7069f, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0xbf7fffe9, 0x3ae7007d, - 0x3ae7007d, 0x3ae7007d, 0x3ae7007d, 0x3ae7007d, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, - 0x3f7fffe2, 0x3af90591, 0x3af90591, 0x3af90591, 0x3af90591, 0x3af90591, 0xbf7fffe5, 0xbf7fffe5, - 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0xbad90bb3, 0xbad90bb3, 0xbad90bb3, 0xbad90bb3, 0xbad90bb3, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3ab911d4, 0x3ab911d4, 0x3ab911d4, - 0x3ab911d4, 0x3ab911d4, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xba9917f5, - 0xba9917f5, 0xba9917f5, 0xba9917f5, 0xba9917f5, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0x3a723c2b, 0x3a723c2b, 0x3a723c2b, 0x3a723c2b, 0x3a723c2b, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0xba32486a, 0xba32486a, 0xba32486a, 0xba32486a, 0xba32486a, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x39e4a952, 0x39e4a952, 0x39e4a952, - 0x39e4a952, 0x39e4a952, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xb949839d, - 0xb949839d, 0xb949839d, 0xb949839d, 0xb949839d, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xb8592daa, 0xb8592daa, 0xb8592daa, 0xb8592daa, 0xb8592daa, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x399b0d39, 0x399b0d39, 0x399b0d39, 0x399b0d39, 0x399b0d39, - 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0xba0d7a5e, 0xba0d7a5e, 0xba0d7a5e, - 0xba0d7a5e, 0xba0d7a5e, 0xbf7fffa8, 0xbf7fffa8, 0xbf7fffa8, 0xbf7fffa8, 0xbf7fffa8, 0x3a4d6e1f, - 0x3a4d6e1f, 0x3a4d6e1f, 0x3a4d6e1f, 0x3a4d6e1f, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0xba86b0f0, 0xba86b0f0, 0xba86b0f0, 0xba86b0f0, 0xba86b0f0, 0xbf7fffc0, 0xbf7fffc0, - 0xbf7fffc0, 0xbf7fffc0, 0xbf7fffc0, 0x3aa6aacf, 0x3aa6aacf, 0x3aa6aacf, 0x3aa6aacf, 0x3aa6aacf, - 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0xbac6a4ae, 0xbac6a4ae, 0xbac6a4ae, - 0xbac6a4ae, 0xbac6a4ae, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0x3ae69e8c, - 0x3ae69e8c, 0x3ae69e8c, 0x3ae69e8c, 0x3ae69e8c, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, 0x3f7fffde, - 0x3f7fffde, 0xbb034c35, 0xbb034c35, 0xbb034c35, 0xbb034c35, 0xbb034c35, 0xbf7fffe5, 0xbf7fffe5, - 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b134923, 0x3b134923, 0x3b134923, 0x3b134923, 0x3b134923, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb234610, 0xbb234610, 0xbb234610, - 0xbb234610, 0xbb234610, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0x3b3342fd, - 0x3b3342fd, 0x3b3342fd, 0x3b3342fd, 0x3b3342fd, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0xbb433fea, 0xbb433fea, 0xbb433fea, 0xbb433fea, 0xbb433fea, 0xbf7ffffb, 0xbf7ffffb, - 0xbf7ffffb, 0xbf7ffffb, 0xbf7ffffb, 0x3b533cd5, 0x3b533cd5, 0x3b533cd5, 0x3b533cd5, 0x3b533cd5, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb6339c0, 0xbb6339c0, 0xbb6339c0, - 0xbb6339c0, 0xbb6339c0, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b7336a9, -] )) ), - -################ chunk 13312 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x478b6dfe, 0x478b6dfe, 0x478b6dfe, 0x478b6dfe, 0x478bd997, 0x478bd997, 0x478bd997, 0x478bd997, - 0x478bd997, 0x478c4530, 0x478c4530, 0x478c4530, 0x478c4530, 0x478c4530, 0x478cb0ca, 0x478cb0ca, - 0x478cb0ca, 0x478cb0ca, 0x478cb0ca, 0x478d1c63, 0x478d1c63, 0x478d1c63, 0x478d1c63, 0x478d1c63, - 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478d87fd, 0x478df396, 0x478df396, 0x478df396, - 0x478df396, 0x478df396, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478e5f30, 0x478ecac9, - 0x478ecac9, 0x478ecac9, 0x478ecac9, 0x478ecac9, 0x478f3663, 0x478f3663, 0x478f3663, 0x478f3663, - 0x478f3663, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x478fa1fc, 0x47900d96, 0x47900d96, - 0x47900d96, 0x47900d96, 0x47900d96, 0x4790792f, 0x4790792f, 0x4790792f, 0x4790792f, 0x4790792f, - 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x4790e4c9, 0x47915062, 0x47915062, 0x47915062, - 0x47915062, 0x47915062, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x4791bbfc, 0x47922795, - 0x47922795, 0x47922795, 0x47922795, 0x47922795, 0x4792932f, 0x4792932f, 0x4792932f, 0x4792932f, - 0x4792932f, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x4792fec8, 0x47936a62, 0x47936a62, - 0x47936a62, 0x47936a62, 0x47936a62, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, 0x4793d5fb, - 0x47944195, 0x47944195, 0x47944195, 0x47944195, 0x47944195, 0x4794ad2e, 0x4794ad2e, 0x4794ad2e, - 0x4794ad2e, 0x4794ad2e, 0x479518c8, 0x479518c8, 0x479518c8, 0x479518c8, 0x479518c8, 0x47958461, - 0x47958461, 0x47958461, 0x47958461, 0x47958461, 0x4795effb, 0x4795effb, 0x4795effb, 0x4795effb, - 0x4795effb, 0x47965b94, 0x47965b94, 0x47965b94, 0x47965b94, 0x47965b94, 0x4796c72e, 0x4796c72e, - 0x4796c72e, 0x4796c72e, 0x4796c72e, 0x479732c7, 0x479732c7, 0x479732c7, 0x479732c7, 0x479732c7, - 0x47979e61, 0x47979e61, 0x47979e61, 0x47979e61, 0x47979e61, 0x479809fa, 0x479809fa, 0x479809fa, - 0x479809fa, 0x479809fa, 0x47987594, 0x47987594, 0x47987594, 0x47987594, 0x47987594, 0x4798e12d, - 0x4798e12d, 0x4798e12d, 0x4798e12d, 0x4798e12d, 0x47994cc7, 0x47994cc7, 0x47994cc7, 0x47994cc7, - 0x47994cc7, 0x4799b860, 0x4799b860, 0x4799b860, 0x4799b860, 0x4799b860, 0x479a23f9, 0x479a23f9, - 0x479a23f9, 0x479a23f9, 0x479a23f9, 0x479a8f93, 0x479a8f93, 0x479a8f93, 0x479a8f93, 0x479a8f93, - 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479afb2c, 0x479b66c6, 0x479b66c6, 0x479b66c6, - 0x479b66c6, 0x479b66c6, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479bd25f, 0x479c3df9, - 0x479c3df9, 0x479c3df9, 0x479c3df9, 0x479c3df9, 0x479ca992, 0x479ca992, 0x479ca992, 0x479ca992, - 0x479ca992, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d152c, 0x479d80c5, 0x479d80c5, - 0x479d80c5, 0x479d80c5, 0x479d80c5, 0x479dec5f, 0x479dec5f, 0x479dec5f, 0x479dec5f, 0x479dec5f, - 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479e57f8, 0x479ec392, 0x479ec392, 0x479ec392, - 0x479ec392, 0x479ec392, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f2f2b, 0x479f9ac5, - 0x479f9ac5, 0x479f9ac5, 0x479f9ac5, 0x479f9ac5, 0x47a0065e, 0x47a0065e, 0x47a0065e, 0x47a0065e, - 0x47a0065e, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a071f8, 0x47a0dd91, 0x47a0dd91, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3b7336a9, 0x3b7336a9, 0x3b7336a9, 0x3b7336a9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3b7ccc19, 0x3b7ccc19, 0x3b7ccc19, 0x3b7ccc19, 0x3b7ccc19, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6ccf2f, 0xbb6ccf2f, 0xbb6ccf2f, 0xbb6ccf2f, 0xbb6ccf2f, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5cd245, 0x3b5cd245, 0x3b5cd245, - 0x3b5cd245, 0x3b5cd245, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbb4cd55a, - 0xbb4cd55a, 0xbb4cd55a, 0xbb4cd55a, 0xbb4cd55a, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3b3cd86f, 0x3b3cd86f, 0x3b3cd86f, 0x3b3cd86f, 0x3b3cd86f, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2cdb82, 0xbb2cdb82, 0xbb2cdb82, 0xbb2cdb82, 0xbb2cdb82, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1cde95, 0x3b1cde95, 0x3b1cde95, - 0x3b1cde95, 0x3b1cde95, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0ce1a7, - 0xbb0ce1a7, 0xbb0ce1a7, 0xbb0ce1a7, 0xbb0ce1a7, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, 0x3f7fffe2, - 0x3f7fffe2, 0x3af9c972, 0x3af9c972, 0x3af9c972, 0x3af9c972, 0x3af9c972, 0xbf7fffda, 0xbf7fffda, - 0xbf7fffda, 0xbf7fffda, 0xbf7fffda, 0xbad9cf94, 0xbad9cf94, 0xbad9cf94, 0xbad9cf94, 0xbad9cf94, - 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3ab9d5b5, 0x3ab9d5b5, 0x3ab9d5b5, - 0x3ab9d5b5, 0x3ab9d5b5, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xba99dbd6, - 0xba99dbd6, 0xba99dbd6, 0xba99dbd6, 0xba99dbd6, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, - 0x3f7fffbc, 0x3a73c3ed, 0x3a73c3ed, 0x3a73c3ed, 0x3a73c3ed, 0x3a73c3ed, 0xbf7fffaf, 0xbf7fffaf, - 0xbf7fffaf, 0xbf7fffaf, 0xbf7fffaf, 0xba33d02c, 0xba33d02c, 0xba33d02c, 0xba33d02c, 0xba33d02c, - 0x3f7fffa2, 0x3f7fffa2, 0x3f7fffa2, 0x3f7fffa2, 0x3f7fffa2, 0x39e7b8d6, 0x39e7b8d6, 0x39e7b8d6, - 0x39e7b8d6, 0x39e7b8d6, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xb94fa2a6, - 0xb94fa2a6, 0xb94fa2a6, 0xb94fa2a6, 0xb94fa2a6, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, - 0x3f7fff85, 0xb840b188, 0xb840b188, 0xb840b188, 0xb840b188, 0xb840b188, 0xbf7fff8b, 0xbf7fff8b, - 0xbf7fff8b, 0xbf7fff8b, 0xbf7fff8b, 0x3997fdb5, 0x3997fdb5, 0x3997fdb5, 0x3997fdb5, 0x3997fdb5, - 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0x3f7fff9a, 0xba0bf29c, 0xba0bf29c, 0xba0bf29c, - 0xba0bf29c, 0xba0bf29c, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0x3a4be65d, - 0x3a4be65d, 0x3a4be65d, 0x3a4be65d, 0x3a4be65d, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0xba85ed0f, 0xba85ed0f, 0xba85ed0f, 0xba85ed0f, 0xba85ed0f, 0xbf7fffc0, 0xbf7fffc0, - 0xbf7fffc0, 0xbf7fffc0, 0xbf7fffc0, 0x3aa5e6ee, 0x3aa5e6ee, 0x3aa5e6ee, 0x3aa5e6ee, 0x3aa5e6ee, - 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0xbac5e0cd, 0xbac5e0cd, 0xbac5e0cd, - 0xbac5e0cd, 0xbac5e0cd, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0xbf7fffd5, 0x3ae5daab, - 0x3ae5daab, 0x3ae5daab, 0x3ae5daab, 0x3ae5daab, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, - 0x3f7fffdd, 0xbb02ea44, 0xbb02ea44, 0xbb02ea44, 0xbb02ea44, 0xbb02ea44, 0xbf7fffe5, 0xbf7fffe5, -] )) ), - -################ chunk 13824 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47a0dd91, 0x47a0dd91, 0x47a0dd91, 0x47a1492b, 0x47a1492b, 0x47a1492b, 0x47a1492b, 0x47a1492b, - 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a1b4c4, 0x47a2205e, 0x47a2205e, 0x47a2205e, - 0x47a2205e, 0x47a2205e, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a28bf7, 0x47a2f791, - 0x47a2f791, 0x47a2f791, 0x47a2f791, 0x47a2f791, 0x47a3632a, 0x47a3632a, 0x47a3632a, 0x47a3632a, - 0x47a3632a, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a3cec4, 0x47a43a5d, 0x47a43a5d, - 0x47a43a5d, 0x47a43a5d, 0x47a43a5d, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, 0x47a4a5f7, - 0x47a51190, 0x47a51190, 0x47a51190, 0x47a51190, 0x47a51190, 0x47a57d2a, 0x47a57d2a, 0x47a57d2a, - 0x47a57d2a, 0x47a57d2a, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a5e8c3, 0x47a6545d, - 0x47a6545d, 0x47a6545d, 0x47a6545d, 0x47a6545d, 0x47a6bff6, 0x47a6bff6, 0x47a6bff6, 0x47a6bff6, - 0x47a6bff6, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a72b8f, 0x47a79729, 0x47a79729, - 0x47a79729, 0x47a79729, 0x47a79729, 0x47a802c2, 0x47a802c2, 0x47a802c2, 0x47a802c2, 0x47a802c2, - 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a86e5c, 0x47a8d9f5, 0x47a8d9f5, 0x47a8d9f5, - 0x47a8d9f5, 0x47a8d9f5, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9458f, 0x47a9b128, - 0x47a9b128, 0x47a9b128, 0x47a9b128, 0x47a9b128, 0x47aa1cc2, 0x47aa1cc2, 0x47aa1cc2, 0x47aa1cc2, - 0x47aa1cc2, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aa885b, 0x47aaf3f5, 0x47aaf3f5, - 0x47aaf3f5, 0x47aaf3f5, 0x47aaf3f5, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, 0x47ab5f8e, - 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47abcb28, 0x47ac36c1, 0x47ac36c1, 0x47ac36c1, - 0x47ac36c1, 0x47ac36c1, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47aca25b, 0x47ad0df4, - 0x47ad0df4, 0x47ad0df4, 0x47ad0df4, 0x47ad0df4, 0x47ad798e, 0x47ad798e, 0x47ad798e, 0x47ad798e, - 0x47ad798e, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ade527, 0x47ae50c1, 0x47ae50c1, - 0x47ae50c1, 0x47ae50c1, 0x47ae50c1, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, 0x47aebc5a, - 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af27f4, 0x47af938d, 0x47af938d, 0x47af938d, - 0x47af938d, 0x47af938d, 0x47afff27, 0x47afff27, 0x47afff27, 0x47afff27, 0x47afff27, 0x47b06ac0, - 0x47b06ac0, 0x47b06ac0, 0x47b06ac0, 0x47b06ac0, 0x47b0d65a, 0x47b0d65a, 0x47b0d65a, 0x47b0d65a, - 0x47b0d65a, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b141f3, 0x47b1ad8d, 0x47b1ad8d, - 0x47b1ad8d, 0x47b1ad8d, 0x47b1ad8d, 0x47b21926, 0x47b21926, 0x47b21926, 0x47b21926, 0x47b21926, - 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b284c0, 0x47b2f059, 0x47b2f059, 0x47b2f059, - 0x47b2f059, 0x47b2f059, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b35bf3, 0x47b3c78c, - 0x47b3c78c, 0x47b3c78c, 0x47b3c78c, 0x47b3c78c, 0x47b43326, 0x47b43326, 0x47b43326, 0x47b43326, - 0x47b43326, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b49ebf, 0x47b50a58, 0x47b50a58, - 0x47b50a58, 0x47b50a58, 0x47b50a58, 0x47b575f2, 0x47b575f2, 0x47b575f2, 0x47b575f2, 0x47b575f2, - 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b5e18b, 0x47b64d25, 0x47b64d25, 0x47b64d25, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b12e732, 0x3b12e732, 0x3b12e732, 0x3b12e732, 0x3b12e732, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb22e420, 0xbb22e420, 0xbb22e420, - 0xbb22e420, 0xbb22e420, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0x3b32e10d, - 0x3b32e10d, 0x3b32e10d, 0x3b32e10d, 0x3b32e10d, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0xbb42ddf9, 0xbb42ddf9, 0xbb42ddf9, 0xbb42ddf9, 0xbb42ddf9, 0xbf7ffffa, 0xbf7ffffa, - 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b52dae5, 0x3b52dae5, 0x3b52dae5, 0x3b52dae5, 0x3b52dae5, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb62d7cf, 0xbb62d7cf, 0xbb62d7cf, - 0xbb62d7cf, 0xbb62d7cf, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b72d4b9, - 0x3b72d4b9, 0x3b72d4b9, 0x3b72d4b9, 0x3b72d4b9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3b7d2e09, 0x3b7d2e09, 0x3b7d2e09, 0x3b7d2e09, 0x3b7d2e09, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6d3120, 0xbb6d3120, 0xbb6d3120, 0xbb6d3120, 0xbb6d3120, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5d3436, 0x3b5d3436, 0x3b5d3436, - 0x3b5d3436, 0x3b5d3436, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbb4d374b, - 0xbb4d374b, 0xbb4d374b, 0xbb4d374b, 0xbb4d374b, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3b3d3a5f, 0x3b3d3a5f, 0x3b3d3a5f, 0x3b3d3a5f, 0x3b3d3a5f, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2d3d73, 0xbb2d3d73, 0xbb2d3d73, 0xbb2d3d73, 0xbb2d3d73, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1d4085, 0x3b1d4085, 0x3b1d4085, - 0x3b1d4085, 0x3b1d4085, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0d4398, - 0xbb0d4398, 0xbb0d4398, 0xbb0d4398, 0xbb0d4398, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, - 0x3f7fffe3, 0x3afa8d53, 0x3afa8d53, 0x3afa8d53, 0x3afa8d53, 0x3afa8d53, 0xbf7fffda, 0xbf7fffda, - 0xbf7fffda, 0xbf7fffda, 0xbf7fffda, 0xbada9375, 0xbada9375, 0xbada9375, 0xbada9375, 0xbada9375, - 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3aba9996, 0x3aba9996, 0x3aba9996, - 0x3aba9996, 0x3aba9996, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xba9a9fb7, - 0xba9a9fb7, 0xba9a9fb7, 0xba9a9fb7, 0xba9a9fb7, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, - 0x3f7fffbc, 0x3a754baf, 0x3a754baf, 0x3a754baf, 0x3a754baf, 0x3a754baf, 0xbf7fffb0, 0xbf7fffb0, - 0xbf7fffb0, 0xbf7fffb0, 0xbf7fffb0, 0xba3557ee, 0xba3557ee, 0xba3557ee, 0xba3557ee, 0xba3557ee, - 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x39eac85b, 0x39eac85b, 0x39eac85b, - 0x39eac85b, 0x39eac85b, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xbf7fff94, 0xb955c1ae, - 0xb955c1ae, 0xb955c1ae, 0xb955c1ae, 0xb955c1ae, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, 0x3f7fff85, - 0x3f7fff85, 0xb8283566, 0xb8283566, 0xb8283566, 0xb8283566, 0xb8283566, 0xbf7fff8a, 0xbf7fff8a, - 0xbf7fff8a, 0xbf7fff8a, 0xbf7fff8a, 0x3994ee30, 0x3994ee30, 0x3994ee30, 0x3994ee30, 0x3994ee30, - 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0xba0a6ada, 0xba0a6ada, 0xba0a6ada, -] )) ), - -################ chunk 14336 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47b64d25, 0x47b64d25, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b6b8be, 0x47b72458, - 0x47b72458, 0x47b72458, 0x47b72458, 0x47b72458, 0x47b78ff1, 0x47b78ff1, 0x47b78ff1, 0x47b78ff1, - 0x47b78ff1, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b7fb8b, 0x47b86724, 0x47b86724, - 0x47b86724, 0x47b86724, 0x47b86724, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, 0x47b8d2be, - 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b93e57, 0x47b9a9f1, 0x47b9a9f1, 0x47b9a9f1, - 0x47b9a9f1, 0x47b9a9f1, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba158a, 0x47ba8124, - 0x47ba8124, 0x47ba8124, 0x47ba8124, 0x47ba8124, 0x47baecbd, 0x47baecbd, 0x47baecbd, 0x47baecbd, - 0x47baecbd, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bb5857, 0x47bbc3f0, 0x47bbc3f0, - 0x47bbc3f0, 0x47bbc3f0, 0x47bbc3f0, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, 0x47bc2f8a, - 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bc9b23, 0x47bd06bd, 0x47bd06bd, 0x47bd06bd, - 0x47bd06bd, 0x47bd06bd, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bd7256, 0x47bdddf0, - 0x47bdddf0, 0x47bdddf0, 0x47bdddf0, 0x47bdddf0, 0x47be4989, 0x47be4989, 0x47be4989, 0x47be4989, - 0x47be4989, 0x47beb523, 0x47beb523, 0x47beb523, 0x47beb523, 0x47beb523, 0x47bf20bc, 0x47bf20bc, - 0x47bf20bc, 0x47bf20bc, 0x47bf20bc, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, 0x47bf8c56, - 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47bff7ef, 0x47c06389, 0x47c06389, 0x47c06389, - 0x47c06389, 0x47c06389, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c0cf22, 0x47c13abc, - 0x47c13abc, 0x47c13abc, 0x47c13abc, 0x47c13abc, 0x47c1a655, 0x47c1a655, 0x47c1a655, 0x47c1a655, - 0x47c1a655, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c211ee, 0x47c27d88, 0x47c27d88, - 0x47c27d88, 0x47c27d88, 0x47c27d88, 0x47c2e921, 0x47c2e921, 0x47c2e921, 0x47c2e921, 0x47c2e921, - 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c354bb, 0x47c3c054, 0x47c3c054, 0x47c3c054, - 0x47c3c054, 0x47c3c054, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c42bee, 0x47c49787, - 0x47c49787, 0x47c49787, 0x47c49787, 0x47c49787, 0x47c50321, 0x47c50321, 0x47c50321, 0x47c50321, - 0x47c50321, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c56eba, 0x47c5da54, 0x47c5da54, - 0x47c5da54, 0x47c5da54, 0x47c5da54, 0x47c645ed, 0x47c645ed, 0x47c645ed, 0x47c645ed, 0x47c645ed, - 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c6b187, 0x47c71d20, 0x47c71d20, 0x47c71d20, - 0x47c71d20, 0x47c71d20, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c788ba, 0x47c7f453, - 0x47c7f453, 0x47c7f453, 0x47c7f453, 0x47c7f453, 0x47c85fed, 0x47c85fed, 0x47c85fed, 0x47c85fed, - 0x47c85fed, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c8cb86, 0x47c93720, 0x47c93720, - 0x47c93720, 0x47c93720, 0x47c93720, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, 0x47c9a2b9, - 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca0e53, 0x47ca79ec, 0x47ca79ec, 0x47ca79ec, - 0x47ca79ec, 0x47ca79ec, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cae586, 0x47cb511f, - 0x47cb511f, 0x47cb511f, 0x47cb511f, 0x47cb511f, 0x47cbbcb9, 0x47cbbcb9, 0x47cbbcb9, 0x47cbbcb9, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xba0a6ada, 0xba0a6ada, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0x3a4a5e9b, - 0x3a4a5e9b, 0x3a4a5e9b, 0x3a4a5e9b, 0x3a4a5e9b, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0xba85292e, 0xba85292e, 0xba85292e, 0xba85292e, 0xba85292e, 0xbf7fffc0, 0xbf7fffc0, - 0xbf7fffc0, 0xbf7fffc0, 0xbf7fffc0, 0x3aa5230d, 0x3aa5230d, 0x3aa5230d, 0x3aa5230d, 0x3aa5230d, - 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0x3f7fffcb, 0xbac51cec, 0xbac51cec, 0xbac51cec, - 0xbac51cec, 0xbac51cec, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0x3ae516ca, - 0x3ae516ca, 0x3ae516ca, 0x3ae516ca, 0x3ae516ca, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, - 0x3f7fffdd, 0xbb028854, 0xbb028854, 0xbb028854, 0xbb028854, 0xbb028854, 0xbf7fffe5, 0xbf7fffe5, - 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b128542, 0x3b128542, 0x3b128542, 0x3b128542, 0x3b128542, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb228230, 0xbb228230, 0xbb228230, - 0xbb228230, 0xbb228230, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0x3b327f1c, - 0x3b327f1c, 0x3b327f1c, 0x3b327f1c, 0x3b327f1c, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, 0x3f7ffff7, - 0x3f7ffff7, 0xbb427c09, 0xbb427c09, 0xbb427c09, 0xbb427c09, 0xbb427c09, 0xbf7ffffa, 0xbf7ffffa, - 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b5278f4, 0x3b5278f4, 0x3b5278f4, 0x3b5278f4, 0x3b5278f4, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb6275df, 0xbb6275df, 0xbb6275df, - 0xbb6275df, 0xbb6275df, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b7272c9, - 0x3b7272c9, 0x3b7272c9, 0x3b7272c9, 0x3b7272c9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3b7d8ff9, 0x3b7d8ff9, 0x3b7d8ff9, 0x3b7d8ff9, 0x3b7d8ff9, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6d9310, 0xbb6d9310, 0xbb6d9310, 0xbb6d9310, 0xbb6d9310, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5d9626, 0x3b5d9626, 0x3b5d9626, - 0x3b5d9626, 0x3b5d9626, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbf7ffffc, 0xbb4d993b, - 0xbb4d993b, 0xbb4d993b, 0xbb4d993b, 0xbb4d993b, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3b3d9c4f, 0x3b3d9c4f, 0x3b3d9c4f, 0x3b3d9c4f, 0x3b3d9c4f, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2d9f63, 0xbb2d9f63, 0xbb2d9f63, 0xbb2d9f63, 0xbb2d9f63, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1da276, 0x3b1da276, 0x3b1da276, - 0x3b1da276, 0x3b1da276, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0da588, - 0xbb0da588, 0xbb0da588, 0xbb0da588, 0xbb0da588, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, - 0x3f7fffe3, 0x3afb5134, 0x3afb5134, 0x3afb5134, 0x3afb5134, 0x3afb5134, 0xbf7fffdb, 0xbf7fffdb, - 0xbf7fffdb, 0xbf7fffdb, 0xbf7fffdb, 0xbadb5756, 0xbadb5756, 0xbadb5756, 0xbadb5756, 0xbadb5756, - 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3f7fffd1, 0x3abb5d78, 0x3abb5d78, 0x3abb5d78, - 0x3abb5d78, 0x3abb5d78, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xbf7fffc7, 0xba9b6398, - 0xba9b6398, 0xba9b6398, 0xba9b6398, 0xba9b6398, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, -] )) ), - -################ chunk 14848 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47cbbcb9, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc2852, 0x47cc93ec, 0x47cc93ec, - 0x47cc93ec, 0x47cc93ec, 0x47cc93ec, 0x47ccff85, 0x47ccff85, 0x47ccff85, 0x47ccff85, 0x47ccff85, - 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cd6b1f, 0x47cdd6b8, 0x47cdd6b8, 0x47cdd6b8, - 0x47cdd6b8, 0x47cdd6b8, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ce4252, 0x47ceadeb, - 0x47ceadeb, 0x47ceadeb, 0x47ceadeb, 0x47ceadeb, 0x47cf1985, 0x47cf1985, 0x47cf1985, 0x47cf1985, - 0x47cf1985, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cf851e, 0x47cff0b7, 0x47cff0b7, - 0x47cff0b7, 0x47cff0b7, 0x47cff0b7, 0x47d05c51, 0x47d05c51, 0x47d05c51, 0x47d05c51, 0x47d05c51, - 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d0c7ea, 0x47d13384, 0x47d13384, 0x47d13384, - 0x47d13384, 0x47d13384, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d19f1d, 0x47d20ab7, - 0x47d20ab7, 0x47d20ab7, 0x47d20ab7, 0x47d20ab7, 0x47d27650, 0x47d27650, 0x47d27650, 0x47d27650, - 0x47d27650, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d2e1ea, 0x47d34d83, 0x47d34d83, - 0x47d34d83, 0x47d34d83, 0x47d34d83, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, 0x47d3b91d, - 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d424b6, 0x47d49050, 0x47d49050, 0x47d49050, - 0x47d49050, 0x47d49050, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d4fbe9, 0x47d56783, - 0x47d56783, 0x47d56783, 0x47d56783, 0x47d56783, 0x47d5d31c, 0x47d5d31c, 0x47d5d31c, 0x47d5d31c, - 0x47d5d31c, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d63eb6, 0x47d6aa4f, 0x47d6aa4f, - 0x47d6aa4f, 0x47d6aa4f, 0x47d6aa4f, 0x47d715e9, 0x47d715e9, 0x47d715e9, 0x47d715e9, 0x47d715e9, - 0x47d78182, 0x47d78182, 0x47d78182, 0x47d78182, 0x47d78182, 0x47d7ed1c, 0x47d7ed1c, 0x47d7ed1c, - 0x47d7ed1c, 0x47d7ed1c, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d858b5, 0x47d8c44f, - 0x47d8c44f, 0x47d8c44f, 0x47d8c44f, 0x47d8c44f, 0x47d92fe8, 0x47d92fe8, 0x47d92fe8, 0x47d92fe8, - 0x47d92fe8, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47d99b82, 0x47da071b, 0x47da071b, - 0x47da071b, 0x47da071b, 0x47da071b, 0x47da72b5, 0x47da72b5, 0x47da72b5, 0x47da72b5, 0x47da72b5, - 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47dade4e, 0x47db49e8, 0x47db49e8, 0x47db49e8, - 0x47db49e8, 0x47db49e8, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dbb581, 0x47dc211b, - 0x47dc211b, 0x47dc211b, 0x47dc211b, 0x47dc211b, 0x47dc8cb4, 0x47dc8cb4, 0x47dc8cb4, 0x47dc8cb4, - 0x47dc8cb4, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dcf84d, 0x47dd63e7, 0x47dd63e7, - 0x47dd63e7, 0x47dd63e7, 0x47dd63e7, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, 0x47ddcf80, - 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47de3b1a, 0x47dea6b3, 0x47dea6b3, 0x47dea6b3, - 0x47dea6b3, 0x47dea6b3, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df124d, 0x47df7de6, - 0x47df7de6, 0x47df7de6, 0x47df7de6, 0x47df7de6, 0x47dfe980, 0x47dfe980, 0x47dfe980, 0x47dfe980, - 0x47dfe980, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e05519, 0x47e0c0b3, 0x47e0c0b3, - 0x47e0c0b3, 0x47e0c0b3, 0x47e0c0b3, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, 0x47e12c4c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fffbc, 0x3a76d371, 0x3a76d371, 0x3a76d371, 0x3a76d371, 0x3a76d371, 0xbf7fffb0, 0xbf7fffb0, - 0xbf7fffb0, 0xbf7fffb0, 0xbf7fffb0, 0xba36dfb1, 0xba36dfb1, 0xba36dfb1, 0xba36dfb1, 0xba36dfb1, - 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x39edd7df, 0x39edd7df, 0x39edd7df, - 0x39edd7df, 0x39edd7df, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xb95be0b7, - 0xb95be0b7, 0xb95be0b7, 0xb95be0b7, 0xb95be0b7, 0x3f7fff86, 0x3f7fff86, 0x3f7fff86, 0x3f7fff86, - 0x3f7fff86, 0xb80fb944, 0xb80fb944, 0xb80fb944, 0xb80fb944, 0xb80fb944, 0xbf7fff8a, 0xbf7fff8a, - 0xbf7fff8a, 0xbf7fff8a, 0xbf7fff8a, 0x3991deac, 0x3991deac, 0x3991deac, 0x3991deac, 0x3991deac, - 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0xba08e318, 0xba08e318, 0xba08e318, - 0xba08e318, 0xba08e318, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0xbf7fffa7, 0x3a48d6d9, - 0x3a48d6d9, 0x3a48d6d9, 0x3a48d6d9, 0x3a48d6d9, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, 0x3f7fffb4, - 0x3f7fffb4, 0xba84654d, 0xba84654d, 0xba84654d, 0xba84654d, 0xba84654d, 0xbf7fffbf, 0xbf7fffbf, - 0xbf7fffbf, 0xbf7fffbf, 0xbf7fffbf, 0x3aa45f2c, 0x3aa45f2c, 0x3aa45f2c, 0x3aa45f2c, 0x3aa45f2c, - 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0xbac4590b, 0xbac4590b, 0xbac4590b, - 0xbac4590b, 0xbac4590b, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0x3ae452e9, - 0x3ae452e9, 0x3ae452e9, 0x3ae452e9, 0x3ae452e9, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, - 0x3f7fffdd, 0xbb022663, 0xbb022663, 0xbb022663, 0xbb022663, 0xbb022663, 0xbf7fffe5, 0xbf7fffe5, - 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b122351, 0x3b122351, 0x3b122351, 0x3b122351, 0x3b122351, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb22203f, 0xbb22203f, 0xbb22203f, - 0xbb22203f, 0xbb22203f, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0xbf7ffff2, 0x3b321d2c, - 0x3b321d2c, 0x3b321d2c, 0x3b321d2c, 0x3b321d2c, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0xbb421a18, 0xbb421a18, 0xbb421a18, 0xbb421a18, 0xbb421a18, 0xbf7ffffa, 0xbf7ffffa, - 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b521704, 0x3b521704, 0x3b521704, 0x3b521704, 0x3b521704, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb6213ee, 0xbb6213ee, 0xbb6213ee, - 0xbb6213ee, 0xbb6213ee, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b7210d8, - 0x3b7210d8, 0x3b7210d8, 0x3b7210d8, 0x3b7210d8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3b7df1ea, 0x3b7df1ea, 0x3b7df1ea, 0x3b7df1ea, 0x3b7df1ea, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6df500, 0xbb6df500, 0xbb6df500, 0xbb6df500, 0xbb6df500, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5df816, 0x3b5df816, 0x3b5df816, - 0x3b5df816, 0x3b5df816, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbb4dfb2c, - 0xbb4dfb2c, 0xbb4dfb2c, 0xbb4dfb2c, 0xbb4dfb2c, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3b3dfe40, 0x3b3dfe40, 0x3b3dfe40, 0x3b3dfe40, 0x3b3dfe40, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2e0153, 0xbb2e0153, 0xbb2e0153, 0xbb2e0153, 0xbb2e0153, -] )) ), - -################ chunk 15360 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e197e6, 0x47e2037f, 0x47e2037f, 0x47e2037f, - 0x47e2037f, 0x47e2037f, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e26f19, 0x47e2dab2, - 0x47e2dab2, 0x47e2dab2, 0x47e2dab2, 0x47e2dab2, 0x47e3464c, 0x47e3464c, 0x47e3464c, 0x47e3464c, - 0x47e3464c, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e3b1e5, 0x47e41d7f, 0x47e41d7f, - 0x47e41d7f, 0x47e41d7f, 0x47e41d7f, 0x47e48918, 0x47e48918, 0x47e48918, 0x47e48918, 0x47e48918, - 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e4f4b2, 0x47e5604b, 0x47e5604b, 0x47e5604b, - 0x47e5604b, 0x47e5604b, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e5cbe5, 0x47e6377e, - 0x47e6377e, 0x47e6377e, 0x47e6377e, 0x47e6377e, 0x47e6a318, 0x47e6a318, 0x47e6a318, 0x47e6a318, - 0x47e6a318, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e70eb1, 0x47e77a4b, 0x47e77a4b, - 0x47e77a4b, 0x47e77a4b, 0x47e77a4b, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, 0x47e7e5e4, - 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8517e, 0x47e8bd17, 0x47e8bd17, 0x47e8bd17, - 0x47e8bd17, 0x47e8bd17, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e928b1, 0x47e9944a, - 0x47e9944a, 0x47e9944a, 0x47e9944a, 0x47e9944a, 0x47e9ffe4, 0x47e9ffe4, 0x47e9ffe4, 0x47e9ffe4, - 0x47e9ffe4, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ea6b7d, 0x47ead716, 0x47ead716, - 0x47ead716, 0x47ead716, 0x47ead716, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, 0x47eb42b0, - 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ebae49, 0x47ec19e3, 0x47ec19e3, 0x47ec19e3, - 0x47ec19e3, 0x47ec19e3, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ec857c, 0x47ecf116, - 0x47ecf116, 0x47ecf116, 0x47ecf116, 0x47ecf116, 0x47ed5caf, 0x47ed5caf, 0x47ed5caf, 0x47ed5caf, - 0x47ed5caf, 0x47edc849, 0x47edc849, 0x47edc849, 0x47edc849, 0x47edc849, 0x47ee33e2, 0x47ee33e2, - 0x47ee33e2, 0x47ee33e2, 0x47ee33e2, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, 0x47ee9f7c, - 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef0b15, 0x47ef76af, 0x47ef76af, 0x47ef76af, - 0x47ef76af, 0x47ef76af, 0x47efe248, 0x47efe248, 0x47efe248, 0x47efe248, 0x47efe248, 0x47f04de2, - 0x47f04de2, 0x47f04de2, 0x47f04de2, 0x47f04de2, 0x47f0b97b, 0x47f0b97b, 0x47f0b97b, 0x47f0b97b, - 0x47f0b97b, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f12515, 0x47f190ae, 0x47f190ae, - 0x47f190ae, 0x47f190ae, 0x47f190ae, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, 0x47f1fc48, - 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f267e1, 0x47f2d37b, 0x47f2d37b, 0x47f2d37b, - 0x47f2d37b, 0x47f2d37b, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f33f14, 0x47f3aaae, - 0x47f3aaae, 0x47f3aaae, 0x47f3aaae, 0x47f3aaae, 0x47f41647, 0x47f41647, 0x47f41647, 0x47f41647, - 0x47f41647, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f481e1, 0x47f4ed7a, 0x47f4ed7a, - 0x47f4ed7a, 0x47f4ed7a, 0x47f4ed7a, 0x47f55914, 0x47f55914, 0x47f55914, 0x47f55914, 0x47f55914, - 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f5c4ad, 0x47f63047, 0x47f63047, 0x47f63047, - 0x47f63047, 0x47f63047, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f69be0, 0x47f7077a, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1e0466, 0x3b1e0466, 0x3b1e0466, - 0x3b1e0466, 0x3b1e0466, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0e0779, - 0xbb0e0779, 0xbb0e0779, 0xbb0e0779, 0xbb0e0779, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, - 0x3f7fffe3, 0x3afc1514, 0x3afc1514, 0x3afc1514, 0x3afc1514, 0x3afc1514, 0xbf7fffdb, 0xbf7fffdb, - 0xbf7fffdb, 0xbf7fffdb, 0xbf7fffdb, 0xbadc1b37, 0xbadc1b37, 0xbadc1b37, 0xbadc1b37, 0xbadc1b37, - 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3abc2159, 0x3abc2159, 0x3abc2159, - 0x3abc2159, 0x3abc2159, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xba9c2779, - 0xba9c2779, 0xba9c2779, 0xba9c2779, 0xba9c2779, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, 0x3f7fffbc, - 0x3f7fffbc, 0x3a785b33, 0x3a785b33, 0x3a785b33, 0x3a785b33, 0x3a785b33, 0xbf7fffb0, 0xbf7fffb0, - 0xbf7fffb0, 0xbf7fffb0, 0xbf7fffb0, 0xba386773, 0xba386773, 0xba386773, 0xba386773, 0xba386773, - 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x3f7fffa3, 0x39f0e763, 0x39f0e763, 0x39f0e763, - 0x39f0e763, 0x39f0e763, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xbf7fff95, 0xb961ffbf, - 0xb961ffbf, 0xb961ffbf, 0xb961ffbf, 0xb961ffbf, 0x3f7fff86, 0x3f7fff86, 0x3f7fff86, 0x3f7fff86, - 0x3f7fff86, 0xb7ee7a43, 0xb7ee7a43, 0xb7ee7a43, 0xb7ee7a43, 0xb7ee7a43, 0xbf7fff8a, 0xbf7fff8a, - 0xbf7fff8a, 0xbf7fff8a, 0xbf7fff8a, 0x398ecf28, 0x398ecf28, 0x398ecf28, 0x398ecf28, 0x398ecf28, - 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0x3f7fff99, 0xba075b56, 0xba075b56, 0xba075b56, - 0xba075b56, 0xba075b56, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0x3a474f17, - 0x3a474f17, 0x3a474f17, 0x3a474f17, 0x3a474f17, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, - 0x3f7fffb3, 0xba83a16b, 0xba83a16b, 0xba83a16b, 0xba83a16b, 0xba83a16b, 0xbf7fffbf, 0xbf7fffbf, - 0xbf7fffbf, 0xbf7fffbf, 0xbf7fffbf, 0x3aa39b4b, 0x3aa39b4b, 0x3aa39b4b, 0x3aa39b4b, 0x3aa39b4b, - 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0xbac3952a, 0xbac3952a, 0xbac3952a, - 0xbac3952a, 0xbac3952a, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0xbf7fffd4, 0x3ae38f08, - 0x3ae38f08, 0x3ae38f08, 0x3ae38f08, 0x3ae38f08, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, - 0x3f7fffdd, 0xbb01c473, 0xbb01c473, 0xbb01c473, 0xbb01c473, 0xbb01c473, 0xbf7fffe5, 0xbf7fffe5, - 0xbf7fffe5, 0xbf7fffe5, 0xbf7fffe5, 0x3b11c161, 0x3b11c161, 0x3b11c161, 0x3b11c161, 0x3b11c161, - 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0x3f7fffec, 0xbb21be4f, 0xbb21be4f, 0xbb21be4f, - 0xbb21be4f, 0xbb21be4f, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0x3b31bb3c, - 0x3b31bb3c, 0x3b31bb3c, 0x3b31bb3c, 0x3b31bb3c, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0xbb41b828, 0xbb41b828, 0xbb41b828, 0xbb41b828, 0xbb41b828, 0xbf7ffffa, 0xbf7ffffa, - 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b51b513, 0x3b51b513, 0x3b51b513, 0x3b51b513, 0x3b51b513, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb61b1fe, 0xbb61b1fe, 0xbb61b1fe, - 0xbb61b1fe, 0xbb61b1fe, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b71aee8, -] )) ), - -################ chunk 15872 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x47f7077a, 0x47f7077a, 0x47f7077a, 0x47f7077a, 0x47f77313, 0x47f77313, 0x47f77313, 0x47f77313, - 0x47f77313, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f7deac, 0x47f84a46, 0x47f84a46, - 0x47f84a46, 0x47f84a46, 0x47f84a46, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, 0x47f8b5df, - 0x47f92179, 0x47f92179, 0x47f92179, 0x47f92179, 0x47f92179, 0x47f98d12, 0x47f98d12, 0x47f98d12, - 0x47f98d12, 0x47f98d12, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47f9f8ac, 0x47fa6445, - 0x47fa6445, 0x47fa6445, 0x47fa6445, 0x47fa6445, 0x47facfdf, 0x47facfdf, 0x47facfdf, 0x47facfdf, - 0x47facfdf, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fb3b78, 0x47fba712, 0x47fba712, - 0x47fba712, 0x47fba712, 0x47fba712, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, 0x47fc12ab, - 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fc7e45, 0x47fce9de, 0x47fce9de, 0x47fce9de, - 0x47fce9de, 0x47fce9de, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fd5578, 0x47fdc111, - 0x47fdc111, 0x47fdc111, 0x47fdc111, 0x47fdc111, 0x47fe2cab, 0x47fe2cab, 0x47fe2cab, 0x47fe2cab, - 0x47fe2cab, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47fe9844, 0x47ff03de, 0x47ff03de, - 0x47ff03de, 0x47ff03de, 0x47ff03de, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, 0x47ff6f77, - 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x47ffdb11, 0x48002355, 0x48002355, 0x48002355, - 0x48002355, 0x48002355, 0x48005922, 0x48005922, 0x48005922, 0x48005922, 0x48005922, 0x48008eef, - 0x48008eef, 0x48008eef, 0x48008eef, 0x48008eef, 0x4800c4bb, 0x4800c4bb, 0x4800c4bb, 0x4800c4bb, - 0x4800c4bb, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x4800fa88, 0x48013055, 0x48013055, - 0x48013055, 0x48013055, 0x48013055, 0x48016622, 0x48016622, 0x48016622, 0x48016622, 0x48016622, - 0x48019bee, 0x48019bee, 0x48019bee, 0x48019bee, 0x48019bee, 0x4801d1bb, 0x4801d1bb, 0x4801d1bb, - 0x4801d1bb, 0x4801d1bb, 0x48020788, 0x48020788, 0x48020788, 0x48020788, 0x48020788, 0x48023d55, - 0x48023d55, 0x48023d55, 0x48023d55, 0x48023d55, 0x48027321, 0x48027321, 0x48027321, 0x48027321, - 0x48027321, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802a8ee, 0x4802debb, 0x4802debb, - 0x4802debb, 0x4802debb, 0x4802debb, 0x48031487, 0x48031487, 0x48031487, 0x48031487, 0x48031487, - 0x48034a54, 0x48034a54, 0x48034a54, 0x48034a54, 0x48034a54, 0x48038021, 0x48038021, 0x48038021, - 0x48038021, 0x48038021, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803b5ee, 0x4803ebba, - 0x4803ebba, 0x4803ebba, 0x4803ebba, 0x4803ebba, 0x48042187, 0x48042187, 0x48042187, 0x48042187, - 0x48042187, 0x48045754, 0x48045754, 0x48045754, 0x48045754, 0x48045754, 0x48048d21, 0x48048d21, - 0x48048d21, 0x48048d21, 0x48048d21, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, 0x4804c2ed, - 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x4804f8ba, 0x48052e87, 0x48052e87, 0x48052e87, - 0x48052e87, 0x48052e87, 0x48056454, 0x48056454, 0x48056454, 0x48056454, 0x48056454, 0x48059a20, - 0x48059a20, 0x48059a20, 0x48059a20, 0x48059a20, 0x4805cfed, 0x4805cfed, 0x4805cfed, 0x4805cfed, - 0x4805cfed, 0x480605ba, 0x480605ba, 0x480605ba, 0x480605ba, 0x480605ba, 0x48063b87, 0x48063b87, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3b71aee8, 0x3b71aee8, 0x3b71aee8, 0x3b71aee8, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3b7e53da, 0x3b7e53da, 0x3b7e53da, 0x3b7e53da, 0x3b7e53da, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0xbb6e56f1, 0xbb6e56f1, 0xbb6e56f1, 0xbb6e56f1, 0xbb6e56f1, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3b5e5a07, 0x3b5e5a07, 0x3b5e5a07, - 0x3b5e5a07, 0x3b5e5a07, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbb4e5d1c, - 0xbb4e5d1c, 0xbb4e5d1c, 0xbb4e5d1c, 0xbb4e5d1c, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0x3b3e6030, 0x3b3e6030, 0x3b3e6030, 0x3b3e6030, 0x3b3e6030, 0xbf7ffff5, 0xbf7ffff5, - 0xbf7ffff5, 0xbf7ffff5, 0xbf7ffff5, 0xbb2e6344, 0xbb2e6344, 0xbb2e6344, 0xbb2e6344, 0xbb2e6344, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3b1e6657, 0x3b1e6657, 0x3b1e6657, - 0x3b1e6657, 0x3b1e6657, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbf7fffea, 0xbb0e6969, - 0xbb0e6969, 0xbb0e6969, 0xbb0e6969, 0xbb0e6969, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, - 0x3f7fffe3, 0x3afcd8f5, 0x3afcd8f5, 0x3afcd8f5, 0x3afcd8f5, 0x3afcd8f5, 0xbf7fffdb, 0xbf7fffdb, - 0xbf7fffdb, 0xbf7fffdb, 0xbf7fffdb, 0xbadcdf18, 0xbadcdf18, 0xbadcdf18, 0xbadcdf18, 0xbadcdf18, - 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3abce53a, 0x3abce53a, 0x3abce53a, - 0x3abce53a, 0x3abce53a, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0xbf7fffc8, 0x3bd8c4c1, - 0x3bd8c4c1, 0x3bd8c4c1, 0x3bd8c4c1, 0x3bd8c4c1, 0x3f7fff30, 0x3f7fff30, 0x3f7fff30, 0x3f7fff30, - 0x3f7fff30, 0x3a79e2f5, 0x3a79e2f5, 0x3a79e2f5, 0x3a79e2f5, 0x3a79e2f5, 0xbf7fffb1, 0xbf7fffb1, - 0xbf7fffb1, 0xbf7fffb1, 0xbf7fffb1, 0x3be8c199, 0x3be8c199, 0x3be8c199, 0x3be8c199, 0x3be8c199, - 0x3f7fff57, 0x3f7fff57, 0x3f7fff57, 0x3f7fff57, 0x3f7fff57, 0x39f3f6e7, 0x39f3f6e7, 0x39f3f6e7, - 0x39f3f6e7, 0x39f3f6e7, 0xbf7fff96, 0xbf7fff96, 0xbf7fff96, 0xbf7fff96, 0xbf7fff96, 0x3bf8be6d, - 0x3bf8be6d, 0x3bf8be6d, 0x3bf8be6d, 0x3bf8be6d, 0x3f7fff79, 0x3f7fff79, 0x3f7fff79, 0x3f7fff79, - 0x3f7fff79, 0xb7bd81ff, 0xb7bd81ff, 0xb7bd81ff, 0xb7bd81ff, 0xb7bd81ff, 0xbf7fff76, 0xbf7fff76, - 0xbf7fff76, 0xbf7fff76, 0xbf7fff76, 0xbbf7436c, 0xbbf7436c, 0xbbf7436c, 0xbbf7436c, 0xbbf7436c, - 0x3f7fff98, 0x3f7fff98, 0x3f7fff98, 0x3f7fff98, 0x3f7fff98, 0xba05d393, 0xba05d393, 0xba05d393, - 0xba05d393, 0xba05d393, 0xbf7fff53, 0xbf7fff53, 0xbf7fff53, 0xbf7fff53, 0xbf7fff53, 0xbbe74697, - 0xbbe74697, 0xbbe74697, 0xbbe74697, 0xbbe74697, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, 0x3f7fffb3, - 0x3f7fffb3, 0xba82dd8a, 0xba82dd8a, 0xba82dd8a, 0xba82dd8a, 0xba82dd8a, 0xbf7fff2c, 0xbf7fff2c, - 0xbf7fff2c, 0xbf7fff2c, 0xbf7fff2c, 0xbbd749bf, 0xbbd749bf, 0xbbd749bf, 0xbbd749bf, 0xbbd749bf, - 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0x3f7fffca, 0xbac2d149, 0xbac2d149, 0xbac2d149, - 0xbac2d149, 0xbac2d149, 0xbf7fff01, 0xbf7fff01, 0xbf7fff01, 0xbf7fff01, 0xbf7fff01, 0xbbc74ce4, - 0xbbc74ce4, 0xbbc74ce4, 0xbbc74ce4, 0xbbc74ce4, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, 0x3f7fffdd, - 0x3f7fffdd, 0xbb016282, 0xbb016282, 0xbb016282, 0xbb016282, 0xbb016282, 0xbf7ffed2, 0xbf7ffed2, -] )) ), - -################ chunk 16384 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x48063b87, 0x48063b87, 0x48063b87, 0x48067153, 0x48067153, 0x48067153, 0x48067153, 0x48067153, - 0x4806a720, 0x4806a720, 0x4806a720, 0x4806a720, 0x4806a720, 0x4806dced, 0x4806dced, 0x4806dced, - 0x4806dced, 0x4806dced, 0x480712ba, 0x480712ba, 0x480712ba, 0x480712ba, 0x480712ba, 0x48074886, - 0x48074886, 0x48074886, 0x48074886, 0x48074886, 0x48077e53, 0x48077e53, 0x48077e53, 0x48077e53, - 0x48077e53, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807b420, 0x4807e9ed, 0x4807e9ed, - 0x4807e9ed, 0x4807e9ed, 0x4807e9ed, 0x48081fb9, 0x48081fb9, 0x48081fb9, 0x48081fb9, 0x48081fb9, - 0x48085586, 0x48085586, 0x48085586, 0x48085586, 0x48085586, 0x48088b53, 0x48088b53, 0x48088b53, - 0x48088b53, 0x48088b53, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808c120, 0x4808f6ec, - 0x4808f6ec, 0x4808f6ec, 0x4808f6ec, 0x4808f6ec, 0x48092cb9, 0x48092cb9, 0x48092cb9, 0x48092cb9, - 0x48092cb9, 0x48096286, 0x48096286, 0x48096286, 0x48096286, 0x48096286, 0x48099852, 0x48099852, - 0x48099852, 0x48099852, 0x48099852, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, 0x4809ce1f, - 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a03ec, 0x480a39b9, 0x480a39b9, 0x480a39b9, - 0x480a39b9, 0x480a39b9, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480a6f85, 0x480aa552, - 0x480aa552, 0x480aa552, 0x480aa552, 0x480aa552, 0x480adb1f, 0x480adb1f, 0x480adb1f, 0x480adb1f, - 0x480adb1f, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b10ec, 0x480b46b8, 0x480b46b8, - 0x480b46b8, 0x480b46b8, 0x480b46b8, 0x480b7c85, 0x480b7c85, 0x480b7c85, 0x480b7c85, 0x480b7c85, - 0x480bb252, 0x480bb252, 0x480bb252, 0x480bb252, 0x480bb252, 0x480be81f, 0x480be81f, 0x480be81f, - 0x480be81f, 0x480be81f, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c1deb, 0x480c53b8, - 0x480c53b8, 0x480c53b8, 0x480c53b8, 0x480c53b8, 0x480c8985, 0x480c8985, 0x480c8985, 0x480c8985, - 0x480c8985, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cbf52, 0x480cf51e, 0x480cf51e, - 0x480cf51e, 0x480cf51e, 0x480cf51e, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, 0x480d2aeb, - 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d60b8, 0x480d9685, 0x480d9685, 0x480d9685, - 0x480d9685, 0x480d9685, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480dcc51, 0x480e021e, - 0x480e021e, 0x480e021e, 0x480e021e, 0x480e021e, 0x480e37eb, 0x480e37eb, 0x480e37eb, 0x480e37eb, - 0x480e37eb, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480e6db8, 0x480ea384, 0x480ea384, - 0x480ea384, 0x480ea384, 0x480ea384, 0x480ed951, 0x480ed951, 0x480ed951, 0x480ed951, 0x480ed951, - 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f0f1e, 0x480f44eb, 0x480f44eb, 0x480f44eb, - 0x480f44eb, 0x480f44eb, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480f7ab7, 0x480fb084, - 0x480fb084, 0x480fb084, 0x480fb084, 0x480fb084, 0x480fe651, 0x480fe651, 0x480fe651, 0x480fe651, - 0x480fe651, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x48101c1d, 0x481051ea, 0x481051ea, - 0x481051ea, 0x481051ea, 0x481051ea, 0x481087b7, 0x481087b7, 0x481087b7, 0x481087b7, 0x481087b7, - 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810bd84, 0x4810f350, 0x4810f350, 0x4810f350, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0xbf7ffed2, 0xbf7ffed2, 0xbf7ffed2, 0xbbb75005, 0xbbb75005, 0xbbb75005, 0xbbb75005, 0xbbb75005, - 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0x3f7fffeb, 0xbb215c5e, 0xbb215c5e, 0xbb215c5e, - 0xbb215c5e, 0xbb215c5e, 0xbf7ffe9f, 0xbf7ffe9f, 0xbf7ffe9f, 0xbf7ffe9f, 0xbf7ffe9f, 0xbba75324, - 0xbba75324, 0xbba75324, 0xbba75324, 0xbba75324, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, 0x3f7ffff6, - 0x3f7ffff6, 0xbb415637, 0xbb415637, 0xbb415637, 0xbb415637, 0xbb415637, 0xbf7ffe68, 0xbf7ffe68, - 0xbf7ffe68, 0xbf7ffe68, 0xbf7ffe68, 0xbb975640, 0xbb975640, 0xbb975640, 0xbb975640, 0xbb975640, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0xbb61500e, 0xbb61500e, 0xbb61500e, - 0xbb61500e, 0xbb61500e, 0xbf7ffe2c, 0xbf7ffe2c, 0xbf7ffe2c, 0xbf7ffe2c, 0xbf7ffe2c, 0xbb875959, - 0xbb875959, 0xbb875959, 0xbb875959, 0xbb875959, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0xbb80a4f0, 0xbb80a4f0, 0xbb80a4f0, 0xbb80a4f0, 0xbb80a4f0, 0xbf7ffe12, 0xbf7ffe12, - 0xbf7ffe12, 0xbf7ffe12, 0xbf7ffe12, 0xbb6eb8e1, 0xbb6eb8e1, 0xbb6eb8e1, 0xbb6eb8e1, 0xbb6eb8e1, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0xbb90a1d8, 0xbb90a1d8, 0xbb90a1d8, - 0xbb90a1d8, 0xbb90a1d8, 0xbf7ffe4f, 0xbf7ffe4f, 0xbf7ffe4f, 0xbf7ffe4f, 0xbf7ffe4f, 0xbb4ebf0c, - 0xbb4ebf0c, 0xbb4ebf0c, 0xbb4ebf0c, 0xbb4ebf0c, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f7ffffa, 0xbba09ebd, 0xbba09ebd, 0xbba09ebd, 0xbba09ebd, 0xbba09ebd, 0xbf7ffe88, 0xbf7ffe88, - 0xbf7ffe88, 0xbf7ffe88, 0xbf7ffe88, 0xbb2ec534, 0xbb2ec534, 0xbb2ec534, 0xbb2ec534, 0xbb2ec534, - 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0x3f7ffff0, 0xbbb09b9f, 0xbbb09b9f, 0xbbb09b9f, - 0xbbb09b9f, 0xbbb09b9f, 0xbf7ffebd, 0xbf7ffebd, 0xbf7ffebd, 0xbf7ffebd, 0xbf7ffebd, 0xbb0ecb59, - 0xbb0ecb59, 0xbb0ecb59, 0xbb0ecb59, 0xbb0ecb59, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, 0x3f7fffe3, - 0x3f7fffe3, 0xbbc0987f, 0xbbc0987f, 0xbbc0987f, 0xbbc0987f, 0xbbc0987f, 0xbf7ffeee, 0xbf7ffeee, - 0xbf7ffeee, 0xbf7ffeee, 0xbf7ffeee, 0xbadda2f9, 0xbadda2f9, 0xbadda2f9, 0xbadda2f9, 0xbadda2f9, - 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0x3f7fffd2, 0xbbd0955c, 0xbbd0955c, 0xbbd0955c, - 0xbbd0955c, 0xbbd0955c, 0xbf7fff1a, 0xbf7fff1a, 0xbf7fff1a, 0xbf7fff1a, 0xbf7fff1a, 0xba9daf3b, - 0xba9daf3b, 0xba9daf3b, 0xba9daf3b, 0xba9daf3b, 0x3f7fffbd, 0x3f7fffbd, 0x3f7fffbd, 0x3f7fffbd, - 0x3f7fffbd, 0xbbe09236, 0xbbe09236, 0xbbe09236, 0xbbe09236, 0xbbe09236, 0xbf7fff43, 0xbf7fff43, - 0xbf7fff43, 0xbf7fff43, 0xbf7fff43, 0xba3b76f7, 0xba3b76f7, 0xba3b76f7, 0xba3b76f7, 0xba3b76f7, - 0x3f7fffa4, 0x3f7fffa4, 0x3f7fffa4, 0x3f7fffa4, 0x3f7fffa4, 0xbbf08f0c, 0xbbf08f0c, 0xbbf08f0c, - 0xbbf08f0c, 0xbbf08f0c, 0xbf7fff68, 0xbf7fff68, 0xbf7fff68, 0xbf7fff68, 0xbf7fff68, 0xb96e3dd0, - 0xb96e3dd0, 0xb96e3dd0, 0xb96e3dd0, 0xb96e3dd0, 0x3f7fff87, 0x3f7fff87, 0x3f7fff87, 0x3f7fff87, - 0x3f7fff87, 0x3bff72cd, 0x3bff72cd, 0x3bff72cd, 0x3bff72cd, 0x3bff72cd, 0xbf7fff89, 0xbf7fff89, - 0xbf7fff89, 0xbf7fff89, 0xbf7fff89, 0x3988b01f, 0x3988b01f, 0x3988b01f, 0x3988b01f, 0x3988b01f, - 0x3f7fff66, 0x3f7fff66, 0x3f7fff66, 0x3f7fff66, 0x3f7fff66, 0x3bef75fa, 0x3bef75fa, 0x3bef75fa, -] )) ), - -################ chunk 16896 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4810f350, 0x4810f350, 0x4811291d, 0x4811291d, 0x4811291d, 0x4811291d, 0x4811291d, 0x48115eea, - 0x48115eea, 0x48115eea, 0x48115eea, 0x48115eea, 0x481194b7, 0x481194b7, 0x481194b7, 0x481194b7, - 0x481194b7, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x4811ca83, 0x48120050, 0x48120050, - 0x48120050, 0x48120050, 0x48120050, 0x4812361d, 0x4812361d, 0x4812361d, 0x4812361d, 0x4812361d, - 0x48126bea, 0x48126bea, 0x48126bea, 0x48126bea, 0x48126bea, 0x4812a1b6, 0x4812a1b6, 0x4812a1b6, - 0x4812a1b6, 0x4812a1b6, 0x4812d783, 0x4812d783, 0x4812d783, 0x4812d783, 0x4812d783, 0x48130d50, - 0x48130d50, 0x48130d50, 0x48130d50, 0x48130d50, 0x4813431d, 0x4813431d, 0x4813431d, 0x4813431d, - 0x4813431d, 0x481378e9, 0x481378e9, 0x481378e9, 0x481378e9, 0x481378e9, 0x4813aeb6, 0x4813aeb6, - 0x4813aeb6, 0x4813aeb6, 0x4813aeb6, 0x4813e483, 0x4813e483, 0x4813e483, 0x4813e483, 0x4813e483, - 0x48141a50, 0x48141a50, 0x48141a50, 0x48141a50, 0x48141a50, 0x4814501c, 0x4814501c, 0x4814501c, - 0x4814501c, 0x4814501c, 0x481485e9, 0x481485e9, 0x481485e9, 0x481485e9, 0x481485e9, 0x4814bbb6, - 0x4814bbb6, 0x4814bbb6, 0x4814bbb6, 0x4814bbb6, 0x4814f183, 0x4814f183, 0x4814f183, 0x4814f183, - 0x4814f183, 0x4815274f, 0x4815274f, 0x4815274f, 0x4815274f, 0x4815274f, 0x48155d1c, 0x48155d1c, - 0x48155d1c, 0x48155d1c, 0x48155d1c, 0x481592e9, 0x481592e9, 0x481592e9, 0x481592e9, 0x481592e9, - 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815c8b6, 0x4815fe82, 0x4815fe82, 0x4815fe82, - 0x4815fe82, 0x4815fe82, 0x4816344f, 0x4816344f, 0x4816344f, 0x4816344f, 0x4816344f, 0x48166a1c, - 0x48166a1c, 0x48166a1c, 0x48166a1c, 0x48166a1c, 0x48169fe9, 0x48169fe9, 0x48169fe9, 0x48169fe9, - 0x48169fe9, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x4816d5b5, 0x48170b82, 0x48170b82, - 0x48170b82, 0x48170b82, 0x48170b82, 0x4817414f, 0x4817414f, 0x4817414f, 0x4817414f, 0x4817414f, - 0x4817771b, 0x4817771b, 0x4817771b, 0x4817771b, 0x4817771b, 0x4817ace8, 0x4817ace8, 0x4817ace8, - 0x4817ace8, 0x4817ace8, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x4817e2b5, 0x48181882, - 0x48181882, 0x48181882, 0x48181882, 0x48181882, 0x48184e4e, 0x48184e4e, 0x48184e4e, 0x48184e4e, - 0x48184e4e, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818841b, 0x4818b9e8, 0x4818b9e8, - 0x4818b9e8, 0x4818b9e8, 0x4818b9e8, 0x4818efb5, 0x4818efb5, 0x4818efb5, 0x4818efb5, 0x4818efb5, - 0x48192581, 0x48192581, 0x48192581, 0x48192581, 0x48192581, 0x48195b4e, 0x48195b4e, 0x48195b4e, - 0x48195b4e, 0x48195b4e, 0x44800000, 0x44802000, 0x447fc000, 0x44801000, 0x447fe000, 0x45000000, - 0x45001000, 0x44ffe000, 0x45000800, 0x44fff000, 0x45800000, 0x45800800, 0x457ff000, 0x45800400, - 0x457ff800, 0x46000000, 0x46000400, 0x45fff800, 0x46000200, 0x45fffc00, 0x46800000, 0x46800200, - 0x467ffc00, 0x46800100, 0x467ffe00, 0x47000000, 0x47000100, 0x46fffe00, 0x47000080, 0x46ffff00, - 0x47800000, 0x47800080, 0x477fff00, 0x47800040, 0x477fff80, 0x48000000, 0x48000040, 0x47ffff80, - 0x48000020, 0x47ffffc0, 0x48800000, 0x48800020, 0x487fffc0, 0x48800010, 0x487fffe0, 0x49000000, - 0x49000010, 0x48ffffe0, 0x49000008, 0x48fffff0, 0x49800000, 0x49800008, 0x497ffff0, 0x49800004, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3bef75fa, 0x3bef75fa, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0xbf7fffa6, 0x3a443f92, - 0x3a443f92, 0x3a443f92, 0x3a443f92, 0x3a443f92, 0x3f7fff41, 0x3f7fff41, 0x3f7fff41, 0x3f7fff41, - 0x3f7fff41, 0x3bdf7924, 0x3bdf7924, 0x3bdf7924, 0x3bdf7924, 0x3bdf7924, 0xbf7fffbf, 0xbf7fffbf, - 0xbf7fffbf, 0xbf7fffbf, 0xbf7fffbf, 0x3aa21389, 0x3aa21389, 0x3aa21389, 0x3aa21389, 0x3aa21389, - 0x3f7fff17, 0x3f7fff17, 0x3f7fff17, 0x3f7fff17, 0x3f7fff17, 0x3bcf7c4a, 0x3bcf7c4a, 0x3bcf7c4a, - 0x3bcf7c4a, 0x3bcf7c4a, 0xbf7fffd3, 0xbf7fffd3, 0xbf7fffd3, 0xbf7fffd3, 0xbf7fffd3, 0x3ae20746, - 0x3ae20746, 0x3ae20746, 0x3ae20746, 0x3ae20746, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, 0x3f7ffeea, - 0x3f7ffeea, 0x3bbf7f6d, 0x3bbf7f6d, 0x3bbf7f6d, 0x3bbf7f6d, 0x3bbf7f6d, 0xbf7fffe4, 0xbf7fffe4, - 0xbf7fffe4, 0xbf7fffe4, 0xbf7fffe4, 0x3b10fd80, 0x3b10fd80, 0x3b10fd80, 0x3b10fd80, 0x3b10fd80, - 0x3f7ffeb9, 0x3f7ffeb9, 0x3f7ffeb9, 0x3f7ffeb9, 0x3f7ffeb9, 0x3baf828d, 0x3baf828d, 0x3baf828d, - 0x3baf828d, 0x3baf828d, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0xbf7ffff1, 0x3b30f75b, - 0x3b30f75b, 0x3b30f75b, 0x3b30f75b, 0x3b30f75b, 0x3f7ffe84, 0x3f7ffe84, 0x3f7ffe84, 0x3f7ffe84, - 0x3f7ffe84, 0x3b9f85aa, 0x3b9f85aa, 0x3b9f85aa, 0x3b9f85aa, 0x3b9f85aa, 0xbf7ffffa, 0xbf7ffffa, - 0xbf7ffffa, 0xbf7ffffa, 0xbf7ffffa, 0x3b50f133, 0x3b50f133, 0x3b50f133, 0x3b50f133, 0x3b50f133, - 0x3f7ffe4b, 0x3f7ffe4b, 0x3f7ffe4b, 0x3f7ffe4b, 0x3f7ffe4b, 0x3b8f88c5, 0x3b8f88c5, 0x3b8f88c5, - 0x3b8f88c5, 0x3b8f88c5, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0xbf7fffff, 0x3b70eb07, - 0x3b70eb07, 0x3b70eb07, 0x3b70eb07, 0x3b70eb07, 0x3f7ffe0e, 0x3f7ffe0e, 0x3f7ffe0e, 0x3f7ffe0e, - 0x3f7ffe0e, 0x3b7f17bb, 0x3b7f17bb, 0x3b7f17bb, 0x3b7f17bb, 0x3b7f17bb, 0xbf800000, 0xbf800000, - 0xbf800000, 0xbf800000, 0xbf800000, 0x3b88726c, 0x3b88726c, 0x3b88726c, 0x3b88726c, 0x3b88726c, - 0x3f7ffe31, 0x3f7ffe31, 0x3f7ffe31, 0x3f7ffe31, 0x3f7ffe31, 0x3b5f1de8, 0x3b5f1de8, 0x3b5f1de8, - 0x3b5f1de8, 0x3b5f1de8, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0xbf7ffffd, 0x3b986f52, - 0x3b986f52, 0x3b986f52, 0x3b986f52, 0x3b986f52, 0x3f7ffe6b, 0x3f7ffe6b, 0x3f7ffe6b, 0x3f7ffe6b, - 0x3f7ffe6b, 0x3b3f2411, 0x3b3f2411, 0x3b3f2411, 0x3b3f2411, 0x3b3f2411, 0xbf7ffff6, 0xbf7ffff6, - 0xbf7ffff6, 0xbf7ffff6, 0xbf7ffff6, 0x3ba86c36, 0x3ba86c36, 0x3ba86c36, 0x3ba86c36, 0x3ba86c36, - 0x3f7ffea2, 0x3f7ffea2, 0x3f7ffea2, 0x3f7ffea2, 0x3f7ffea2, 0x3b1f2a38, 0x3b1f2a38, 0x3b1f2a38, - 0x3b1f2a38, 0x3b1f2a38, 0x3f7cc335, 0x3f2ab809, 0x3eccd5bd, 0x3f7146fa, 0x3f4a5cdb, 0x3f7321ca, - 0x3f46cd6d, 0x3e7fb55b, 0x3f7bca72, 0x3f2ef22c, 0x3f4dd254, 0x3f6f4d37, 0xbd871e6c, 0x3f7d9b8c, - 0x3ed7495d, 0x3e95ea1f, 0x3f7679a2, 0xbf2579d9, 0x3f372298, 0xbe4e4a80, 0xbf541ad1, 0x3cc09e69, - 0xbf6b3881, 0xbeead545, 0xbf7edcc1, 0x3ebef1b5, 0xbf144ab6, 0x3f7b759c, 0xbdf0c04d, 0x3f45a9c6, - 0xbf38ca2a, 0xbf78ecb7, 0x3e44f5d5, 0xbf771b81, 0xbe9a753e, 0x3d2c676b, 0x3f5d0c2d, 0xbf51675e, - 0x3f041491, 0xbee25604, 0xbf7f17ca, 0xbeef6b22, 0xbf1bf202, 0xbf558adb, 0xbf6a3014, 0x3f7c60cc, - 0x3ec8816c, 0x3f2c77db, 0x3f48e90f, 0x3f720e0d, 0x3f719d6d, 0x3e6d67d9, 0x3f49bd23, 0x3f2b7984, -] )) ), - -################ chunk 17408 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x497ffff8, 0x4a000000, 0x4a000004, 0x49fffff8, 0x4a000002, 0x49fffffc, 0x4a800000, 0x4a800002, - 0x4a7ffffc, 0x4a800001, 0x4a7ffffe, 0x4b000000, 0x4b000001, 0x4afffffe, 0x4b000000, 0x4affffff, - 0x4b800000, 0x4b800000, 0x4b7fffff, 0x4b800000, 0x4b800000, 0x4c000000, 0x4c000000, 0x4c000000, - 0x4c000000, 0x4c000000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4c800000, 0x4d000000, - 0x4d000000, 0x4d000000, 0x4d000000, 0x4d000000, 0x4d800000, 0x4d800000, 0x4d800000, 0x4d800000, - 0x4d800000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e000000, 0x4e800000, 0x4e800000, - 0x4e800000, 0x4e800000, 0x4e800000, 0x4f000000, 0x4f000000, 0x4f000000, 0x4f000000, 0x4f000000, - 0x4f800000, 0x4f800000, 0x4f800000, 0x4f800000, 0x4f800000, 0x50000000, 0x50000000, 0x50000000, - 0x50000000, 0x50000000, 0x50800000, 0x50800000, 0x50800000, 0x50800000, 0x50800000, 0x51000000, - 0x51000000, 0x51000000, 0x51000000, 0x51000000, 0x51800000, 0x51800000, 0x51800000, 0x51800000, - 0x51800000, 0x52000000, 0x52000000, 0x52000000, 0x52000000, 0x52000000, 0x52800000, 0x52800000, - 0x52800000, 0x52800000, 0x52800000, 0x53000000, 0x53000000, 0x53000000, 0x53000000, 0x53000000, - 0x53800000, 0x53800000, 0x53800000, 0x53800000, 0x53800000, 0x54000000, 0x54000000, 0x54000000, - 0x54000000, 0x54000000, 0x54800000, 0x54800000, 0x54800000, 0x54800000, 0x54800000, 0x55000000, - 0x55000000, 0x55000000, 0x55000000, 0x55000000, 0x55800000, 0x55800000, 0x55800000, 0x55800000, - 0x55800000, 0x56000000, 0x56000000, 0x56000000, 0x56000000, 0x56000000, 0x56800000, 0x56800000, - 0x56800000, 0x56800000, 0x56800000, 0x57000000, 0x57000000, 0x57000000, 0x57000000, 0x57000000, - 0x57800000, 0x57800000, 0x57800000, 0x57800000, 0x57800000, 0x58000000, 0x58000000, 0x58000000, - 0x58000000, 0x58000000, 0x58800000, 0x58800000, 0x58800000, 0x58800000, 0x58800000, 0x447a0000, - 0x44898000, 0x44610000, 0x447a4000, 0x4479c000, 0x461c4000, 0x462be000, 0x460ca000, 0x461c4400, - 0x461c3c00, 0x47c35000, 0x47d6d800, 0x47afc800, 0x47c35080, 0x47c34f80, 0x49742400, 0x49864700, - 0x495bba00, 0x49742410, 0x497423f0, 0x4b189680, 0x4b27d8c0, 0x4b095440, 0x4b189681, 0x4b18967f, - 0x4cbebc20, 0x4cd1cef0, 0x4caba950, 0x4cbebc20, 0x4cbebc20, 0x4e6e6b28, 0x4e832156, 0x4e5693a4, - 0x4e6e6b28, 0x4e6e6b28, 0x501502f9, 0x5023e9ac, 0x50061c46, 0x501502f9, 0x501502f9, 0x51ba43b7, - 0x51cce416, 0x51a7a358, 0x51ba43b7, 0x51ba43b7, 0x5368d4a5, 0x53800e8e, 0x53518c2e, 0x5368d4a5, - 0x5368d4a5, 0x551184e7, 0x55201231, 0x5502f79d, 0x551184e7, 0x551184e7, 0x56b5e621, 0x56c816be, - 0x56a3b584, 0x56b5e621, 0x56b5e621, 0x58635fa9, 0x587a1c6d, 0x584ca2e5, 0x58635fa9, 0x58635fa9, - 0x5a0e1bca, 0x5a1c51c4, 0x59ffcb9e, 0x5a0e1bca, 0x5a0e1bca, 0x5bb1a2bc, 0x5bc36635, 0x5b9fdf43, - 0x5bb1a2bc, 0x5bb1a2bc, 0x5d5e0b6b, 0x5d743fc3, 0x5d47d714, 0x5d5e0b6b, 0x5d5e0b6b, 0x44fa0000, - 0x469c4000, 0x453b8000, 0x46ea6000, 0x459c4000, 0x47435000, 0x45fa0000, 0x479c4000, 0x464b2000, - 0x47fde800, 0x46a41000, 0x484d1400, 0x4704d000, 0x48a60400, 0x4756d800, 0x49064700, 0x47add400, - 0x49594900, 0x480ca000, 0x49afc800, 0x48638a00, 0x4a0e3640, 0x48b81500, 0x4a661a40, 0x4914ed00, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7c9976, 0x3f481391, 0xbdd246fe, 0x3f727cf9, 0x3ec608e0, 0x3f7c265c, 0x3e62f4a2, 0xbf336723, - 0x3f70b717, 0xbe8bc65d, 0x3f29793c, 0xbf66d965, 0xbf59d77f, 0xbdfceb5f, 0xbf66d965, 0xbf1589c3, - 0x3f2056b4, 0x3f2056b4, 0xbea29962, 0x3f2056b4, 0x3f2056b4, 0xbe5c9c0d, 0xbe5c9c0d, 0xbe5c9c0d, - 0xbe5c9c0d, 0xbe5c9c0d, 0xbf683c6d, 0xbf683c6d, 0xbf683c6d, 0xbf683c6d, 0xbf683c6d, 0x3f255b29, - 0x3f255b29, 0x3f255b29, 0x3f255b29, 0x3f255b29, 0xbe298aea, 0xbe298aea, 0xbe298aea, 0xbe298aea, - 0xbe298aea, 0xbf71f6e9, 0xbf71f6e9, 0xbf71f6e9, 0xbf71f6e9, 0xbf71f6e9, 0x3f4965a3, 0x3f4965a3, - 0x3f4965a3, 0x3f4965a3, 0x3f4965a3, 0x3e738617, 0x3e738617, 0x3e738617, 0x3e738617, 0x3e738617, - 0xbf630b05, 0xbf630b05, 0xbf630b05, 0xbf630b05, 0xbf630b05, 0x3f12b918, 0x3f12b918, 0x3f12b918, - 0x3f12b918, 0x3f12b918, 0xbeafa16c, 0xbeafa16c, 0xbeafa16c, 0xbeafa16c, 0xbeafa16c, 0xbf43c0f5, - 0xbf43c0f5, 0xbf43c0f5, 0xbf43c0f5, 0xbf43c0f5, 0x3e2d7c30, 0x3e2d7c30, 0x3e2d7c30, 0x3e2d7c30, - 0x3e2d7c30, 0xbf714ddd, 0xbf714ddd, 0xbf714ddd, 0xbf714ddd, 0xbf714ddd, 0x3f46e765, 0x3f46e765, - 0x3f46e765, 0x3f46e765, 0x3f46e765, 0x3e54560d, 0x3e54560d, 0x3e54560d, 0x3e54560d, 0x3e54560d, - 0xbf69fc2c, 0xbf69fc2c, 0xbf69fc2c, 0xbf69fc2c, 0xbf69fc2c, 0x3f2bba00, 0x3f2bba00, 0x3f2bba00, - 0x3f2bba00, 0x3f2bba00, 0xbdccdfcd, 0xbdccdfcd, 0xbdccdfcd, 0xbdccdfcd, 0xbdccdfcd, 0xbf7ae054, - 0xbf7ae054, 0xbf7ae054, 0xbf7ae054, 0xbf7ae054, 0x3f6bb5d3, 0x3f6bb5d3, 0x3f6bb5d3, 0x3f6bb5d3, - 0x3f6bb5d3, 0x3f320ea5, 0x3f320ea5, 0x3f320ea5, 0x3f320ea5, 0x3f320ea5, 0xbd04f439, 0xbd04f439, - 0xbd04f439, 0xbd04f439, 0xbd04f439, 0xbf7f75e6, 0xbf7f75e6, 0xbf7f75e6, 0xbf7f75e6, 0xbf7f75e6, - 0x3f7dd82f, 0x3f7dd82f, 0x3f7dd82f, 0x3f7dd82f, 0x3f7dd82f, 0x3f776a06, 0x3f776a06, 0x3f776a06, - 0x3f776a06, 0x3f776a06, 0x3f5e3b89, 0x3f5e3b89, 0x3f5e3b89, 0x3f5e3b89, 0x3f5e3b89, 0x3f0ff813, - 0x3f6755d6, 0x3d87ac5a, 0xbec8ac6a, 0x3f7fe90e, 0xbf73c074, 0xbe90c6b4, 0xbf49c612, 0xbe83bb01, - 0xbf4588b7, 0xbf7fd61c, 0x3f766492, 0x3f70cc91, 0xbf11ee0b, 0xbf028731, 0x3f6fcefd, 0xbf6c73c5, - 0xbf72dbb9, 0x3f4cf6a9, 0x3e58b2e7, 0xbf6842df, 0xbf33e40c, 0xbf7f4067, 0xbf581590, 0xbe0b97de, - 0xbeba0d9c, 0xbd7e6746, 0x3f38b364, 0xbeba0d9c, 0xbeba0d9c, 0x3f567fc6, 0xbf502115, 0x3e50f35d, - 0x3f567fc6, 0x3f567fc6, 0x3f5f84c5, 0xbf7ffbb7, 0xbf08cd09, 0x3f5f84c5, 0x3f5f84c5, 0x3d7bcaec, - 0x3ecccf4b, 0xbe91adb3, 0x3d7bcaec, 0x3d7bcaec, 0x3f7ff1d1, 0x3f7a1d5e, 0x3f77a0c4, 0x3f7ff1d1, - 0x3f7ff1d1, 0x3e7d7d10, 0xbecbb4d6, 0x3f4a0824, 0x3e7d7d10, 0x3e7d7d10, 0x3e8227f6, 0xbf7c4b5b, - 0x3f7106dd, 0x3e8227f6, 0x3e8227f6, 0x3dd7c630, 0x3f7f16bb, 0xbf74e752, 0x3dd7c630, 0x3dd7c630, - 0x3f5e34db, 0xbe10aaab, 0xbefc7e1d, 0x3f5e34db, 0x3f5e34db, 0xbf525898, 0xbe1c5bca, 0xbf7aa99b, - 0xbf525898, 0xbf525898, 0x3f79ea33, 0x3eed92ef, 0x3f7e0366, 0x3f79ea33, 0x3f79ea33, 0xbebc23a8, - 0x3f502ddb, 0xbf79c64f, 0xbf18af9b, 0x3e1e6165, 0xbc927353, 0x3d8670f4, 0xbf4ab84c, 0x3f7ef91d, - 0x3f1fef22, 0xbcc3d401, 0xbf78b80e, 0xbde7f668, 0xbed819fd, 0xbf7d963b, 0x3e4815a7, 0x3e7e4125, - 0x3f4e7e68, 0xbec1ddfc, 0x3f3cbf1b, 0x3f4d7356, 0x3f7e788c, 0xbf5b2664, 0x3f28be92, 0xbf7ed1f5, -] )) ), - -################ chunk 17920 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4aba2840, 0x4970f780, 0x4b169ab0, 0x49c2f240, 0x4b73aed0, 0x4a1db700, 0x4bc524c0, 0x4a7f3020, - 0x4c1f7e14, 0x4ace7390, 0x4c81083a, 0x4b2705d0, 0x4cd0c744, 0x47c54400, 0x49769500, 0x4b1a1d20, - 0x439ea683, 0x431ea683, 0x47c92c00, 0x497b7700, 0x4b1d2a60, 0x43a1cac2, 0x4321cac2, 0x47d0fc00, - 0x49829d80, 0x4b2344e0, 0x43a81341, 0x43281341, 0x47d4e400, 0x49850e80, 0x4b265220, 0x43ab3780, - 0x432b3780, 0x47dcb400, 0x4989f080, 0x4b2c6ca0, 0x43b17fff, 0x43317fff, 0x47f80c00, 0x499b0780, - 0x4b41c960, 0x43c77dbb, 0x43477dbb, 0x47ffdc00, 0x499fe980, 0x4b47e3e0, 0x43cdc63a, 0x434dc63a, - 0x4805ca00, 0x49a73c80, 0x4b510ba0, 0x43d732f8, 0x435732f8, 0x4807be00, 0x49a9ad80, 0x4b5418e0, - 0x43da5737, 0x435a5737, 0x48118200, 0x49b5e280, 0x4b635b20, 0x43ea0c75, 0x436a0c75, 0x48137600, - 0x49b85380, 0x4b666860, 0x43ed30b4, 0x436d30b4, 0x48195200, 0x49bfa680, 0x4b6f9020, 0x43f69d72, - 0x43769d72, 0x481f2e00, 0x49c6f980, 0x4b78b7e0, 0x44000518, 0x43800518, 0x48231600, 0x49cbdb80, - 0x4b7ed260, 0x44032958, 0x43832958, 0x4828f200, 0x49d32e80, 0x4b83fd10, 0x4407dfb7, 0x4387dfb7, - 0x482ece00, 0x49da8180, 0x4b8890f0, 0x440c9616, 0x438c9616, 0x4830c200, 0x49dcf280, 0x4b8a1790, - 0x440e2836, 0x438e2836, 0x483a8600, 0x49e92780, 0x4b91b8b0, 0x441602d4, 0x439602d4, 0x483c7a00, - 0x49eb9880, 0x4b933f50, 0x441794f4, 0x439794f4, 0x48406200, 0x49f07a80, 0x4b964c90, 0x441ab933, - 0x439ab933, 0x48425600, 0x49f2eb80, 0x4b97d330, 0x441c4b53, 0x439c4b53, 0x484e0e00, 0x4a00c8c0, - 0x4ba0faf0, 0x4425b811, 0x43a5b811, 0x4859c600, 0x4a081bc0, 0x4baa22b0, 0x442f24cf, 0x43af24cf, - 0x485dae00, 0x4a0a8cc0, 0x4bad2ff0, 0x4432490f, 0x43b2490f, 0x485fa200, 0x4a0bc540, 0x4baeb690, - 0x4433db2f, 0x43b3db2f, 0x48638a00, 0x4a0e3640, 0x4bb1c3d0, 0x4436ff6e, 0x43b6ff6e, 0x48696600, - 0x4a11dfc0, 0x4bb657b0, 0x443bb5cd, 0x43bbb5cd, 0x486b5a00, 0x4a131840, 0x4bb7de50, 0x443d47ed, - 0x43bd47ed, 0x48751e00, 0x4a1932c0, 0x4bbf7f70, 0x4445228b, 0x43c5228b, 0x487afa00, 0x4a1cdc40, - 0x4bc41350, 0x4449d8ea, 0x43c9d8ea, 0x48806b00, 0x4a2085c0, 0x4bc8a730, 0x444e8f4a, 0x43ce8f4a, - 0x48835900, 0x4a242f40, 0x4bcd3b10, 0x445345a9, 0x43d345a9, 0x48845300, 0x4a2567c0, 0x4bcec1b0, - 0x4454d7c8, 0x43d4d7c8, 0x48874100, 0x4a291140, 0x4bd35590, 0x44598e28, 0x43d98e28, 0x48893500, - 0x4a2b8240, 0x4bd662d0, 0x445cb267, 0x43dcb267, 0x488a2f00, 0x4a2cbac0, 0x4bd7e970, 0x445e4487, - 0x43de4487, 0x488f1100, 0x4a32d540, 0x4bdf8a90, 0x44661f25, 0x43e61f25, 0x4895e700, 0x4a3b60c0, - 0x4bea38f0, 0x44711e03, 0x43f11e03, 0x4897db00, 0x4a3dd1c0, 0x4bed4630, 0x44744243, 0x43f44243, - 0x4898d500, 0x4a3f0a40, 0x4beeccd0, 0x4475d462, 0x43f5d462, 0x489ac900, 0x4a417b40, 0x4bf1da10, - 0x4478f8a2, 0x43f8f8a2, 0x48a19f00, 0x4a4a06c0, 0x4bfc8870, 0x4481fbc0, 0x4401fbc0, 0x48a48d00, - 0x4a4db040, 0x4c008e28, 0x448456ef, 0x440456ef, 0x48a96f00, 0x4a53cac0, 0x4c045eb8, 0x4488443f, - 0x4408443f, 0x48aa6900, 0x4a550340, 0x4c052208, 0x44890d4f, 0x44090d4f, 0x48ac5d00, 0x4a577440, - 0x4c06a8a8, 0x448a9f6e, 0x440a9f6e, 0x48af4b00, 0x4a5b1dc0, 0x4c08f298, 0x448cfa9e, 0x440cfa9e, - 0x48b33300, 0x4a5fffc0, 0x4c0bffd8, 0x44901edd, 0x44101edd, 0x45800000, 0x45800000, 0x45800000, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f12b9fa, 0x3f66d451, 0xbe742800, 0xbf70618f, 0xbf6eb6aa, 0xbf32ac11, 0xbe03911c, 0x3ed16cf8, - 0x3ef4c2c8, 0x3ebc6e0e, 0x3f4f4410, 0x3f7fbf18, 0x3f670ed9, 0xbf1771c2, 0xbf7fb7b0, 0x3f644398, - 0xbf800000, 0xb6f82347, 0x3f779be9, 0xbf56f246, 0x3f5b6654, 0xbf800000, 0x358c48ee, 0xbf612c5a, - 0x3e791904, 0x3f465b85, 0xbf800000, 0x3671e04a, 0x3f44032a, 0x3f43277c, 0x3f3a4982, 0xbf800000, - 0x363841cd, 0xbf7fa107, 0x3f5bc79e, 0x3f1f5b2d, 0xbf800000, 0x34485f9f, 0xbee075f7, 0x3e317dfc, - 0x3e2e9430, 0xbf800000, 0x359916d0, 0xbe96afe7, 0x3f7cf5e5, 0x3ce7ca1c, 0xbf800000, 0x3678473b, - 0x3e122bb2, 0xbe0d5375, 0xbe3d9bfc, 0xbf800000, 0x33c3e110, 0xbf791475, 0xbf304b3d, 0xbe82835a, - 0xbf800000, 0xb6d82090, 0x3f5b1844, 0x3f298b9d, 0xbf13c487, 0xbf800000, 0xb6fe8a38, 0xbf4ba8a3, - 0x3f7980f0, 0xbf2253aa, 0xbf800000, 0x35a5e4b3, 0xbeeb7de7, 0xbd88ff18, 0xbf48bfd0, 0xbf800000, - 0x362b73ea, 0xbd1347b8, 0xbf6f9f0d, 0xbf65f79f, 0xbf800000, 0xb6d4ed17, 0x3f35953f, 0x3cff6ff6, - 0xbf73a6c4, 0xbf800000, 0x37407869, 0x3eade70f, 0x3f72b064, 0xbf7ec9dc, 0xbf800000, 0xb700ded8, - 0xbdc31fa2, 0xbf140900, 0xbf7e3e51, 0xbf800000, 0x36828a8f, 0x3f75f834, 0xbf71ef29, 0xbf7b7458, - 0xbf800000, 0xb756bcc2, 0xbf5483fa, 0x3f6ec9ad, 0xbf5abdbd, 0xbf800000, 0xb677b769, 0x3f52d6f1, - 0x3f77e3e5, 0xbf50addd, 0xbf800000, 0xb6af1340, 0xbf7d2545, 0x3d9baade, 0xbf39696b, 0xbf800000, - 0x36fb0ed6, 0x3f0079de, 0xbf04bbc7, 0xbf2c534b, 0xbf800000, 0x35bf8079, 0xbeb37f1b, 0x3f679566, - 0xbe9be2f6, 0xbf800000, 0xb6ce8625, 0xbf724c04, 0xbf7d4f38, 0x3df48f26, 0xbf800000, 0xb7667635, - 0x3ef0c49e, 0xbe3ab3ce, 0x3e84f919, 0xbf800000, 0x3688f180, 0xbf7e5bd3, 0x3ed91181, 0x3ea7f612, - 0xbf800000, 0xb759f03b, 0x3f4d7356, 0x3f7e788c, 0x3eeb2ff1, 0xbf800000, 0xb49be5ea, 0x3f7b08c0, - 0xbec85a45, 0x3f234f1d, 0xbf800000, 0xb66ae986, 0xbf0ae99b, 0xbf5a921c, 0x3f30fa5f, 0xbf800000, - 0xb6b57a32, 0x3f45fbcb, 0x3f55aaa1, 0x3f66860e, 0xbf800000, 0xb739ed83, 0x3edb16be, 0x3e92b65e, - 0x3f78f0ea, 0xbf800000, 0x37798714, 0x395a86ef, 0xbf7fffdc, 0x3f7ff1c5, 0xbf800000, 0x3746df5b, - 0xbedae55c, 0x3e94c173, 0x3f7b366b, 0xbf800000, 0xb70745ca, 0x3f7f7389, 0x3f4b0b97, 0x3f770cae, - 0xbf800000, 0xb76342bc, 0x3f5fbd82, 0x3eb562fd, 0x3f6319ae, 0xbf800000, 0xb75d23b3, 0xbf785956, - 0xbf455781, 0x3f4ff076, 0xbf800000, 0xb5012a80, 0x3f15080f, 0xbf7f621c, 0x3f44bd0a, 0xbf800000, - 0x371d8a22, 0xbf4d83a1, 0x3f7e95cb, 0x3efdeef1, 0xbf800000, 0x36ee40f4, 0xbf694cc6, 0xbee79afd, - 0x3c9659b8, 0xbf800000, 0xb6c1b843, 0x3ec48604, 0x3f32bfa0, 0xbdfeaa7b, 0xbf800000, 0x374a12d3, - 0xbf7ff5c5, 0x3f7c0392, 0xbe479b3b, 0xbf800000, 0x372075b2, 0x3f3dedcc, 0x3ef7c7f3, 0xbeaa5d2a, - 0xbf800000, 0xb70a7943, 0xbe66ad83, 0x3f25327f, 0xbf3e982b, 0xbf800000, 0x3720bd9b, 0x3e5a36ed, - 0x3f0b94b4, 0xbf5e9c60, 0xbf800000, 0x37cf6dfb, 0x3dc3f929, 0xbf1329d1, 0xbf7cc66f, 0xbf800000, - 0x37a63cb7, 0x3f63fefc, 0x3c0f29dc, 0xbf7f05f6, 0xbf800000, 0xb7f0f874, 0xbeadb3ac, 0x3f7306c9, - 0xbf7f9a91, 0xbf800000, 0x37732023, 0xbf3581fc, 0x3cdd4e96, 0xbf76b67d, 0xbf800000, 0x374d464c, - 0x3f2839a0, 0xbf21c123, 0xbf596868, 0xbf800000, 0xb75cdbca, 0x3f4dd254, 0x3f4dd254, 0x3f4dd254, -] )) ), - -################ chunk 18432 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x45800000, 0x46000000, 0x46000000, 0x46000000, 0x46000000, 0x46800000, 0x46800000, 0x46800000, - 0x46800000, 0x47000000, 0x47000000, 0x47000000, 0x47000000, 0x47800000, 0x47800000, 0x47800000, - 0x47800000, 0x48000000, 0x48000000, 0x48000000, 0x48000000, 0x48800000, 0x48800000, 0x48800000, - 0x48800000, 0x49000000, 0x49000000, 0x49000000, 0x49000000, 0x49800000, 0x49800000, 0x49800000, - 0x49800000, 0x4a25e927, 0x4bcf6371, 0x4d819e27, 0x49aca22c, 0x4b57cab8, 0x4c843514, 0x4bafac5d, - 0x4544597b, 0x4546aa6a, 0x45c4597b, 0x45c6aa6a, 0x4613431d, 0x4614ffd0, 0x4644597b, 0x4646aa6a, - 0x46756fda, 0x46785505, 0x4693431d, 0x4694ffd0, 0x46abce4c, 0x46add51d, 0x46c4597b, 0x46c6aa6a, - 0x46dce4ab, 0x46df7fb8, 0x46f56fda, 0x46f85505, 0x4706fd85, 0x47089529, 0x4713431d, 0x4714ffd0, - 0x471f88b4, 0x47216a76, 0x472bce4c, 0x472dd51d, 0x473813e4, 0x473a3fc4, 0x4744597b, 0x4746aa6a, - 0x47509f13, 0x47531511, 0x475ce4ab, 0x475f7fb8, 0x47692a43, 0x476bea5e, 0x47756fda, 0x47785505, - 0x4780dab9, 0x47825fd6, 0x4786fd85, 0x47889529, 0x478d2051, 0x478eca7c, 0x4793431d, 0x4794ffd0, - 0x479965e8, 0x479b3523, 0x479f88b4, 0x47a16a76, 0x47a5ab80, 0x47a79fca, 0x47abce4c, 0x47add51d, - 0x47b1f118, 0x47b40a70, 0x47b813e4, 0x47ba3fc4, 0x47be36b0, 0x47c07517, 0x47c4597b, 0x47c6aa6a, - 0x47ca7c47, 0x47ccdfbe, 0x47d09f13, 0x47d31511, 0x47d6c1df, 0x47d94a64, 0x47dce4ab, 0x47df7fb8, - 0x47e30777, 0x47e5b50b, 0x47e92a43, 0x47ebea5e, 0x47ef4d0e, 0x47f21fb2, 0x47f56fda, 0x47f85505, - 0x47fb92a6, 0x47fe8a58, 0x4800dab9, 0x48025fd6, 0x4803ec1f, 0x48057a7f, 0x4806fd85, 0x48089529, - 0x480a0eeb, 0x480bafd3, 0x480d2051, 0x480eca7c, 0x481031b7, 0x4811e526, 0x4813431d, 0x4814ffd0, - 0x48165482, 0x48181a79, 0x481965e8, 0x481b3523, 0x481c774e, 0x481e4fcd, 0x481f88b4, 0x48216a76, - 0x48229a1a, 0x48248520, 0x4825ab80, 0x48279fca, 0x4828bce6, 0x482aba73, 0x482bce4c, 0x482dd51d, - 0x482edfb2, 0x4830efc7, 0x4831f118, 0x48340a70, 0x4835027e, 0x4837251a, 0x483813e4, 0x483a3fc4, - 0x483b254a, 0x483d5a6d, 0x483e36b0, 0x48407517, 0x48414815, 0x48438fc1, 0x4844597b, 0x4846aa6a, - 0x48476ae1, 0x4849c514, 0x484a7c47, 0x484cdfbe, 0x484d8dad, 0x484ffa67, 0x48509f13, 0x48531511, - 0x4853b079, 0x48562fbb, 0x4856c1df, 0x48594a64, 0x4859d345, 0x485c650e, 0x485ce4ab, 0x485f7fb8, - 0x485ff611, 0x48629a61, 0x48630777, 0x4865b50b, 0x486618dd, 0x4868cfb5, 0x48692a43, 0x486bea5e, - 0x486c3ba8, 0x486f0508, 0x486f4d0e, 0x48721fb2, 0x48725e74, 0x48753a5b, 0x48756fda, 0x48785505, - 0x48788140, 0x487b6fae, 0x487b92a6, 0x487e8a58, 0x487ea40c, 0x4880d281, 0x4880dab9, 0x48825fd6, - 0x4882636c, 0x4883ed2b, 0x4883ec1f, 0x48857a7f, 0x488574d2, 0x488707d4, 0x4886fd85, 0x48889529, - 0x48888638, 0x488a227e, 0x488a0eeb, 0x488bafd3, 0x488b979e, 0x488d3d28, 0x488d2051, 0x488eca7c, - 0x488ea904, 0x489057d1, 0x489031b7, 0x4891e526, 0x4891ba6a, 0x4893727b, 0x4893431d, 0x4894ffd0, - 0x4894cbcf, 0x48968d25, 0x48965482, 0x48981a79, 0x4897dd35, 0x4899a7ce, 0x489965e8, 0x489b3523, - 0x489aee9b, 0x489cc278, 0x489c774e, 0x489e4fcd, 0x489e0001, 0x489fdd22, 0x489f88b4, 0x48a16a76, - 0x48a11167, 0x48a2f7cb, 0x48a29a1a, 0x48a48520, 0x48a422cd, 0x48a61275, 0x48a5ab80, 0x48a79fca, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f4dd254, 0x3e95ea1f, 0x3e95ea1f, 0x3e95ea1f, 0x3e95ea1f, 0xbf541ad1, 0xbf541ad1, 0xbf541ad1, - 0xbf541ad1, 0x3ebef1b5, 0x3ebef1b5, 0x3ebef1b5, 0x3ebef1b5, 0xbf38ca2a, 0xbf38ca2a, 0xbf38ca2a, - 0xbf38ca2a, 0x3d2c676b, 0x3d2c676b, 0x3d2c676b, 0x3d2c676b, 0xbf7f17ca, 0xbf7f17ca, 0xbf7f17ca, - 0xbf7f17ca, 0x3f7c60cc, 0x3f7c60cc, 0x3f7c60cc, 0x3f7c60cc, 0x3f719d6d, 0x3f719d6d, 0x3f719d6d, - 0x3f719d6d, 0x3f7d625f, 0x3f18e481, 0xbf669efe, 0x3f683d76, 0x3f16d598, 0xbed1517f, 0x3f11bd88, - 0x3f800000, 0x3f4d336e, 0x3f7fffff, 0x3e91eda3, 0x3f7fffff, 0xbeb0398e, 0x3f7ffffe, 0xbf566878, - 0x3f7fffff, 0xbf7f80a6, 0x3f7ffffc, 0xbf435868, 0x3f800000, 0xbe662110, 0x3f7ffff8, 0x3ece4b50, - 0x3f800000, 0x3f5e9579, 0x3f7ffffb, 0x3f7e0316, 0x3f7fffff, 0x3f387b8d, 0x3f7fffef, 0x3e287e6a, - 0x3f7ffff0, 0xbeeb8958, 0x3f7fffff, 0xbf662412, 0x3f7ffffa, 0xbf7b94ac, 0x3f7fffdf, 0xbf2ce15b, - 0x3f7ffff9, 0xbdd07819, 0x3f800000, 0x3f030f2b, 0x3f7ffff2, 0x3f6cc678, 0x3f7fffed, 0x3f781440, - 0x3f7fffff, 0x3f215cc8, 0x3f7ffffc, 0x3d1e3acf, 0x3f7fffe5, 0xbf118993, 0x3f7fffbb, 0xbf72233b, - 0x3f7fff84, 0xbf739538, 0x3f7fffc1, 0xbf13a547, 0x3f7fffe9, 0x3caa3c12, 0x3f7ffffd, 0x3f1dc9ad, - 0x3f7ffffe, 0x3f772c65, 0x3f7fffe9, 0x3f6e79be, 0x3f7fffc1, 0x3f06f718, 0x3f7fff7b, 0xbdb4067e, - 0x3f7fffba, 0xbf297b30, 0x3f7fffe5, 0xbf7ab1e5, 0x3f7ffffc, 0xbf67aec7, 0x3f7fffff, 0xbef39de6, - 0x3f7fffed, 0x3e166e45, 0x3f7fffc7, 0x3f35fd0f, 0x3f7fff72, 0x3f7d54da, 0x3f7fffb4, 0x3f60ce7d, - 0x3f7fffe1, 0x3ed4cfc6, 0x3f7ffffa, 0xbe52515b, 0x3f7fffff, 0xbf41ac66, 0x3f7ffff0, 0xbf7f3c67, - 0x3f7fffcd, 0xbf59230c, 0x3f7fff96, 0xbeb50b78, 0x3f7fff4a, 0x3e8a960a, 0x3f7ffeea, 0x3f4a0d40, - 0x3f7ffd7a, 0x3f7ffcb2, 0x3f7ffe11, 0x3f4f893f, 0x3f7ffe94, 0x3e9c1907, 0x3f7fff03, 0xbeab6316, - 0x3f7fff5e, 0xbf542809, 0x3f7fffa5, 0xbf7fc766, 0x3f7fffd7, 0xbf44ff5e, 0x3f7ffff6, 0xbe75f81c, - 0x3f800000, 0x3ec40c27, 0x3f7ffff6, 0x3f5d4d65, 0x3f7fffd8, 0x3f7e7c81, 0x3f7fffa5, 0x3f3c4d2f, - 0x3f7fff5f, 0x3e32a1a0, 0x3f7fff04, 0xbee36190, 0x3f7ffd51, 0xbf63a579, 0x3f7ffded, 0xbf7c0b37, - 0x3f7ffe75, 0xbf303968, 0x3f7ffeea, 0xbdfcc1f0, 0x3f7fff49, 0x3f00d7f8, 0x3f7fff95, 0x3f6affde, - 0x3f7fffcd, 0x3f79653e, 0x3f7ffff0, 0x3f2359c5, 0x3f7fffff, 0x3d674aaa, 0x3f7ffffa, 0xbf0c156e, - 0x3f7fffe1, 0xbf714a69, 0x3f7fffb4, 0xbf74f353, 0x3f7fff73, 0xbf18f704, 0x3f7fff1d, 0x3c2fe867, - 0x3f7ffd26, 0x3f1a29b0, 0x3f7ffdc8, 0x3f7561a5, 0x3f7ffe55, 0x3f6f660b, 0x3f7ffece, 0x3f0ad401, - 0x3f7fff33, 0xbd9f85ff, 0x3f7fff84, 0xbf278b9c, 0x3f7fffc1, 0xbf79baa7, 0x3f7fffe9, 0xbf6a66ce, - 0x3f7ffffd, 0xbeff1866, 0x3f7ffffe, 0x3e142b34, 0x3f7fffea, 0x3f342bb6, 0x3f7fffc1, 0x3f7cf2c6, - 0x3f7fff85, 0x3f62f526, 0x3f7fff34, 0x3ee0b1bc, 0x3f7ffed0, 0xbe38867c, 0x3f7ffe57, 0xbf3ffb64, - 0x3f7ffdca, 0xbf7f0648, 0x3f7ffd29, 0xbf5a7cf3, 0x3f7ffc73, 0xbec14725, 0x3f7ffbaa, 0x3e7bc74b, - 0x3f7ff49b, 0x3f45f348, 0x3f7ff5e8, 0x3f7ff2c6, 0x3f7ff721, 0x3f510800, 0x3f7ff845, 0x3ea0fcf7, - 0x3f7ff956, 0xbe9ef26c, 0x3f7ffa52, 0xbf5068bf, 0x3f7ffb3a, 0xbf7ff7b9, 0x3f7ffc0e, 0xbf46a13d, - 0x3f7ffcce, 0xbe7ff11d, 0x3f7ffd79, 0x3ebf4954, 0x3f7ffe11, 0x3f59ed1f, 0x3f7ffe94, 0x3f7f1db1, -] )) ), - -################ chunk 18944 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x48a73433, 0x48a92d1e, 0x48a8bce6, 0x48aaba73, 0x48aa4599, 0x48ac47c8, 0x48abce4c, 0x48add51d, - 0x48ad56ff, 0x48af6272, 0x48aedfb2, 0x48b0efc7, 0x48b06865, 0x48b27d1b, 0x48b1f118, 0x48b40a70, - 0x48b379cb, 0x48b597c5, 0x48b5027e, 0x48b7251a, 0x48b68b31, 0x48b8b26f, 0x48b813e4, 0x48ba3fc4, - 0x48b99c97, 0x48bbcd18, 0x48bb254a, 0x48bd5a6d, 0x48bcadfd, 0x48bee7c2, 0x48be36b0, 0x48c07517, - 0x48bfbf62, 0x48c2026c, 0x48c14815, 0x48c38fc1, 0x48c2d0c8, 0x48c51d15, 0x48c4597b, 0x48c6aa6a, - 0x48c5e22e, 0x48c837bf, 0x48c76ae1, 0x48c9c514, 0x48c8f394, 0x48cb5269, 0x48ca7c47, 0x48ccdfbe, - 0x48cc04fa, 0x48ce6d12, 0x48cd8dad, 0x48cffa67, 0x48cf1660, 0x48d187bc, 0x48d09f13, 0x48d31511, - 0x48d227c6, 0x48d4a266, 0x48d3b079, 0x48d62fbb, 0x48d5392c, 0x48d7bd0f, 0x48d6c1df, 0x48d94a64, - 0x48d84a92, 0x48dad7b9, 0x48d9d345, 0x48dc650e, 0x48db5bf8, 0x48ddf263, 0x48dce4ab, 0x48df7fb8, - 0x48de6d5e, 0x48e10d0c, 0x48dff611, 0x48e29a61, 0x48e17ec4, 0x48e427b6, 0x48e30777, 0x48e5b50b, - 0x48e4902a, 0x48e74260, 0x48e618dd, 0x48e8cfb5, 0x48e7a190, 0x48ea5d09, 0x48e92a43, 0x48ebea5e, - 0x48eab2f5, 0x48ed77b3, 0x48ec3ba8, 0x48ef0508, 0x48edc45b, 0x48f0925d, 0x48ef4d0e, 0x48f21fb2, - 0x48f0d5c1, 0x48f3ad06, 0x48f25e74, 0x48f53a5b, 0x48f3e727, 0x48f6c7b0, 0x48f56fda, 0x48f85505, - 0x48f6f88d, 0x48f9e25a, 0x48f88140, 0x48fb6fae, 0x48fa09f3, 0x48fcfd03, 0x48fb92a6, 0x48fe8a58, - 0x48fd1b59, 0x49000bd6, 0x48fea40c, 0x4900d281, 0x4900165f, 0x4901992b, 0x4900dab9, 0x49025fd6, - 0x49019f12, 0x49032680, 0x4902636c, 0x4903ed2b, 0x490327c5, 0x4904b3d5, 0x4903ec1f, 0x49057a7f, - 0x4904b078, 0x4906412a, 0x490574d2, 0x490707d4, 0x4906392b, 0x4907ce7f, 0x4906fd85, 0x49089529, - 0x4907c1de, 0x49095bd3, 0x49088638, 0x490a227e, 0x49094a91, 0x490ae928, 0x490a0eeb, 0x490bafd3, - 0x490ad344, 0x490c767d, 0x490b979e, 0x490d3d28, 0x490c5bf7, 0x490e03d2, 0x490d2051, 0x490eca7c, - 0x490de4aa, 0x490f9127, 0x490ea904, 0x491057d1, 0x490f6d5d, 0x49111e7c, 0x491031b7, 0x4911e526, - 0x4910f610, 0x4912abd0, 0x4911ba6a, 0x4913727b, 0x49127ec3, 0x49143925, 0x4913431d, 0x4914ffd0, - 0x49140776, 0x4915c67a, 0x4914cbcf, 0x49168d25, 0x49159029, 0x491753cf, 0x49165482, 0x49181a79, - 0x491718dc, 0x4918e124, 0x4917dd35, 0x4919a7ce, 0x4918a18f, 0x491a6e79, 0x491965e8, 0x491b3523, - 0x491a2a42, 0x491bfbcd, 0x491aee9b, 0x491cc278, 0x491bb2f5, 0x491d8922, 0x491c774e, 0x491e4fcd, - 0x491d3ba8, 0x491f1677, 0x491e0001, 0x491fdd22, 0x491ec45b, 0x4920a3cc, 0x491f88b4, 0x49216a76, - 0x49204d0e, 0x49223121, 0x49211167, 0x4922f7cb, 0x4921d5c1, 0x4923be76, 0x49229a1a, 0x49248520, - 0x49235e74, 0x49254bca, 0x492422cd, 0x49261275, 0x4924e727, 0x4926d91f, 0x4925ab80, 0x49279fca, - 0x49266fda, 0x49286674, 0x49273433, 0x49292d1e, 0x4927f88d, 0x4929f3c9, 0x4928bce6, 0x492aba73, - 0x49298140, 0x492b811e, 0x492a4599, 0x492c47c8, 0x492b09f2, 0x492d0e73, 0x492bce4c, 0x492dd51d, - 0x492c92a5, 0x492e9bc7, 0x492d56ff, 0x492f6272, 0x492e1b58, 0x4930291c, 0x492edfb2, 0x4930efc7, - 0x492fa40b, 0x4931b671, 0x49306865, 0x49327d1b, 0x49312cbe, 0x493343c6, 0x4931f118, 0x49340a70, - 0x4932b571, 0x4934d11b, 0x493379cb, 0x493597c5, 0x49343e24, 0x49365e70, 0x4935027e, 0x4937251a, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fff03, 0x3f3b54b5, 0x3f7fff5e, 0x3e3cc038, 0x3f7fffa5, 0xbedec2f3, 0x3f7fffd7, 0xbf627565, - 0x3f7ffff6, 0xbf7d1c8b, 0x3f800000, 0xbf34eeb2, 0x3f7ffff6, 0xbdf169f4, 0x3f7fffd8, 0x3efd3ae1, - 0x3f7fffa6, 0x3f69f7b4, 0x3f7fff5f, 0x3f79f698, 0x3f7fff05, 0x3f285b2f, 0x3f7ffe96, 0x3da81746, - 0x3f7ffe13, 0xbf0d46f0, 0x3f7ffd7c, 0xbf706b5b, 0x3f7ffcd1, 0xbf75af7c, 0x3f7ffc11, 0xbf1b04eb, - 0x3f7ff3ec, 0xbc74a98d, 0x3f7ff543, 0x3f14ddc0, 0x3f7ff686, 0x3f75c8e4, 0x3f7ff7b5, 0x3f704c29, - 0x3f7ff8cf, 0x3f0cfb53, 0x3f7ff9d6, 0xbd562087, 0x3f7ffac8, 0xbf2285a2, 0x3f7ffba6, 0xbf78338d, - 0x3f7ffc70, 0xbf69d2dd, 0x3f7ffd26, 0xbefc9d48, 0x3f7ffdc7, 0x3df439de, 0x3f7ffe55, 0x3f2f7182, - 0x3f7ffece, 0x3f7bda7b, 0x3f7fff33, 0x3f65ec36, 0x3f7fff84, 0x3ede1fb1, 0x3f7fffc0, 0xbe3e247a, - 0x3f7fffe9, 0xbf3b926e, 0x3f7ffffd, 0xbf7e5e10, 0x3f7ffffe, 0xbf5dd729, 0x3f7fffea, 0xbecd6236, - 0x3f7fffc2, 0x3e80a807, 0x3f7fff85, 0x3f46da5d, 0x3f7fff35, 0x3f7fbb65, 0x3f7ffed0, 0x3f54c17b, - 0x3f7ffe57, 0x3ead690b, 0x3f7ffdca, 0xbe9266f3, 0x3f7ffd29, 0xbf513c44, 0x3f7ffc74, 0xbf7ff0e4, - 0x3f7ff338, 0xbf4ab5af, 0x3f7ff499, 0xbe8ca746, 0x3f7ff5e6, 0x3eb30885, 0x3f7ff71f, 0x3f566815, - 0x3f7ff844, 0x3f7efe50, 0x3f7ff955, 0x3f3fbf64, 0x3f7ffa51, 0x3e568596, 0x3f7ffb39, 0xbed2dafc, - 0x3f7ffc0d, 0xbf5f51d7, 0x3f7ffccd, 0xbf7ce4c2, 0x3f7ffd79, 0xbf33eb48, 0x3f7ffe10, 0xbe12c478, - 0x3f7ffe93, 0x3effb57f, 0x3f7fff03, 0x3f673942, 0x3f7fd65c, 0x3f79a6a8, 0x3f7fffa4, 0x3f2d4032, - 0x3f7fdb53, 0x3d9cb322, 0x3f7ffff6, 0xbf00e731, 0x3f7fdff9, 0xbf6e1532, 0x3f7ffff6, 0xbf7547c1, - 0x3f7fe44f, 0xbf203284, 0x3f7fffa6, 0xbc194075, 0x3f7fe854, 0x3f0f78b3, 0x3f7fff05, 0x3f73ddb7, - 0x3f7fec09, 0x3f6fcd1c, 0x3f7ffe14, 0x3f126b84, 0x3f7fef6c, 0xbd6cf25b, 0x3f7ffcd1, 0xbf1d643e, - 0x3f7ff27f, 0xbf788c21, 0x3f7ffb3f, 0xbf6f5fcd, 0x3f7ff542, 0xbf03fb23, 0x3f7ff95b, 0x3dff915c, - 0x3f7ff7b4, 0x3f2a99b6, 0x3f7ff727, 0x3f7c1b06, 0x3f7ff9d5, 0x3f68bc7d, 0x3f7ff4a2, 0x3ee9e428, - 0x3f7ffba5, 0xbe43c0f3, 0x3f7ff1cd, 0xbf3709d4, 0x3f7ffd25, 0xbf7e8648, 0x3f7feea6, 0xbf610bf3, - 0x3f7ffe54, 0xbecac37b, 0x3f7fd26d, 0x3e48829f, 0x3f7fff32, 0x3f42a634, 0x3f7fd7a0, 0x3f7fcb1a, - 0x3f7fffc0, 0x3f585712, 0x3f7fdc83, 0x3eaab83e, 0x3f7ffffd, 0xbe85c2c7, 0x3f7fe115, 0xbf4d6169, - 0x3f7fffea, 0xbf7fe805, 0x3f7fe557, 0xbf4ea7ef, 0x3f7fff86, 0xbe89e784, 0x3f7fe948, 0x3ea6a983, - 0x3f7ffed1, 0x3f572f07, 0x3f7fece8, 0x3f7fdee4, 0x3f7ffdcb, 0x3f4409bb, 0x3f7ff038, 0x3e50ee85, - 0x3f7ffc75, 0xbec6cf73, 0x3f7ff337, 0xbf6003b9, 0x3f7fface, 0xbf7ebef6, 0x3f7ff5e5, 0xbf3888c0, - 0x3f7ff8d6, 0xbe0d1c50, 0x3f7ff843, 0x3ee60f66, 0x3f7ff68e, 0x3f67d546, 0x3f7ffa50, 0x3f7c7856, - 0x3f7ff3f5, 0x3f2c324d, 0x3f7ffc0c, 0x3d914dbe, 0x3f7ff10b, 0xbf02229c, 0x3f7ffd78, 0xbf6e9aa4, - 0x3f7fedd1, 0xbf790da6, 0x3f7ffe93, 0xbf1f14a7, 0x3f7fd3c0, 0xbd87a157, 0x3f7fff5d, 0x3f10a6fa, - 0x3f7fd8df, 0x3f744bfd, 0x3f7fffd7, 0x3f7482dc, 0x3f7fddae, 0x3f113efb, 0x3f800000, 0xba7bbccf, - 0x3f7fe22c, 0xbf1e8402, 0x3f7fffd8, 0xbf78e2bb, 0x3f7fe65a, 0xbf6edd38, 0x3f7fff60, 0xbf02c148, - 0x3f7fea36, 0x3d8b8e04, 0x3f7ffe97, 0x3f2ba9ab, 0x3f7fedc3, 0x3f792aa8, 0x3f7ffd7d, 0x3f682341, -] )) ), - -################ chunk 19456 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4935c6d7, 0x4937ebc4, 0x49368b31, 0x4938b26f, 0x49374f8a, 0x49397919, 0x493813e4, 0x493a3fc4, - 0x4938d83d, 0x493b066e, 0x49399c97, 0x493bcd18, 0x493a60f0, 0x493c93c3, 0x493b254a, 0x493d5a6d, - 0x493be9a3, 0x493e2118, 0x493cadfd, 0x493ee7c2, 0x493d7256, 0x493fae6d, 0x493e36b0, 0x49407517, - 0x493efb09, 0x49413bc1, 0x493fbf62, 0x4942026c, 0x494083bc, 0x4942c916, 0x49414815, 0x49438fc1, - 0x49420c6f, 0x4944566b, 0x4942d0c8, 0x49451d15, 0x49439522, 0x4945e3c0, 0x4944597b, 0x4946aa6a, - 0x49451dd5, 0x49477115, 0x4945e22e, 0x494837bf, 0x4946a688, 0x4948fe6a, 0x49476ae1, 0x4949c514, - 0x49482f3b, 0x494a8bbe, 0x4948f394, 0x494b5269, 0x4949b7ee, 0x494c1913, 0x494a7c47, 0x494cdfbe, - 0x494b40a1, 0x494da668, 0x494c04fa, 0x494e6d12, 0x494cc954, 0x494f33bd, 0x494d8dad, 0x494ffa67, - 0x494e5207, 0x4950c112, 0x494f1660, 0x495187bc, 0x494fdaba, 0x49524e66, 0x49509f13, 0x49531511, - 0x4951636d, 0x4953dbbb, 0x495227c6, 0x4954a266, 0x4952ec20, 0x49556910, 0x4953b079, 0x49562fbb, - 0x495474d2, 0x4956f665, 0x4955392c, 0x4957bd0f, 0x4955fd85, 0x495883ba, 0x4956c1df, 0x49594a64, - 0x49578638, 0x495a110f, 0x49584a92, 0x495ad7b9, 0x49590eeb, 0x495b9e63, 0x4959d345, 0x495c650e, - 0x495a979e, 0x495d2bb8, 0x495b5bf8, 0x495df263, 0x495c2051, 0x495eb90d, 0x495ce4ab, 0x495f7fb8, - 0x495da904, 0x49604662, 0x495e6d5e, 0x49610d0c, 0x495f31b7, 0x4961d3b7, 0x495ff611, 0x49629a61, - 0x4960ba6a, 0x4963610c, 0x49617ec4, 0x496427b6, 0x4962431d, 0x4964ee60, 0x49630777, 0x4965b50b, - 0x4963cbd0, 0x49667bb5, 0x4964902a, 0x49674260, 0x49655483, 0x4968090a, 0x496618dd, 0x4968cfb5, - 0x4966dd36, 0x4969965f, 0x4967a190, 0x496a5d09, 0x496865e9, 0x496b23b4, 0x49692a43, 0x496bea5e, - 0x4969ee9c, 0x496cb109, 0x496ab2f5, 0x496d77b3, 0x496b774f, 0x496e3e5d, 0x496c3ba8, 0x496f0508, - 0x496d0002, 0x496fcbb2, 0x496dc45b, 0x4970925d, 0x496e88b5, 0x49715907, 0x496f4d0e, 0x49721fb2, - 0x49701168, 0x4972e65c, 0x4970d5c1, 0x4973ad06, 0x49719a1b, 0x497473b1, 0x49725e74, 0x49753a5b, - 0x497322ce, 0x49760106, 0x4973e727, 0x4976c7b0, 0x4974ab81, 0x49778e5a, 0x49756fda, 0x49785505, - 0x49763434, 0x49791baf, 0x4976f88d, 0x4979e25a, 0x4977bce7, 0x497aa904, 0x49788140, 0x497b6fae, - 0x4979459a, 0x497c3659, 0x497a09f3, 0x497cfd03, 0x497ace4d, 0x497dc3ae, 0x497b92a6, 0x497e8a58, - 0x497c5700, 0x497f5103, 0x497d1b59, 0x49800bd6, 0x497ddfb3, 0x49806f2c, 0x497ea40c, 0x4980d281, - 0x497f6865, 0x498135d6, 0x4980165f, 0x4981992b, 0x4980788c, 0x4981fc81, 0x4980dab9, 0x49825fd6, - 0x49813ce6, 0x4982c32b, 0x49819f12, 0x49832680, 0x4982013f, 0x498389d5, 0x4982636c, 0x4983ed2b, - 0x4982c599, 0x49845080, 0x498327c5, 0x4984b3d5, 0x498389f2, 0x4985172a, 0x4983ec1f, 0x49857a7f, - 0x49844e4c, 0x4985ddd5, 0x4984b078, 0x4986412a, 0x498512a5, 0x4986a47f, 0x498574d2, 0x498707d4, - 0x4985d6ff, 0x49876b29, 0x4986392b, 0x4987ce7f, 0x49869b58, 0x498831d4, 0x4986fd85, 0x49889529, - 0x49875fb2, 0x4988f87e, 0x4987c1de, 0x49895bd3, 0x4988240b, 0x4989bf29, 0x49888638, 0x498a227e, - 0x4988e865, 0x498a85d3, 0x49894a91, 0x498ae928, 0x4989acbe, 0x498b4c7e, 0x498a0eeb, 0x498bafd3, - 0x498a7117, 0x498c1328, 0x498ad344, 0x498c767d, 0x498b3571, 0x498cd9d2, 0x498b979e, 0x498d3d28, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ff0fe, 0x3ee758a9, 0x3f7ffc13, 0xbe0a418f, 0x3f7ff3e9, 0xbf3808bf, 0x3f7ffa58, 0xbf7c8d0c, - 0x3f7ff683, 0xbf605cc1, 0x3f7ff84c, 0xbec82321, 0x3f7ff8cd, 0x3e4e1c2d, 0x3f7ff5f0, 0x3f4392ef, - 0x3f7ffac6, 0x3f7ecb48, 0x3f7ff343, 0x3f5792b5, 0x3f7ffc6e, 0x3ec5e75f, 0x3f7ff045, 0xbe88842e, - 0x3f7ffdc6, 0xbf4e3ae1, 0x3f7fcfb2, 0xbf7fe2c6, 0x3f7ffecd, 0xbf4dcf4a, 0x3f7fd50e, 0xbea5bb68, - 0x3f7fff83, 0x3ea95c5a, 0x3f7fda19, 0x3f57f442, 0x3f7fffe9, 0x3f7fd240, 0x3f7fded4, 0x3f431dc9, - 0x3f7ffffe, 0x3e84cfb8, 0x3f7fe33e, 0xbec9709b, 0x3f7fffc2, 0xbf589a44, 0x3f7fe757, 0xbf7e99cb, - 0x3f7fff36, 0xbf378a92, 0x3f7feb20, 0xbe4694cc, 0x3f7ffe58, 0x3ee89bd4, 0x3f7fee98, 0x3f6147d7, - 0x3f7ffd2b, 0x3f7c3ad0, 0x3f7ff1c0, 0x3f2b2308, 0x3f7ffbac, 0x3e02a46f, 0x3f7ff497, 0xbf035cfc, - 0x3f7ff9dd, 0xbf68f0cf, 0x3f7ff71d, 0xbf78b80d, 0x3f7ff7bd, 0xbf1df586, 0x3f7ff952, 0xbd7873c3, - 0x3f7ff54d, 0x3f11d418, 0x3f7ffb37, 0x3f6f8c4f, 0x3f7ff28c, 0x3f741592, 0x3f7ffccb, 0x3f1d00e6, - 0x3f7fcb76, 0xbbd64cea, 0x3f7ffe0f, 0xbf1fa282, 0x3f7fd10f, 0xbf7512b3, 0x3f7fff02, 0xbf6e58bb, - 0x3f7fd657, 0xbf0f1064, 0x3f7fffa4, 0x3d96f401, 0x3f7fdb4e, 0x3f2cb842, 0x3f7ffff5, 0x3f797d96, - 0x3f7fdff5, 0x3f67882b, 0x3f7ffff6, 0x3f007a62, 0x3f7fe44b, 0xbe0fea49, 0x3f7fffa7, 0xbf2d9cc8, - 0x3f7fe850, 0xbf7cc7dc, 0x3f7fff06, 0xbf5fabc5, 0x3f7fec05, 0xbee29f82, 0x3f7ffe15, 0x3e53b417, - 0x3f7fef69, 0x3f39dc1b, 0x3f7ffcd3, 0x3f7eedb8, 0x3f7ff27c, 0x3f56cca1, 0x3f7ffb41, 0x3ec34416, - 0x3f7ff53f, 0xbe8b447f, 0x3f7ff95d, 0xbf45446e, 0x3f7ff7b1, 0xbf7fecac, 0x3f7ff72a, 0xbf562335, - 0x3f7ff9d3, 0xbea306c8, 0x3f7ff4a5, 0x3eac0dd8, 0x3f7ffba3, 0x3f4fc88d, 0x3f7ff1d0, 0x3f7fc392, - 0x3f7ffd23, 0x3f4c3a80, 0x3f7fcce2, 0x3e820ce3, 0x3f7ffe53, 0xbecc1028, 0x3f7fd267, 0xbf595c4f, - 0x3f7fff32, 0xbf7e7299, 0x3f7fd79b, 0xbf41658b, 0x3f7fffc0, 0xbe40f91a, 0x3f7fdc7e, 0x3ece48b6, - 0x3f7ffffd, 0x3f61f49f, 0x3f7fe110, 0x3f7bfb48, 0x3f7fffea, 0x3f35b0dd, 0x3f7fe552, 0x3df9f263, - 0x3f7fff86, 0xbeed4cf9, 0x3f7fe944, 0xbf69878c, 0x3f7ffed2, 0xbf786078, 0x3f7fece4, 0xbf292a00, - 0x3f7ffdcc, 0xbd61a2dd, 0x3f7ff034, 0x3f059f5c, 0x3f7ffc76, 0x3f700c53, 0x3f7ff334, 0x3f73a656, - 0x3f7ffad0, 0x3f1bdf73, 0x3f7ff5e2, 0xbc469043, 0x3f7ff8d9, 0xbf13fda9, 0x3f7ff840, 0xbf757b6a, - 0x3f7ff691, 0xbf73466d, 0x3f7ffa4e, 0xbf004a77, 0x3f7ff3f8, 0x3c8a1011, 0x3f7ffc0a, 0x3f21b0c3, - 0x3f7fc889, 0x3f79ce87, 0x3f7f597e, 0x3f66eb3d, 0x3f7fce4a, 0x3f0cdde7, 0x3f7ffe92, 0xbdac02bf, - 0x3f7fea4a, 0xbf2ea8d1, 0x3f7f6d57, 0xbf7d00aa, 0x3f7fd8da, 0xbf5ef901, 0x3f7fffd7, 0xbefc5ff8, - 0x3f7fe243, 0x3e1a5d3f, 0x3f7f7fee, 0x3f3ad6d4, 0x3f7fe227, 0x3f7f0e1f, 0x3f7fffd9, 0x3f5604d5, - 0x3f7fd8fa, 0x3edde02f, 0x3f7f9142, 0xbe5e068c, 0x3f7fea32, 0xbf462cb3, 0x3f7ffe98, 0xbf7ff488, - 0x3f7fce6e, 0xbf4c1916, 0x3f7fa155, 0xbebe5fba, 0x3f7ff0fb, 0x3e905781, 0x3f7ffc15, 0x3f509d53, - 0x3f7fc29f, 0x3f7fb2da, 0x3f7fb025, 0x3f41413c, 0x3f7ff681, 0x3e9e030c, 0x3f7ff84f, 0xbeb104c3, - 0x3f7fb58e, 0xbf5a1c9f, 0x3f7fbdb3, 0xbf7e4961, 0x3f7ffac4, 0xbf4aa027, 0x3f7ff346, 0xbe79df28, - 0x3f7f51b7, 0x3ed0e53d, 0x3f7fc9ff, 0x3f629f9b, 0x3f7ffdc5, 0x3f7bb9be, 0x3f7fecfb, 0x3f3fa809, -] )) ), - -################ chunk 19968 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x498bf9ca, 0x498da07d, 0x498c5bf7, 0x498e03d2, 0x498cbe24, 0x498e6727, 0x498d2051, 0x498eca7c, - 0x498d827d, 0x498f2dd2, 0x498de4aa, 0x498f9127, 0x498e46d7, 0x498ff47c, 0x498ea904, 0x499057d1, - 0x498f0b30, 0x4990bb26, 0x498f6d5d, 0x49911e7c, 0x498fcf8a, 0x499181d1, 0x499031b7, 0x4991e526, - 0x499093e3, 0x4992487b, 0x4990f610, 0x4992abd0, 0x4991583d, 0x49930f26, 0x4991ba6a, 0x4993727b, - 0x49921c96, 0x4993d5d0, 0x49927ec3, 0x49943925, 0x4992e0f0, 0x49949c7a, 0x4993431d, 0x4994ffd0, - 0x4993a549, 0x49956325, 0x49940776, 0x4995c67a, 0x499469a3, 0x499629cf, 0x4994cbcf, 0x49968d25, - 0x49952dfc, 0x4996f07a, 0x49959029, 0x499753cf, 0x4995f256, 0x4997b724, 0x49965482, 0x49981a79, - 0x4996b6af, 0x49987dcf, 0x499718dc, 0x4998e124, 0x49977b09, 0x49994479, 0x4997dd35, 0x4999a7ce, - 0x49983f62, 0x499a0b23, 0x4998a18f, 0x499a6e79, 0x499903bc, 0x499ad1ce, 0x499965e8, 0x499b3523, - 0x4999c815, 0x499b9878, 0x499a2a42, 0x499bfbcd, 0x499a8c6f, 0x499c5f23, 0x499aee9b, 0x499cc278, - 0x499b50c8, 0x499d25cd, 0x499bb2f5, 0x499d8922, 0x499c1522, 0x499dec77, 0x499c774e, 0x499e4fcd, - 0x499cd97b, 0x499eb322, 0x499d3ba8, 0x499f1677, 0x499d9dd5, 0x499f79cc, 0x499e0001, 0x499fdd22, - 0x499e622e, 0x49a04077, 0x499ec45b, 0x49a0a3cc, 0x499f2688, 0x49a10721, 0x499f88b4, 0x49a16a76, - 0x499feae1, 0x49a1cdcc, 0x49a04d0e, 0x49a23121, 0x49a0af3a, 0x49a29476, 0x49a11167, 0x49a2f7cb, - 0x49a17394, 0x49a35b20, 0x49a1d5c1, 0x49a3be76, 0x49a237ed, 0x49a421cb, 0x49a29a1a, 0x49a48520, - 0x49a2fc47, 0x49a4e875, 0x49a35e74, 0x49a54bca, 0x49a3c0a0, 0x49a5af20, 0x49a422cd, 0x49a61275, - 0x49a484fa, 0x49a675ca, 0x49a4e727, 0x49a6d91f, 0x49a54953, 0x49a73c74, 0x49a5ab80, 0x49a79fca, - 0x49a60dad, 0x49a8031f, 0x49a66fda, 0x49a86674, 0x49a6d206, 0x49a8c9c9, 0x49a73433, 0x49a92d1e, - 0x49a79660, 0x49a99074, 0x49a7f88d, 0x49a9f3c9, 0x49a85ab9, 0x49aa571e, 0x49a8bce6, 0x49aaba73, - 0x49a91f13, 0x49ab1dc9, 0x49a98140, 0x49ab811e, 0x49a9e36c, 0x49abe473, 0x49aa4599, 0x49ac47c8, - 0x49aaa7c6, 0x49acab1d, 0x49ab09f2, 0x49ad0e73, 0x49ab6c1f, 0x49ad71c8, 0x49abce4c, 0x49add51d, - 0x49ac3079, 0x49ae3872, 0x49ac92a5, 0x49ae9bc7, 0x49acf4d2, 0x49aeff1d, 0x49ad56ff, 0x49af6272, - 0x49adb92c, 0x49afc5c7, 0x49ae1b58, 0x49b0291c, 0x49ae7d85, 0x49b08c71, 0x49aedfb2, 0x49b0efc7, - 0x49af41df, 0x49b1531c, 0x49afa40b, 0x49b1b671, 0x49b00638, 0x49b219c6, 0x49b06865, 0x49b27d1b, - 0x49b0ca92, 0x49b2e071, 0x49b12cbe, 0x49b343c6, 0x49b18eeb, 0x49b3a71b, 0x49b1f118, 0x49b40a70, - 0x49b25345, 0x49b46dc6, 0x49b2b571, 0x49b4d11b, 0x49b3179e, 0x49b53470, 0x49b379cb, 0x49b597c5, - 0x49b3dbf8, 0x49b5fb1a, 0x49b43e24, 0x49b65e70, 0x49b4a051, 0x49b6c1c5, 0x49b5027e, 0x49b7251a, - 0x49b564aa, 0x49b7886f, 0x49b5c6d7, 0x49b7ebc4, 0x49b62904, 0x49b84f1a, 0x49b68b31, 0x49b8b26f, - 0x49b6ed5d, 0x49b915c4, 0x49b74f8a, 0x49b97919, 0x49b7b1b7, 0x49b9dc6e, 0x49b813e4, 0x49ba3fc4, - 0x49b87610, 0x49baa319, 0x49b8d83d, 0x49bb066e, 0x49b93a6a, 0x49bb69c3, 0x49b99c97, 0x49bbcd18, - 0x49b9fec3, 0x49bc306e, 0x49ba60f0, 0x49bc93c3, 0x49bac31d, 0x49bcf718, 0x49bb254a, 0x49bd5a6d, - 0x49bb8776, 0x49bdbdc2, 0x49bbe9a3, 0x49be2118, 0x49bc4bd0, 0x49be846d, 0x49bcadfd, 0x49bee7c2, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7f6609, 0x3e36972a, 0x3f7fd508, 0xbeefd411, 0x3f7fff83, 0xbf6a1c6e, 0x3f7fe56d, 0xbf7806e9, - 0x3f7f7918, 0xbf33d235, 0x3f7fdecf, 0xbde4f7e6, 0x3f7ffffe, 0x3f06d6bb, 0x3f7fdc9c, 0x3f708a6e, - 0x3f7f8ae6, 0x3f733528, 0x3f7fe753, 0x3f272c5c, 0x3f7fff36, 0x3d377133, 0x3f7fd289, 0xbf152772, - 0x3f7f9b71, 0xbf75e22d, 0x3f7fee95, 0xbf6d4a0f, 0x3f7ffd2c, 0xbf19c521, 0x3f7fc734, 0x3cb7c339, - 0x3f7faabb, 0x3f22cb9d, 0x3f7ff494, 0x3f7a1d7a, 0x3f7ff9df, 0x3f664c77, 0x3f7fba9c, 0x3f0bac03, - 0x3f7fb8c2, 0xbdb76511, 0x3f7ff950, 0xbf2fb377, 0x3f7ff550, 0xbf7d3772, 0x3f7f49c3, 0xbf6c5e75, - 0x3f7fc587, 0xbef9e2a6, 0x3f7ffcca, 0x3e200296, 0x3f7fef7e, 0x3f3bd00f, 0x3f7f5e8d, 0x3f7f2c7e, - 0x3f7fd109, 0x3f653ad3, 0x3f7fff01, 0x3edb4c33, 0x3f7fe869, 0xbe63998a, 0x3f7f7216, 0xbf471365, - 0x3f7fdb49, 0xbf7ffa5a, 0x3f7ffff5, 0xbf5d0e04, 0x3f7fe012, 0xbebbb811, 0x3f7f845c, 0x3e93149a, - 0x3f7fe446, 0x3f51706f, 0x3f7fffa7, 0x3f7fa018, 0x3f7fd678, 0x3f53e17e, 0x3f7f9561, 0x3e9b4ac8, - 0x3f7fec01, 0xbeb3b24a, 0x3f7ffe16, 0xbf5adb32, 0x3f7fcb9b, 0xbf7e1e21, 0x3f7fa523, 0xbf49bfdd, - 0x3f7ff279, 0xbe7453b4, 0x3f7ffb42, 0x3ed3801b, 0x3f7fbf7d, 0x3f6348c8, 0x3f7fb3a3, 0x3f7f7b9a, - 0x3f7ff7af, 0x3f3eb4d9, 0x3f7ff72c, 0x3e30f735, 0x3f7fb21c, 0xbef25941, 0x3f7fc0e1, 0xbf6aaf71, - 0x3f7ffba2, 0xbf7dd019, 0x3f7ff1d3, 0xbf32cd39, 0x3f7f56e4, 0xbdd99bfc, 0x3f7fccdc, 0x3f080d07, - 0x3f7ffe52, 0x3f71069e, 0x3f7feb37, 0x3f7afefb, 0x3f7f6ae6, 0x3f2616c3, 0x3f7fd795, 0x3d209ba8, - 0x3f7fffbf, 0xbf16500a, 0x3f7fe359, 0xbf7646fa, 0x3f7f7da5, 0xbf770b83, 0x3f7fe10c, 0xbf18a02a, - 0x3f7fffea, 0x3ce574e9, 0x3f7fda39, 0x3f23e52c, 0x3f7f8f23, 0x3f7a6a70, 0x3f7fe940, 0x3f71fa42, - 0x3f7ffed2, 0x3f0a7902, 0x3f7fcfd5, 0xbdc2c5ec, 0x3f7f9f5e, 0xbf30bcb6, 0x3f7ff031, 0xbf7d6c37, - 0x3f7ffc78, 0xbf6bd115, 0x3f7fc430, 0xbef76355, 0x3f7fae57, 0x3e25a6a7, 0x3f7ff5e0, 0x3f3cc7cc, - 0x3f7ff8db, 0x3f7ae878, 0x3f7fb748, 0x3f64971d, 0x3f7fbc0e, 0x3ed8b678, 0x3f7ffa4c, 0xbe692ab7, - 0x3f7ff3fb, 0xbf47f880, 0x3f7f4f0e, 0xbf7dc124, 0x3f7fc882, 0xbf5c54b6, 0x3f7ffd75, 0xbeb90eea, - 0x3f7fedd9, 0x3e95d087, 0x3f7f6388, 0x3f5241e0, 0x3f7fd3b4, 0x3f7f7444, 0x3f7fff5c, 0x3f53136d, - 0x3f7fe673, 0x3e989147, 0x3f7f76c0, 0xbeb65e63, 0x3f7fdda4, 0xbf5b9806, 0x3f800000, 0xbf7fffe1, - 0x3f7fddcc, 0xbf48ddf7, 0x3f7f88b7, 0xbe6ec64e, 0x3f7fe651, 0x3ed61948, 0x3f7fff61, 0x3f63f025, - 0x3f7fd3e2, 0x3f7f635a, 0x3f7f996b, 0x3f3dc025, 0x3f7fedbb, 0x3e2b55d6, 0x3f7ffd80, 0xbef4dc82, - 0x3f7fc8b5, 0xbf5cd478, 0x3f7fa8dd, 0xbf7d9f64, 0x3f7ff3e3, 0xbf31c6d1, 0x3f7ffa5c, 0xbdce3e56, - 0x3f7fbc46, 0x3f09423d, 0x3f7fb70d, 0x3f650803, 0x3f7ff8c8, 0x3f7ab609, 0x3f7ff5f5, 0x3f24ffd6, - 0x3f7f470a, 0x3d09c4d5, 0x3f7fc3fb, 0xbf177770, 0x3f7ffc6b, 0xbf6c329c, 0x3f7ff04c, 0xbf76aaa8, - 0x3f7f5bfd, 0xbf1779fb, 0x3f7fcfa6, 0x3d099263, 0x3f7ffecb, 0x3f24fd6c, 0x3f7fe960, 0x3f724bf9, - 0x3f7f6fae, 0x3f7181ef, 0x3f7fda0e, 0x3f0944e6, 0x3f7fffe8, 0xbdce253b, 0x3f7fe132, 0xbf31c48c, - 0x3f7f821e, 0xbf774d0b, 0x3f7fe335, 0xbf6b41d5, 0x3f7fffc3, 0xbef4e20c, 0x3f7fd7c1, 0x3e2b4966, - 0x3f7f934b, 0x3f3dbe07, 0x3f7feb18, 0x3f7b300a, 0x3f7ffe5b, 0x3f63f195, 0x3f7fcd0d, 0x3ed61f03, -] )) ), - -################ chunk 20480 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x49bd1029, 0x49bf4b17, 0x49bd7256, 0x49bfae6d, 0x49bdd483, 0x49c011c2, 0x49be36b0, 0x49c07517, - 0x49be98dc, 0x49c0d86c, 0x49befb09, 0x49c13bc1, 0x49bf5d36, 0x49c19f17, 0x49bfbf62, 0x49c2026c, - 0x49c0218f, 0x49c265c1, 0x49c083bc, 0x49c2c916, 0x49c0e5e9, 0x49c32c6b, 0x49c14815, 0x49c38fc1, - 0x49c1aa42, 0x49c3f316, 0x49c20c6f, 0x49c4566b, 0x49c26e9c, 0x49c4b9c0, 0x49c2d0c8, 0x49c51d15, - 0x49c332f5, 0x49c5806b, 0x49c39522, 0x49c5e3c0, 0x49c3f74f, 0x49c64715, 0x49c4597b, 0x49c6aa6a, - 0x49c4bba8, 0x49c70dbf, 0x49c51dd5, 0x49c77115, 0x49c58002, 0x49c7d46a, 0x49c5e22e, 0x49c837bf, - 0x49c6445b, 0x49c89b14, 0x49c6a688, 0x49c8fe6a, 0x49c708b5, 0x49c961bf, 0x49c76ae1, 0x49c9c514, - 0x49c7cd0e, 0x49ca2869, 0x49c82f3b, 0x49ca8bbe, 0x49c89168, 0x49caef14, 0x49c8f394, 0x49cb5269, - 0x49c955c1, 0x49cbb5be, 0x49c9b7ee, 0x49cc1913, 0x49ca1a1a, 0x49cc7c68, 0x49ca7c47, 0x49ccdfbe, - 0x49cade74, 0x49cd4313, 0x49cb40a1, 0x49cda668, 0x49cba2cd, 0x49ce09bd, 0x49cc04fa, 0x49ce6d12, - 0x49cc6727, 0x49ced068, 0x49ccc954, 0x49cf33bd, 0x49cd2b80, 0x49cf9712, 0x49cd8dad, 0x49cffa67, - 0x49cdefda, 0x49d05dbc, 0x49ce5207, 0x49d0c112, 0x49ceb433, 0x49d12467, 0x49cf1660, 0x49d187bc, - 0x49cf788d, 0x49d1eb11, 0x49cfdaba, 0x49d24e66, 0x49d03ce6, 0x49d2b1bc, 0x49d09f13, 0x49d31511, - 0x49d10140, 0x49d37866, 0x49d1636d, 0x49d3dbbb, 0x49d1c599, 0x49d43f11, 0x49d227c6, 0x49d4a266, - 0x49d289f3, 0x49d505bb, 0x49d2ec20, 0x49d56910, 0x49d34e4c, 0x49d5cc65, 0x49d3b079, 0x49d62fbb, - 0x49d412a6, 0x49d69310, 0x49d474d2, 0x49d6f665, 0x49d4d6ff, 0x49d759ba, 0x49d5392c, 0x49d7bd0f, - 0x49d59b59, 0x49d82065, 0x49d5fd85, 0x49d883ba, 0x49d65fb2, 0x49d8e70f, 0x49d6c1df, 0x49d94a64, - 0x49d7240c, 0x49d9adb9, 0x49d78638, 0x49da110f, 0x49d7e865, 0x49da7464, 0x49d84a92, 0x49dad7b9, - 0x49d8acbf, 0x49db3b0e, 0x49d90eeb, 0x49db9e63, 0x49d97118, 0x49dc01b9, 0x49d9d345, 0x49dc650e, - 0x49da3572, 0x49dcc863, 0x49da979e, 0x49dd2bb8, 0x49daf9cb, 0x49dd8f0e, 0x49db5bf8, 0x49ddf263, - 0x49dbbe25, 0x49de55b8, 0x49dc2051, 0x49deb90d, 0x49dc827e, 0x49df1c62, 0x49dce4ab, 0x49df7fb8, - 0x49dd46d8, 0x49dfe30d, 0x49dda904, 0x49e04662, 0x49de0b31, 0x49e0a9b7, 0x49de6d5e, 0x49e10d0c, - 0x49decf8b, 0x49e17062, 0x49df31b7, 0x49e1d3b7, 0x49df93e4, 0x49e2370c, 0x49dff611, 0x49e29a61, - 0x49e0583d, 0x49e2fdb6, 0x49e0ba6a, 0x49e3610c, 0x49e11c97, 0x49e3c461, 0x49e17ec4, 0x49e427b6, - 0x49e1e0f0, 0x49e48b0b, 0x49e2431d, 0x49e4ee60, 0x49e2a54a, 0x49e551b6, 0x49e30777, 0x49e5b50b, - 0x49e369a3, 0x49e61860, 0x49e3cbd0, 0x49e67bb5, 0x49e42dfd, 0x49e6df0a, 0x49e4902a, 0x49e74260, - 0x49e4f256, 0x49e7a5b5, 0x49e55483, 0x49e8090a, 0x49e5b6b0, 0x49e86c5f, 0x49e618dd, 0x49e8cfb5, - 0x49e67b09, 0x49e9330a, 0x49e6dd36, 0x49e9965f, 0x49e73f63, 0x49e9f9b4, 0x49e7a190, 0x49ea5d09, - 0x49e803bc, 0x49eac05f, 0x49e865e9, 0x49eb23b4, 0x49e8c816, 0x49eb8709, 0x49e92a43, 0x49ebea5e, - 0x49e98c6f, 0x49ec4db3, 0x49e9ee9c, 0x49ecb109, 0x49ea50c9, 0x49ed145e, 0x49eab2f5, 0x49ed77b3, - 0x49eb1522, 0x49eddb08, 0x49eb774f, 0x49ee3e5d, 0x49ebd97c, 0x49eea1b3, 0x49ec3ba8, 0x49ef0508, - 0x49ec9dd5, 0x49ef685d, 0x49ed0002, 0x49efcbb2, 0x49ed622f, 0x49f02f07, 0x49edc45b, 0x49f0925d, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fa336, 0xbe6eba09, 0x3f7ff1b9, 0xbf33810c, 0x3f7ffbb0, 0xbf7df074, 0x3f7fc117, 0xbf5b99a5, - 0x3f7fb1df, 0xbeb66448, 0x3f7ff718, 0x3e988b41, 0x3f7ff7c2, 0x3f3f5c6e, 0x3f7f3ed9, 0x3f7f8b1d, - 0x3f7fbf46, 0x3f5243ad, 0x3f7ffb33, 0x3e95d68f, 0x3f7ff292, 0xbeb90908, 0x3f7f5445, 0xbf4a5a72, - 0x3f7fcb6a, 0xbf7ffe28, 0x3f7ffe0d, 0xbf47fa78, 0x3f7fec1f, 0xbe693701, 0x3f7f686f, 0x3ed8b0c1, - 0x3f7fd64c, 0x3f546e60, 0x3f7fffa3, 0x3f7f4911, 0x3f7fe46a, 0x3f3cc9ed, 0x3f7f7b57, 0x3e25b31b, - 0x3f7fdfeb, 0xbef75dcf, 0x3f7ffff7, 0xbf5d8c91, 0x3f7fdb72, 0xbf7d6ca9, 0x3f7f8cfe, 0xbf30befe, - 0x3f7fe848, 0xbdc2df0c, 0x3f7fff08, 0x3edd12bd, 0x3f7fd138, 0x3f65aa77, 0x3f7f9d62, 0x3f7a6b17, - 0x3f7fef62, 0x3f23e798, 0x3f7ffcd6, 0x3ce5d9d2, 0x3f7fc5bb, 0xbefb999d, 0x3f7fac84, 0xbf6cbeb0, - 0x3f7ff539, 0xbf7647d6, 0x3f7ff962, 0xbf165298, 0x3f7f367a, 0x3d206938, 0x3f7fba63, 0x3f0c7eb7, - 0x3f7ff9ce, 0x3f72c10a, 0x3f7ff4ab, 0x3f7107af, 0x3f7f4c5f, 0x3f080fb3, 0x3f7fc700, 0xbdd982e4, - 0x3f7ffd21, 0xbf1a8e1a, 0x3f7feeb1, 0xbf77aa93, 0x3f7f6102, 0xbf6ab0b4, 0x3f7fd25b, 0xbef25ed0, - 0x3f7fff30, 0x3e30eac7, 0x3f7fe775, 0x3f27eab2, 0x3f7f7463, 0x3f7b759b, 0x3f7fdc74, 0x3f634a3b, - 0x3f7ffffd, 0x3ed385da, 0x3f7fdef6, 0xbe744773, 0x3f7f8683, 0xbf34850b, 0x3f7fe54a, 0xbf7e1dbf, - 0x3f7fff87, 0xbf5adcd5, 0x3f7fd535, 0xbeb3b833, 0x3f7f9760, 0x3e3a75a1, 0x3f7fecdd, 0x3f404e90, - 0x3f7ffdcf, 0x3f7f9fed, 0x3f7fca31, 0x3f517240, 0x3f7fa6fb, 0x3e931aa5, 0x3f7ff32e, 0xbe7daf32, - 0x3f7ffad4, 0xbf4b399f, 0x3f7f2dee, 0xbf7ffa65, 0x3f7fb553, 0xbf471560, 0x3f7ff83c, 0xbe63a5d8, - 0x3f7ff696, 0x3e9fe1a6, 0x3f7f444c, 0x3f553997, 0x3f7fc26a, 0x3f7f2cbf, 0x3f7ffc07, 0x3f3bd234, - 0x3f7ff115, 0x3e200f0d, 0x3f7f5968, 0xbec032bf, 0x3f7fce3d, 0xbf5e42e5, 0x3f7ffe90, 0xbf7d37e9, - 0x3f7fea52, 0xbf2fb5c2, 0x3f7f6d42, 0xbdb77e33, 0x3f7fd8cf, 0x3edfa582, 0x3f7fffd6, 0x3f664b17, - 0x3f7fe24d, 0x3f7a1e27, 0x3f7f7fda, 0x3f22ce0d, 0x3f7fe21e, 0x3e167983, 0x3f7fffd9, 0xbefe158d, - 0x3f7fd904, 0xbf6d48e0, 0x3f7f9130, 0xbf75e30d, 0x3f7fea2a, 0xbf152a02, 0x3f7ffe9a, 0xbda42ba4, - 0x3f7fce7a, 0x3f0dafd6, 0x3f7fa144, 0x3f73342c, 0x3f7ff0f4, 0x3f708b83, 0x3f7ffc18, 0x3f06d969, - 0x3f7fc2ad, 0x3c5532bd, 0x3f7fb016, 0xbf1bb0fe, 0x3f7ff67c, 0xbf780621, 0x3f7ff853, 0xbf6a1db4, - 0x3f7f3c0c, 0xbeefd9a4, 0x3f7fbda5, 0x3d5dfb92, 0x3f7ffac0, 0x3f28fe0b, 0x3f7ff34c, 0x3f7bb92b, - 0x3f7f51a1, 0x3f62a112, 0x3f7fc9f2, 0x3ed0eb00, 0x3f7ffdc2, 0xbdf82184, 0x3f7fed02, 0xbf35879a, - 0x3f7f65f3, 0xbf7e4903, 0x3f7fd4fd, 0xbf5a1e46, 0x3f7fff81, 0xbeb10aae, 0x3f7fe576, 0x3e40131b, - 0x3f7f7904, 0x3f413f2a, 0x3f7fdec5, 0x3f7fb2b3, 0x3f7ffffe, 0x3f509f27, 0x3f7fdca7, 0x3ecc7b85, - 0x3f7f8ad3, 0xbe819ba1, 0x3f7fe74a, 0xbf4c172e, 0x3f7fff38, 0xbf7ff497, 0x3f7fd295, 0xbf462eb3, - 0x3f7f9b60, 0xbeac7c1a, 0x3f7fee8d, 0x3ea297c6, 0x3f7ffd2f, 0x3f56031a, 0x3f7fc741, 0x3f7f0e65, - 0x3f7faaab, 0x3f3ad8fc, 0x3f7ff48e, 0x3e8bb528, 0x3f7ff9e4, 0xbec2d7d5, 0x3f7f339e, 0xbf5ef774, - 0x3f7fb8b3, 0xbf7d0125, 0x3f7ff94c, 0xbf2eab20, 0x3f7ff555, 0xbe54992f, 0x3f7f49ac, 0x3ee2367e, - 0x3f7fc579, 0x3f66e9e0, 0x3f7ffcc7, 0x3f79cf38, 0x3f7fef85, 0x3f21b335, 0x3f7f5e77, 0x3e10d21f, -] )) ), - -################ chunk 20992 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x49ee2688, 0x49f0f5b2, 0x49ee88b5, 0x49f15907, 0x49eeeae2, 0x49f1bc5c, 0x49ef4d0e, 0x49f21fb2, - 0x49efaf3b, 0x49f28307, 0x49f01168, 0x49f2e65c, 0x49f07395, 0x49f349b1, 0x49f0d5c1, 0x49f3ad06, - 0x49f137ee, 0x49f4105c, 0x49f19a1b, 0x49f473b1, 0x49f1fc48, 0x49f4d706, 0x49f25e74, 0x49f53a5b, - 0x49f2c0a1, 0x49f59db0, 0x49f322ce, 0x49f60106, 0x49f384fb, 0x49f6645b, 0x49f3e727, 0x49f6c7b0, - 0x49f44954, 0x49f72b05, 0x49f4ab81, 0x49f78e5a, 0x49f50dad, 0x49f7f1b0, 0x49f56fda, 0x49f85505, - 0x49f5d207, 0x49f8b85a, 0x49f63434, 0x49f91baf, 0x49f69660, 0x49f97f04, 0x49f6f88d, 0x49f9e25a, - 0x49f75aba, 0x49fa45af, 0x49f7bce7, 0x49faa904, 0x49f81f13, 0x49fb0c59, 0x49f88140, 0x49fb6fae, - 0x49f8e36d, 0x49fbd304, 0x49f9459a, 0x49fc3659, 0x49f9a7c6, 0x49fc99ae, 0x49fa09f3, 0x49fcfd03, - 0x49fa6c20, 0x49fd6059, 0x49face4d, 0x49fdc3ae, 0x49fb3079, 0x49fe2703, 0x49fb92a6, 0x49fe8a58, - 0x49fbf4d3, 0x49feedad, 0x49fc5700, 0x49ff5103, 0x49fcb92c, 0x49ffb458, 0x49fd1b59, 0x4a000bd6, - 0x49fd7d86, 0x4a003d81, 0x49fddfb3, 0x4a006f2c, 0x49fe41df, 0x4a00a0d6, 0x49fea40c, 0x4a00d281, - 0x49ff0639, 0x4a01042c, 0x49ff6865, 0x4a0135d6, 0x49ffca92, 0x4a016781, 0x4a00165f, 0x4a01992b, - 0x4a004776, 0x4a01cad6, 0x4a00788c, 0x4a01fc81, 0x4a00a9a3, 0x4a022e2b, 0x4a00dab9, 0x4a025fd6, - 0x4a010bcf, 0x4a029180, 0x4a013ce6, 0x4a02c32b, 0x4a016dfc, 0x4a02f4d6, 0x4a019f12, 0x4a032680, - 0x4a01d029, 0x4a03582b, 0x4a02013f, 0x4a0389d5, 0x4a023256, 0x4a03bb80, 0x4a02636c, 0x4a03ed2b, - 0x4a029482, 0x4a041ed5, 0x4a02c599, 0x4a045080, 0x4a02f6af, 0x4a04822a, 0x4a0327c5, 0x4a04b3d5, - 0x4a0358dc, 0x4a04e580, 0x4a0389f2, 0x4a05172a, 0x4a03bb09, 0x4a0548d5, 0x4a03ec1f, 0x4a057a7f, - 0x4a041d35, 0x4a05ac2a, 0x4a044e4c, 0x4a05ddd5, 0x4a047f62, 0x4a060f7f, 0x4a04b078, 0x4a06412a, - 0x4a04e18f, 0x4a0672d4, 0x4a0512a5, 0x4a06a47f, 0x4a0543bb, 0x4a06d62a, 0x4a0574d2, 0x4a0707d4, - 0x4a05a5e8, 0x4a07397f, 0x4a05d6ff, 0x4a076b29, 0x4a060815, 0x4a079cd4, 0x4a06392b, 0x4a07ce7f, - 0x4a066a42, 0x4a080029, 0x4a069b58, 0x4a0831d4, 0x4a06cc6e, 0x4a08637e, 0x4a06fd85, 0x4a089529, - 0x4a072e9b, 0x4a08c6d4, 0x4a075fb2, 0x4a08f87e, 0x4a0790c8, 0x4a092a29, 0x4a07c1de, 0x4a095bd3, - 0x4a07f2f5, 0x4a098d7e, 0x4a08240b, 0x4a09bf29, 0x4a085521, 0x4a09f0d3, 0x4a088638, 0x4a0a227e, - 0x4a08b74e, 0x4a0a5428, 0x4a08e865, 0x4a0a85d3, 0x4a09197b, 0x4a0ab77e, 0x4a094a91, 0x4a0ae928, - 0x4a097ba8, 0x4a0b1ad3, 0x4a09acbe, 0x4a0b4c7e, 0x4a09ddd4, 0x4a0b7e28, 0x4a0a0eeb, 0x4a0bafd3, - 0x4a0a4001, 0x4a0be17d, 0x4a0a7117, 0x4a0c1328, 0x4a0aa22e, 0x4a0c44d3, 0x4a0ad344, 0x4a0c767d, - 0x4a0b045b, 0x4a0ca828, 0x4a0b3571, 0x4a0cd9d2, 0x4a0b6687, 0x4a0d0b7d, 0x4a0b979e, 0x4a0d3d28, - 0x4a0bc8b4, 0x4a0d6ed2, 0x4a0bf9ca, 0x4a0da07d, 0x4a0c2ae1, 0x4a0dd227, 0x4a0c5bf7, 0x4a0e03d2, - 0x4a0c8d0e, 0x4a0e357d, 0x4a0cbe24, 0x4a0e6727, 0x4a0cef3a, 0x4a0e98d2, 0x4a0d2051, 0x4a0eca7c, - 0x4a0d5167, 0x4a0efc27, 0x4a0d827d, 0x4a0f2dd2, 0x4a0db394, 0x4a0f5f7c, 0x4a0de4aa, 0x4a0f9127, - 0x4a0e15c1, 0x4a0fc2d1, 0x4a0e46d7, 0x4a0ff47c, 0x4a0e77ed, 0x4a102627, 0x4a0ea904, 0x4a1057d1, - 0x4a0eda1a, 0x4a10897c, 0x4a0f0b30, 0x4a10bb26, 0x4a0f3c47, 0x4a10ecd1, 0x4a0f6d5d, 0x4a111e7c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7fd0fd, 0xbf0047bc, 0x3f7ffeff, 0xbf6dd12d, 0x3f7fe871, 0xbf757c4f, 0x3f7f7201, 0xbf2ce373, - 0x3f7fdb3e, 0xbd98c70f, 0x3f7ffff5, 0x3f0edfd3, 0x3f7fe01b, 0x3f73a55e, 0x3f7f8449, 0x3f700d6c, - 0x3f7fe43d, 0x3f1fd043, 0x3f7fffa8, 0x3bf39247, 0x3f7fd683, 0xbf1cd2a4, 0x3f7f954f, 0xbf785fb5, - 0x3f7febf9, 0xbf6988d7, 0x3f7ffe18, 0xbf120432, 0x3f7fcba8, 0x3d74ccc5, 0x3f7fa513, 0x3f2a100b, - 0x3f7ff273, 0x3f7bfaba, 0x3f7ffb46, 0x3f61f61b, 0x3f7f2b03, 0x3f038f39, 0x3f7fb394, 0xbe01bc29, - 0x3f7ff7aa, 0xbf3688b7, 0x3f7ff731, 0xbf7e7241, 0x3f7f4189, 0xbf595dfa, 0x3f7fc0d3, 0xbee9041d, - 0x3f7ffb9e, 0x3e45af0c, 0x3f7ff1da, 0x3f422e3a, 0x3f7f56ce, 0x3f7fc36f, 0x3f7fccd0, 0x3f4fca65, - 0x3f7ffe50, 0x3ec9dc3a, 0x3f7feb3f, 0xbe845ea1, 0x3f7f6ad1, 0xbf4cf31d, 0x3f7fd78a, 0xbf7fecc0, - 0x3f7fffbf, 0xbf5813ad, 0x3f7fe362, 0xbea9cad4, 0x3f7f7d92, 0x3ea54c9b, 0x3f7fe102, 0x3f56cae9, - 0x3f7fffeb, 0x3f7eee02, 0x3f7fda43, 0x3f4e5d8c, 0x3f7f8f10, 0x3e88f504, 0x3f7fe937, 0xbefed5cf, - 0x3f7ffed4, 0xbf5faa3c, 0x3f7fcfe1, 0xbf7fdac5, 0x3f7f9f4d, 0xbf2d9f19, 0x3f7ff02a, 0xbe4f0189, - 0x3f7ffc7b, 0x3ea9e15a, 0x3f7f223a, 0x3f6786d3, 0x3f7fae47, 0x3f7eb265, 0x3f7d66d1, 0x3f209713, - 0x3f7ff8df, 0x3e0b2993, 0x3f7f3939, 0xbec9f22b, 0x3f7f3150, 0xbf6e5794, 0x3f7ffa48, 0xbf7c6362, - 0x3f7e9118, 0xbf12d547, 0x3f7fa92d, 0xbd8d6143, 0x3f7fc875, 0x3ee9195e, 0x3f7db604, 0x3f74149e, - 0x3f7fede0, 0x3f78f069, 0x3f7f6373, 0x3f0469a0, 0x3f7f012f, 0x3af2f48f, 0x3f7fff5b, 0xbf039976, - 0x3f7ecb54, 0xbf78b74e, 0x3f7f8914, 0xbf745d76, 0x3f7fdd9a, 0xbeeac997, 0x3f7e0037, 0x3d85ce02, - 0x3f7fddd6, 0x3f120e00, 0x3f7f88a4, 0x3f7c3a46, 0x3f7ecc08, 0x3f6eafd4, 0x3f7fff63, 0x3ecbb054, - 0x3f7f008b, 0xbe076687, 0x3f7f63f3, 0xbf1fd996, 0x3f7fedb4, 0xbf7e9977, 0x3f7e4569, 0xbf67ee15, - 0x3f7fc8c2, 0xbeabab70, 0x3f7fa8cd, 0x3e4b496b, 0x3f7d5764, 0x3f2cec41, 0x3f7ffa60, 0x3f7fd222, - 0x3f7f30bc, 0x3f602009, 0x3f7f39ca, 0x3e8adff5, 0x3f7ff8c4, 0xbe872092, 0x3f7e8599, 0xbf3936e2, - 0x3f7faea4, 0xbf7fe2de, 0x3f7fc3ed, 0xbf574eb8, 0x3f7da786, 0xbe52e7a7, 0x3f7ff053, 0x3ea8001e, - 0x3f7f5be7, 0x3f44ab41, 0x3f7f0a9a, 0x3f7ecb97, 0x3f7ffec9, 0x3f4d8456, 0x3f7ec0c6, 0x3e0f1b6a, - 0x3f7f8f7d, 0xbec81d52, 0x3f7fda04, 0xbf4f3c1e, 0x3f7df2aa, 0xbf7c8d90, 0x3f7fe13b, 0xbf42cc35, - 0x3f7f820b, 0xbd955341, 0x3f7ed665, 0x3ee75308, 0x3f7fffc4, 0x3f58dd41, 0x3f7ef6ef, 0x3f792b61, - 0x3f7f6b4e, 0x3f3732bd, 0x3f7feb10, 0x3e818488, 0x3f7e38cd, 0xbf02be92, 0x3f7fcd19, 0xbf618384, - 0x3f7fa326, 0xbf74a8f5, 0x3f7d47ca, 0xbf2ac557, 0x3f7ffbb3, 0xbe3fe434, 0x3f7f2812, 0x3f113c61, - 0x3f7f4217, 0x3f6924e8, 0x3f7ff713, 0x3f6f0b82, 0x3f7e79ee, 0x3f1d9266, 0x3f7fb3ee, 0x3df7c2ba, - 0x3f7fbf38, 0xbf1f122e, 0x3f7d98dc, 0xbf6fb897, 0x3f7ff298, 0xbf685989, 0x3f7f542e, 0xbf0fa92c, - 0x3f7f13d9, 0xbd5d3cdc, 0x3f7ffe0a, 0x3f2c2ff7, 0x3f7eb60c, 0x3f7536f7, 0x3f7f95b9, 0x3f609ac6, - 0x3f7fd641, 0x3f0119c2, 0x3f7de4f0, 0xbc582ea0, 0x3f7fe473, 0xbf388690, 0x3f7f7b44, 0xbf7999ac, - 0x3f7ee094, 0xbf57d831, 0x3f7ffff7, 0xbee3ea01, 0x3f7eed26, 0x3da48ad4, 0x3f7f727c, 0x3f4407b4, - 0x3f7fe83f, 0x3f7cdba4, 0x3f7e2c03, 0x3f4e1beb, 0x3f7fd143, 0x3ec498d6, 0x3f7f9d51, 0xbe16a8be, -] )) ), - -################ chunk 21504 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4a0f9e73, 0x4a115026, 0x4a0fcf8a, 0x4a1181d1, 0x4a1000a0, 0x4a11b37b, 0x4a1031b7, 0x4a11e526, - 0x4a1062cd, 0x4a1216d1, 0x4a1093e3, 0x4a12487b, 0x4a10c4fa, 0x4a127a26, 0x4a10f610, 0x4a12abd0, - 0x4a112726, 0x4a12dd7b, 0x4a11583d, 0x4a130f26, 0x4a118953, 0x4a1340d0, 0x4a11ba6a, 0x4a13727b, - 0x4a11eb80, 0x4a13a425, 0x4a121c96, 0x4a13d5d0, 0x4a124dad, 0x4a14077b, 0x4a127ec3, 0x4a143925, - 0x4a12afd9, 0x4a146ad0, 0x4a12e0f0, 0x4a149c7a, 0x4a131206, 0x4a14ce25, 0x4a13431d, 0x4a14ffd0, - 0x4a137433, 0x4a15317a, 0x4a13a549, 0x4a156325, 0x4a13d660, 0x4a1594d0, 0x4a140776, 0x4a15c67a, - 0x4a14388c, 0x4a15f825, 0x4a1469a3, 0x4a1629cf, 0x4a149ab9, 0x4a165b7a, 0x4a14cbcf, 0x4a168d25, - 0x4a14fce6, 0x4a16becf, 0x4a152dfc, 0x4a16f07a, 0x4a155f13, 0x4a172224, 0x4a159029, 0x4a1753cf, - 0x4a15c13f, 0x4a17857a, 0x4a15f256, 0x4a17b724, 0x4a16236c, 0x4a17e8cf, 0x4a165482, 0x4a181a79, - 0x4a168599, 0x4a184c24, 0x4a16b6af, 0x4a187dcf, 0x4a16e7c6, 0x4a18af79, 0x4a1718dc, 0x4a18e124, - 0x4a1749f2, 0x4a1912ce, 0x4a177b09, 0x4a194479, 0x4a17ac1f, 0x4a197624, 0x4a17dd35, 0x4a19a7ce, - 0x4a180e4c, 0x4a19d979, 0x4a183f62, 0x4a1a0b23, 0x4a187079, 0x4a1a3cce, 0x4a18a18f, 0x4a1a6e79, - 0x4a18d2a5, 0x4a1aa023, 0x4a1903bc, 0x4a1ad1ce, 0x4a1934d2, 0x4a1b0378, 0x4a1965e8, 0x4a1b3523, - 0x4a1996ff, 0x4a1b66ce, 0x4a19c815, 0x4a1b9878, 0x4a19f92c, 0x4a1bca23, 0x4a1a2a42, 0x4a1bfbcd, - 0x4a1a5b58, 0x4a1c2d78, 0x4a1a8c6f, 0x4a1c5f23, 0x4a1abd85, 0x4a1c90cd, 0x4a1aee9b, 0x4a1cc278, - 0x4a1b1fb2, 0x4a1cf422, 0x4a1b50c8, 0x4a1d25cd, 0x4a1b81de, 0x4a1d5778, 0x4a1bb2f5, 0x4a1d8922, - 0x4a1be40b, 0x4a1dbacd, 0x4a1c1522, 0x4a1dec77, 0x4a1c4638, 0x4a1e1e22, 0x4a1c774e, 0x4a1e4fcd, - 0x4a1ca865, 0x4a1e8177, 0x4a1cd97b, 0x4a1eb322, 0x4a1d0a91, 0x4a1ee4cc, 0x4a1d3ba8, 0x4a1f1677, - 0x4a1d6cbe, 0x4a1f4822, 0x4a1d9dd5, 0x4a1f79cc, 0x4a1dceeb, 0x4a1fab77, 0x4a1e0001, 0x4a1fdd22, - 0x4a1e3118, 0x4a200ecc, 0x4a1e622e, 0x4a204077, 0x4a1e9344, 0x4a207221, 0x4a1ec45b, 0x4a20a3cc, - 0x4a1ef571, 0x4a20d577, 0x4a1f2688, 0x4a210721, 0x4a1f579e, 0x4a2138cc, 0x4a1f88b4, 0x4a216a76, - 0x4a1fb9cb, 0x4a219c21, 0x4a1feae1, 0x4a21cdcc, 0x4a201bf7, 0x4a21ff76, 0x4a204d0e, 0x4a223121, - 0x4a207e24, 0x4a2262cb, 0x4a20af3a, 0x4a229476, 0x4a20e051, 0x4a22c621, 0x4a211167, 0x4a22f7cb, - 0x4a21427e, 0x4a232976, 0x4a217394, 0x4a235b20, 0x4a21a4aa, 0x4a238ccb, 0x4a21d5c1, 0x4a23be76, - 0x4a2206d7, 0x4a23f020, 0x4a2237ed, 0x4a2421cb, 0x4a226904, 0x4a245375, 0x4a229a1a, 0x4a248520, - 0x4a22cb31, 0x4a24b6cb, 0x4a22fc47, 0x4a24e875, 0x4a232d5d, 0x4a251a20, 0x4a235e74, 0x4a254bca, - 0x4a238f8a, 0x4a257d75, 0x4a23c0a0, 0x4a25af20, 0x4a23f1b7, 0x4a25e0ca, 0x4a2422cd, 0x4a261275, - 0x4a2453e4, 0x4a26441f, 0x4a2484fa, 0x4a2675ca, 0x4a24b610, 0x4a26a775, 0x4a24e727, 0x4a26d91f, - 0x4a25183d, 0x4a270aca, 0x4a254953, 0x4a273c74, 0x4a257a6a, 0x4a276e1f, 0x4a25ab80, 0x4a279fca, - 0x4a25dc96, 0x4a27d174, 0x4a260dad, 0x4a28031f, 0x4a263ec3, 0x4a2834c9, 0x4a266fda, 0x4a286674, - 0x4a26a0f0, 0x4a28981f, 0x4a26d206, 0x4a28c9c9, 0x4a27031d, 0x4a28fb74, 0x4a273433, 0x4a292d1e, - 0x4a276549, 0x4a295ec9, 0x4a279660, 0x4a299074, 0x4a27c776, 0x4a29c21e, 0x4a27f88d, 0x4a29f3c9, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7d3802, 0xbf4ea612, 0x3f7ffcd9, 0xbf7ef91a, 0x3f7f1f3a, 0xbf437137, 0x3f7f4a36, 0xbea4643f, - 0x3f7ff534, 0x3e5a5dc9, 0x3f7e6e15, 0x3f585563, 0x3f7fb90a, 0x3f7fef9c, 0x3f7fba55, 0x3f37e46c, - 0x3f7d8a05, 0x3e83717c, 0x3f7ff4b1, 0xbe8e8b1c, 0x3f7f4c48, 0xbf610a72, 0x3f7f1ce9, 0xbf7fbe0c, - 0x3f7ffd1e, 0xbf2b82e7, 0x3f7eab24, 0xbe43cd56, 0x3f7f9bc7, 0x3eaf426f, 0x3f7fd250, 0x3f68bb2d, - 0x3f7dd708, 0x3f7e64a4, 0x3f7fe77d, 0x3f1e5afa, 0x3f7f744f, 0x3dffaa67, 0x3f7eea97, 0xbecf2f04, - 0x3f7ffffd, 0xbf6f5eaf, 0x3f7ee32f, 0xbf7be4f3, 0x3f7f797c, 0xbf4046af, 0x3f7fe541, 0xbd6d24bf, - 0x3f7e1f0c, 0x3eee2bed, 0x3f7fd540, 0x3f74ed49, 0x3f7f974e, 0x3f7841dd, 0x3f7d280e, 0x3f347c94, - 0x3f7ffdd1, 0xbc187691, 0x3f7f1635, 0xbf060aa9, 0x3f7f5228, 0xbf79608d, 0x3f7ff327, 0xbf737f99, - 0x3f7e620f, 0xbf27e1af, 0x3f7fbdf9, 0x3d9c99f8, 0x3f7fb544, 0x3f14644b, 0x3f7d7b00, 0x3f7cb357, - 0x3f7ff69b, 0x3f6da3a5, 0x3f7f4435, 0x3f1a8496, 0x3f7f25cd, 0xbe12b7fb, 0x3f7ffc04, 0xbf221245, - 0x3f7ea00f, 0xbf7ee1cd, 0x3f7fa1a8, 0xbf66b4cb, 0x3f7fce31, 0xbf0c74bd, 0x3f7dc8f4, 0x3e56793f, - 0x3f7fea5a, 0x3f2f04c2, 0x3f7f6d2d, 0x3f7fe969, 0x3f7ef46c, 0x3f5ebb0f, 0x3f7fffd5, 0x3efb84d2, - 0x3f7ed90b, 0xbe8ca135, 0x3f7f804e, 0xbf3b2cc9, 0x3f7fe215, 0xbf7fc8fc, 0x3f7e11e8, 0xbf55bfab, - 0x3f7fd90f, 0xbedcfd35, 0x3f7f911e, 0x3ead631c, 0x3f7ebe05, 0x3f467c49, 0x3f7ffe9c, 0x3f7e80a9, - 0x3f7f0d02, 0x3f4bcd02, 0x3f7f59ed, 0x3ebd75f3, 0x3f7ff0ee, 0xbecd5c6f, 0x3f7e55dc, 0xbf50e62e, - 0x3f7fc2ba, 0xbf7c11ed, 0x3f7fb007, 0xbf40ee98, 0x3f7d6bcf, 0xbe9d1386, 0x3f7ff858, 0x3eec6832, - 0x3f7f3bf4, 0x3f5a5e6a, 0x3f7f2e83, 0x3f787f99, 0x3f7ffabc, 0x3f3530fe, 0x3f7e94cd, 0x3e77f6c8, - 0x3f7fa75b, 0xbf05313e, 0x3f7fc9e6, 0xbf62da0b, 0x3f7dbab3, 0xbf73cdce, 0x3f7fed0a, 0xbf28a1ca, - 0x3f7f65de, 0xbe34a7ac, 0x3f7efe13, 0x3f13944e, 0x3f7fff80, 0x3f6a4f3e, 0x3f7eceba, 0x3f7deef1, - 0x3f7f86f4, 0x3f1b4f83, 0x3f7fdebb, 0x3de10f28, 0x3f7e0497, 0xbf214ca6, 0x3f7fdcb1, 0xbf70b565, - 0x3f7f8ac1, 0xbf7b2dbc, 0x3f7ec89e, 0xbf0d4991, 0x3f7fff39, 0xbd2f953b, 0x3f7f03a3, 0x3f2e4a67, - 0x3f7f6184, 0x3f760518, 0x3f7fee86, 0x3f7749f5, 0x3f7e497b, 0x3efd405d, 0x3f7fc74e, 0xbcc77deb, - 0x3f7faa9b, 0xbf3a7e88, 0x3f7d5c70, 0xbf7a3831, 0x3f7ff9e8, 0xbf72481e, 0x3f7f3385, 0xbedec8a1, - 0x3f7f370c, 0x3dbb4fe2, 0x3f7ff947, 0x3f45daed, 0x3f7e895d, 0x3f7d49d7, 0x3f7face1, 0x3f6c2e01, - 0x3f7fc56c, 0x3ebf4f2e, 0x3f7dac44, 0xbe21f3cd, 0x3f7fef8c, 0xbf505270, 0x3f7f5e62, 0xbf7f367a, - 0x3f7f078d, 0xbf6502ae, 0x3f7ffefd, 0xbe9ef86b, 0x3f7ec43c, 0x3e658450, 0x3f7f8d6c, 0x3f59d8f7, - 0x3f7fdb34, 0x3f7ffbe2, 0x3f7df719, 0x3f5cce6e, 0x3f7fe025, 0x3e7bd386, 0x3f7f8436, 0xbe9405a9, - 0x3f7ed309, 0xbf62637b, 0x3f7fffa9, 0xbf7f992b, 0x3f7efa15, 0xbf539ac0, 0x3f7f68ed, 0xbe3892e5, - 0x3f7febf2, 0x3eb49dee, 0x3f7e3cee, 0x3f69e81c, 0x3f7fcbb4, 0x3f7e0ec6, 0x3f7fa502, 0x3f49724a, - 0x3f7d4ce4, 0x3de8f980, 0x3f7ffb4a, 0xbed46542, 0x3f7f2aea, 0xbf705e28, 0x3f7f3f67, 0xbf7b5e7b, - 0x3f7ff7a5, 0xbf3e60ca, 0x3f7e7dc0, 0xbd3f7f69, 0x3f7fb23a, 0x3ef336e4, 0x3f7fc0c6, 0x3f75be24, - 0x3f7d9da8, 0x3f778b68, 0x3f7ff1e0, 0x3f32730f, 0x3f7f56b8, 0xbca7a36c, 0x3f7f10da, 0xbf087795, -] )) ), - -################ chunk 22016 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x4a2829a3, 0x4a2a2574, 0x4a285ab9, 0x4a2a571e, 0x4a288bd0, 0x4a2a88c9, 0x4a28bce6, 0x4a2aba73, - 0x4a28edfc, 0x4a2aec1e, 0x4a291f13, 0x4a2b1dc9, 0x4a295029, 0x4a2b4f73, 0x4a298140, 0x4a2b811e, - 0x4a29b256, 0x4a2bb2c8, 0x4a29e36c, 0x4a2be473, 0x4a2a1483, 0x4a2c161e, 0x4a2a4599, 0x4a2c47c8, - 0x4a2a76af, 0x4a2c7973, 0x4a2aa7c6, 0x4a2cab1d, 0x4a2ad8dc, 0x4a2cdcc8, 0x4a2b09f2, 0x4a2d0e73, - 0x4a2b3b09, 0x4a2d401d, 0x4a2b6c1f, 0x4a2d71c8, 0x4a2b9d36, 0x4a2da372, 0x4a2bce4c, 0x4a2dd51d, - 0x4a2bff62, 0x4a2e06c8, 0x4a2c3079, 0x4a2e3872, 0x4a2c618f, 0x4a2e6a1d, 0x4a2c92a5, 0x4a2e9bc7, - 0x4a2cc3bc, 0x4a2ecd72, 0x4a2cf4d2, 0x4a2eff1d, 0x4a2d25e9, 0x4a2f30c7, 0x4a2d56ff, 0x4a2f6272, - 0x4a2d8815, 0x4a2f941c, 0x4a2db92c, 0x4a2fc5c7, 0x4a2dea42, 0x4a2ff772, 0x4a2e1b58, 0x4a30291c, - 0x4a2e4c6f, 0x4a305ac7, 0x4a2e7d85, 0x4a308c71, 0x4a2eae9c, 0x4a30be1c, 0x4a2edfb2, 0x4a30efc7, - 0x4a2f10c8, 0x4a312171, 0x4a2f41df, 0x4a31531c, 0x4a2f72f5, 0x4a3184c6, 0x4a2fa40b, 0x4a31b671, - 0x4a2fd522, 0x4a31e81c, 0x4a300638, 0x4a3219c6, 0x4a30374e, 0x4a324b71, 0x4a306865, 0x4a327d1b, - 0x4a30997b, 0x4a32aec6, 0x4a30ca92, 0x4a32e071, 0x4a30fba8, 0x4a33121b, 0x4a312cbe, 0x4a3343c6, - 0x4a315dd5, 0x4a337570, 0x4a318eeb, 0x4a33a71b, 0x4a31c001, 0x4a33d8c6, 0x4a31f118, 0x4a340a70, - 0x4a32222e, 0x4a343c1b, 0x4a325345, 0x4a346dc6, 0x4a32845b, 0x4a349f70, 0x4a32b571, 0x4a34d11b, - 0x4a32e688, 0x4a3502c5, 0x4a33179e, 0x4a353470, 0x4a3348b4, 0x4a35661b, 0x4a3379cb, 0x4a3597c5, - 0x4a33aae1, 0x4a35c970, 0x4a33dbf8, 0x4a35fb1a, 0x4a340d0e, 0x4a362cc5, 0x4a343e24, 0x4a365e70, - 0x4a346f3b, 0x4a36901a, 0x4a34a051, 0x4a36c1c5, 0x4a34d167, 0x4a36f36f, 0x4a35027e, 0x4a37251a, - 0x4a353394, 0x4a3756c5, 0x4a3564aa, 0x4a37886f, 0x4a3595c1, 0x4a37ba1a, 0x4a35c6d7, 0x4a37ebc4, - 0x4a35f7ee, 0x4a381d6f, 0x4a362904, 0x4a384f1a, 0x4a365a1a, 0x4a3880c4, 0x4a368b31, 0x4a38b26f, - 0x4a36bc47, 0x4a38e419, 0x4a36ed5d, 0x4a3915c4, 0x4a371e74, 0x4a39476f, 0x4a374f8a, 0x4a397919, - 0x4a3780a1, 0x4a39aac4, 0x4a37b1b7, 0x4a39dc6e, 0x4a37e2cd, 0x4a3a0e19, 0x4a3813e4, 0x4a3a3fc4, - 0x4a3844fa, 0x4a3a716e, 0x4a387610, 0x4a3aa319, 0x4a38a727, 0x4a3ad4c3, 0x4a38d83d, 0x4a3b066e, - 0x4a390954, 0x4a3b3819, 0x4a393a6a, 0x4a3b69c3, 0x4a396b80, 0x4a3b9b6e, 0x4a399c97, 0x4a3bcd18, - 0x4a39cdad, 0x4a3bfec3, 0x4a39fec3, 0x4a3c306e, 0x4a3a2fda, 0x4a3c6218, 0x4a3a60f0, 0x4a3c93c3, - 0x4a3a9206, 0x4a3cc56d, 0x4a3ac31d, 0x4a3cf718, 0x4a3af433, 0x4a3d28c3, 0x4a3b254a, 0x4a3d5a6d, - 0x4a3b5660, 0x4a3d8c18, 0x4a3b8776, 0x4a3dbdc2, 0x4a3bb88d, 0x4a3def6d, 0x4a3be9a3, 0x4a3e2118, - 0x4a3c1ab9, 0x4a3e52c2, 0x4a3c4bd0, 0x4a3e846d, 0x4a3c7ce6, 0x4a3eb618, 0x4a3cadfd, 0x4a3ee7c2, - 0x4a3cdf13, 0x4a3f196d, 0x4a3d1029, 0x4a3f4b17, 0x4a3d4140, 0x4a3f7cc2, 0x4a3d7256, 0x4a3fae6d, - 0x4a3da36c, 0x4a3fe017, 0x4a3dd483, 0x4a4011c2, 0x4a3e0599, 0x4a40436c, 0x4a3e36b0, 0x4a407517, - 0x4a3e67c6, 0x4a40a6c2, 0x4a3e98dc, 0x4a40d86c, 0x4a3ec9f3, 0x4a410a17, 0x4a3efb09, 0x4a413bc1, - 0x4a3f2c1f, 0x4a416d6c, 0x4a3f5d36, 0x4a419f17, 0x4a3f8e4c, 0x4a41d0c1, 0x4a3fbf62, 0x4a42026c, - 0x49bfbf63, 0x49bfbf63, 0x49bfbf63, 0x47f12065, 0x49712065, 0x489965e8, 0x4884ba86, 0x490cebfb, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffe4d, 0xbf649c7d, 0x3f7eb990, 0xbf7299f8, 0x3f7f93b6, 0xbf25b6e6, 0x3f7fd77f, 0x3db360ef, - 0x3f7de96e, 0x3f16b5db, 0x3f7fe36c, 0x3f6bd5ba, 0x3f7f7d7e, 0x3f6c8fe4, 0x3f7edd48, 0x3f183b0a, - 0x3f7fffeb, 0xbe1e04c1, 0x3f7ef05b, 0xbf2445c9, 0x3f7f702a, 0xbf71fe27, 0x3f7fe92f, 0xbf657427, - 0x3f7e3033, 0xbf0a0f14, 0x3f7fcfed, 0x3e61a23e, 0x3f7f9f3c, 0x3f3117af, 0x3f7d3d2c, 0x3f770ea4, - 0x3f7ffc7e, 0x3f5d4efb, 0x3f7f2221, 0x3ef686d1, 0x3f7f4795, 0xbe921d5c, 0x3f7ff5d5, 0xbf3d1cb9, - 0x3f7e71f6, 0xbf7b0154, 0x3f7fb765, 0xbf5429cd, 0x3f7fbbf2, 0xbed7d24b, 0x3f7d8ee0, 0x3eb2c092, - 0x3f7ff407, 0x3f4846fe, 0x3f7f4ee0, 0x3f7dd1a7, 0x3f7f19fa, 0x3f4a0f30, 0x3f7ffd70, 0x3eb8241b, - 0x3f7eaeb7, 0xbed294ff, 0x3f7f99d3, 0xbf528995, 0x3f7fd39d, 0xbf7f7c5c, 0x3f7ddb95, 0xbf3f0ad4, - 0x3f7fe685, 0xbe97a0e8, 0x3f7f7698, 0x3ef175d3, 0x3f7ee759, 0x3f5bd89e, 0x3f800000, 0x3f7fff84, - 0x3f7ee673, 0x3f332979, 0x3f7f7739, 0x3e6cdc99, 0x3f7fe63f, 0xbf079faa, 0x3f7e234b, 0xbf642956, - 0x3f7fd3f8, 0xbf7f5a89, 0x3f7f9948, 0xbf2678dc, 0x3f7d2d46, 0xbe296561, 0x3f7ffd85, 0x3f15e786, - 0x3f7f192a, 0x3f6b721d, 0x3f7f4f96, 0x3f7d8e28, 0x3f7ff3d7, 0x3f1907ac, 0x3f7e65ff, 0x3dca5469, - 0x3f7fbc62, 0xbf2381fa, 0x3f7fb6f0, 0xbf71aa87, 0x3f7d7fea, 0xbf7a9c77, 0x3f7ff600, 0xbf0ae575, - 0x3f7f46db, 0xbd01e802, 0x3f7f22ec, 0x3ef9f77c, 0x3f7ffc65, 0x3f76cb61, 0x3f7ea3b0, 0x3f7688dd, - 0x3f7f9fc3, 0x3ef84523, 0x3f7fcf8e, 0xbd116f15, 0x3f7dcd8f, 0xbf0bb604, 0x3f7fe970, 0xbf7acebd, - 0x3f7f6f85, 0xbf715812, 0x3f7ef13c, 0xbed9a028, 0x3f7fffe7, 0x3dd20ef7, 0x3f7edc5e, 0x3f19ceac, - 0x3f7f7e1a, 0x3f7daff6, 0x3f7fe322, 0x3f6b1016, 0x3f7e1635, 0x3eb9ff6c, 0x3f7fd7d6, 0xbe2d39b3, - 0x3f7f9327, 0xbf273567, 0x3f7d1d33, 0xbf7f6bb7, 0x3f7ffe5f, 0xbf63b82f, 0x3f7f1007, 0xbe998787, - 0x3f7f576a, 0x3e70a386, 0x3f7ff1ac, 0x3f33dab4, 0x3f7e59da, 0x3f800000, 0x3f7fc132, 0x3f5b58da, - 0x3f7fb1c1, 0x3e70bc0e, 0x3f7d70c7, 0xbe997b7d, 0x3f7ff7cc, 0xbf3faff3, 0x3f7f3ea9, 0xbf7f6c24, - 0x3f7f2bb1, 0xbf51fbc7, 0x3f7ffb2c, 0xbe2d5292, 0x3f7e987d, 0x3eb9f3aa, 0x3f7fa585, 0x3f4aa773, - 0x3f7fcb51, 0x3f7db0cf, 0x3f7dbf5d, 0x3f47abcb, 0x3f7fec2f, 0x3dd2412d, 0x3f7f6845, 0xbed994bb, - 0x3f7efaf3, 0xbf54b484, 0x3f7fffa1, 0xbf7ad001, 0x3f7ed21c, 0xbf3c74d3, 0x3f7f84ce, 0xbd11d3f8, - 0x3f7fdfd7, 0x3ef83a1a, 0x3f7e08f3, 0x3f5dcb87, 0x3f7fdb87, 0x3f76cd0e, 0x3f7f8cd9, 0x3f3063da, - 0x3f7d0cf4, 0xbd01831c, 0x3f7fff0b, 0xbf0ae029, 0x3f7f06b6, 0xbf65e1f6, 0x3f7f5f0f, 0xbf71ac9c, - 0x3f7fef54, 0xbf2386d5, 0x3f7e4d89, 0x3dca222e, 0x3f7fc5d5, 0x3f19029d, 0x3f7fac64, 0x3f6cee77, - 0x3f7d6177, 0x3f6b7497, 0x3f7ff96b, 0x3f15eca4, 0x3f7f364a, 0x3daba396, 0x3f7f3449, 0xbf267411, - 0x3f7ff9c6, 0xbf72e8e3, 0x3f7e8d1c, 0xbf642c32, 0x3f7fab1a, 0xbf07a504, 0x3f7fc6e7, 0xbc889225, - 0x3f7db0fd, 0x3f3324f7, 0x3f7feebf, 0x3f77ca50, 0x3f7f60d7, 0x3f5bdbd9, 0x3f7f047c, 0x3ef180f4, - 0x3f7fff2d, 0xbd4f0406, 0x3f7ec7ac, 0xbf3f06a1, 0x3f7f8b55, 0xbf7b8d16, 0x3f7fdc5f, 0xbf528d2b, - 0x3f7dfb84, 0xbed2a080, 0x3f7fdf0a, 0x3df0b0d2, 0x3f7f865d, 0x3f4a0b50, 0x3f7cfc87, 0x3f7e2cde, - 0x3f7fb3df, 0x3f7fb3df, 0x3f7fb3df, 0x3d53e807, 0x3f6a5dc2, 0x3f7ff845, 0x3e9d5619, 0xbe01019a, -] )) ), - -################ chunk 22528 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0x49536e96, 0x492ca22c, 0x4996b43f, 0x4b16b43f, 0x4a3fbf63, 0x4a25e927, 0x4ab026f9, 0x4b04251e, - 0x4ad7cab8, 0x4b3c614f, 0x4cbc614f, 0x4befaf3b, 0x4bcf6371, 0x4c5c30b8, 0x4ca52e66, 0x4c86deb3, - 0x4ceb79a3, 0x4e6b79a3, 0x4d95cd85, 0x4d819e27, 0x4e099e73, 0x4e4e79ff, 0x4e28965f, 0x4e932c06, - 0x50132c06, 0x4f3b40e6, 0x4f2205b0, 0x4fac060f, 0x50010c3f, 0x4fd2bbf7, 0x5037f707, 0x51b7f707, - 0x50ea1120, 0x50ca871c, 0x51570793, 0x51a14f4f, 0x5183b57b, 0x51e5f4c9, 0x5365f4c9, 0x52924ab4, - 0x527d28e4, 0x530664bc, 0x5349a323, 0x5324a2d9, 0x538fb8fe, 0x550fb8fe, 0x5436dd61, 0x541e398e, - 0x54a7fdeb, 0x54fc0bec, 0x54cdcb90, 0x5533a73d, 0x56b3a73d, 0x55e494b9, 0x55c5c7f2, 0x5651fd66, - 0x569d8773, 0x56809f3a, 0x56e0910c, 0x5860910c, 0x578edcf4, 0x577739ee, 0x58033e60, 0x5844e950, - 0x5820c708, 0x588c5aa8, 0x5a0c5aa8, 0x59329431, 0x591a8435, 0x59a40df8, 0x59f623a4, 0x59c8f8ca, - 0x5a2f7151, 0x5baf7152, 0x5adf393d, 0x5ac12542, 0x5b4d1175, 0x5b99d647, 0x5b7b36fd, 0xc39d1463, - 0xc39d1463, 0xc39d1463, 0xc39d1463, 0xc39d1463, 0xc41d1463, 0xc41d1463, 0xc41d1463, 0xc41d1463, - 0xc41d1463, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc46b9e94, 0xc49d1463, 0xc49d1463, - 0xc49d1463, 0xc49d1463, 0xc49d1463, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, 0xc4c4597c, - 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc4eb9e94, 0xc50971d6, 0xc50971d6, 0xc50971d6, - 0xc50971d6, 0xc50971d6, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc51d1463, 0xc530b6ef, - 0xc530b6ef, 0xc530b6ef, 0xc530b6ef, 0xc530b6ef, 0xc544597c, 0xc544597c, 0xc544597c, 0xc544597c, - 0xc544597c, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc557fc08, 0xc56b9e94, 0xc56b9e94, - 0xc56b9e94, 0xc56b9e94, 0xc56b9e94, 0xc57f4121, 0xc57f4121, 0xc57f4121, 0xc57f4121, 0xc57f4121, - 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc58971d6, 0xc593431d, 0xc593431d, 0xc593431d, - 0xc593431d, 0xc593431d, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc59d1463, 0xc5a6e5a9, - 0xc5a6e5a9, 0xc5a6e5a9, 0xc5a6e5a9, 0xc5a6e5a9, 0xc5b0b6ef, 0xc5b0b6ef, 0xc5b0b6ef, 0xc5b0b6ef, - 0xc5b0b6ef, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5ba8835, 0xc5c4597c, 0xc5c4597c, - 0xc5c4597c, 0xc5c4597c, 0xc5c4597c, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, 0xc5ce2ac2, - 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5d7fc08, 0xc5e1cd4e, 0xc5e1cd4e, 0xc5e1cd4e, - 0xc5e1cd4e, 0xc5e1cd4e, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5eb9e94, 0xc5f56fda, - 0xc5f56fda, 0xc5f56fda, 0xc5f56fda, 0xc5f56fda, 0xc5ff4121, 0xc5ff4121, 0xc5ff4121, 0xc5ff4121, - 0xc5ff4121, 0xc6048933, 0xc6048933, 0xc6048933, 0xc6048933, 0xc6048933, 0xc60971d6, 0xc60971d6, - 0xc60971d6, 0xc60971d6, 0xc60971d6, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, 0xc60e5a7a, - 0xc613431d, 0xc613431d, 0xc613431d, 0xc613431d, 0xc613431d, 0xc6182bc0, 0xc6182bc0, 0xc6182bc0, - 0xc6182bc0, 0xc6182bc0, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc61d1463, 0xc621fd06, - 0xc621fd06, 0xc621fd06, 0xc621fd06, 0xc621fd06, 0xc626e5a9, 0xc626e5a9, 0xc626e5a9, 0xc626e5a9, - 0xc626e5a9, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc62bce4c, 0xc630b6ef, 0xc630b6ef, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3e447690, 0xbf79fd4d, 0xbf606bb3, 0xbf24480d, 0x3f7ecfa9, 0x3f7d625f, 0x3d89e781, 0x3de055b4, - 0xbf6432f4, 0x3f075e59, 0xbe812d82, 0x3f5c1c8a, 0x3f18e481, 0x3f2f7ef7, 0x3f78b65d, 0xbc0f0283, - 0xbe8ea22c, 0xbf22817b, 0x3e574846, 0xbf669efe, 0xbe97a01f, 0xbf7c7e21, 0x3f3465fa, 0xbf51c2f3, - 0x3e2e9813, 0xbf14e7f4, 0xbe0fc7b9, 0x3f54a199, 0x3f18bbac, 0x3f3e8d0a, 0xbf7ebf9b, 0x3f33eeda, - 0xbf7f1a49, 0xbe2533ac, 0x3f79f539, 0xbf68e93a, 0x3f791092, 0x3e853016, 0xbf026791, 0x3f2b57ba, - 0xbf19ae4d, 0x3f1e7812, 0x3f5b1166, 0xbf5a3d48, 0xbe964265, 0xbf39c901, 0xbefef1d1, 0x3de84c39, - 0xbf6c9b15, 0x3f46727f, 0x3f1c387e, 0x3f7fff09, 0x3f7fc25a, 0xbf1e9dbe, 0xbdc6dea7, 0xbf67b6bc, - 0xbea67f7c, 0xbf760042, 0x3f3f2084, 0x3f655e48, 0x3f608210, 0x3f5d726c, 0x3f0ab6e7, 0x3ef8484a, - 0x3f06d02e, 0xbe0fdaf1, 0x3edb8f9e, 0x3e975720, 0xbf544b72, 0xbf595591, 0xbeafc1dd, 0xbf3d8e0b, - 0x3ef747b3, 0x3e8db2d7, 0xbf7b4e98, 0xbf7ff202, 0xbebb9bfd, 0xbf2a5c8b, 0xbf3fde49, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, -] )) ), - -################ chunk 23040 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0xc630b6ef, 0xc630b6ef, 0xc630b6ef, 0xc6359f92, 0xc6359f92, 0xc6359f92, 0xc6359f92, 0xc6359f92, - 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63a8835, 0xc63f70d8, 0xc63f70d8, 0xc63f70d8, - 0xc63f70d8, 0xc63f70d8, 0xc644597c, 0xc644597c, 0xc644597c, 0xc644597c, 0xc644597c, 0xc649421f, - 0xc649421f, 0xc649421f, 0xc649421f, 0xc649421f, 0xc64e2ac2, 0xc64e2ac2, 0xc64e2ac2, 0xc64e2ac2, - 0xc64e2ac2, 0xc6531365, 0xc6531365, 0xc6531365, 0xc6531365, 0xc6531365, 0xc657fc08, 0xc657fc08, - 0xc657fc08, 0xc657fc08, 0xc657fc08, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, 0xc65ce4ab, - 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc661cd4e, 0xc666b5f1, 0xc666b5f1, 0xc666b5f1, - 0xc666b5f1, 0xc666b5f1, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc66b9e94, 0xc6708737, - 0xc6708737, 0xc6708737, 0xc6708737, 0xc6708737, 0xc6756fda, 0xc6756fda, 0xc6756fda, 0xc6756fda, - 0xc6756fda, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67a587d, 0xc67f4121, 0xc67f4121, - 0xc67f4121, 0xc67f4121, 0xc67f4121, 0xc68214e2, 0xc68214e2, 0xc68214e2, 0xc68214e2, 0xc68214e2, - 0xc6848933, 0xc6848933, 0xc6848933, 0xc6848933, 0xc6848933, 0xc686fd85, 0xc686fd85, 0xc686fd85, - 0xc686fd85, 0xc686fd85, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68971d6, 0xc68be628, - 0xc68be628, 0xc68be628, 0xc68be628, 0xc68be628, 0xc68e5a7a, 0xc68e5a7a, 0xc68e5a7a, 0xc68e5a7a, - 0xc68e5a7a, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc690cecb, 0xc693431d, 0xc693431d, - 0xc693431d, 0xc693431d, 0xc693431d, 0xc695b76e, 0xc695b76e, 0xc695b76e, 0xc695b76e, 0xc695b76e, - 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc6982bc0, 0xc69aa011, 0xc69aa011, 0xc69aa011, - 0xc69aa011, 0xc69aa011, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69d1463, 0xc69f88b4, - 0xc69f88b4, 0xc69f88b4, 0xc69f88b4, 0xc69f88b4, 0xc6a1fd06, 0xc6a1fd06, 0xc6a1fd06, 0xc6a1fd06, - 0xc6a1fd06, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a47157, 0xc6a6e5a9, 0xc6a6e5a9, - 0xc6a6e5a9, 0xc6a6e5a9, 0xc6a6e5a9, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, 0xc6a959fb, - 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6abce4c, 0xc6ae429e, 0xc6ae429e, 0xc6ae429e, - 0xc6ae429e, 0xc6ae429e, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b0b6ef, 0xc6b32b41, - 0xc6b32b41, 0xc6b32b41, 0xc6b32b41, 0xc6b32b41, 0xc6b59f92, 0xc6b59f92, 0xc6b59f92, 0xc6b59f92, - 0xc6b59f92, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6b813e4, 0xc6ba8835, 0xc6ba8835, - 0xc6ba8835, 0xc6ba8835, 0xc6ba8835, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, 0xc6bcfc87, - 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6bf70d8, 0xc6c1e52a, 0xc6c1e52a, 0xc6c1e52a, - 0xc6c1e52a, 0xc6c1e52a, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c4597c, 0xc6c6cdcd, - 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c6cdcd, 0xc6c9421f, 0xc6c9421f, 0xc6c9421f, 0xc6c9421f, - 0xc6c9421f, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6cbb670, 0xc6ce2ac2, 0xc6ce2ac2, - 0xc6ce2ac2, 0xc6ce2ac2, 0xc6ce2ac2, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, 0xc6d09f13, - 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d31365, 0xc6d587b6, 0xc6d587b6, 0xc6d587b6, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f7ffff9, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, 0x3f7ffff9, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, - 0x3f7ffffb, 0x3f7ffffb, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, - 0x3f7ffffb, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, -] )) ), - -################ chunk 23552 ################ - ( bitcast(float32_t, Vec(uint32_t)( [ - 0xc6d587b6, 0xc6d587b6, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6d7fc08, 0xc6da7059, - 0xc6da7059, 0xc6da7059, 0xc6da7059, 0xc6da7059, 0xc6dce4ab, 0xc6dce4ab, 0xc6dce4ab, 0xc6dce4ab, - 0xc6dce4ab, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6df58fc, 0xc6e1cd4e, 0xc6e1cd4e, - 0xc6e1cd4e, 0xc6e1cd4e, 0xc6e1cd4e, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, 0xc6e441a0, - 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e6b5f1, 0xc6e92a43, 0xc6e92a43, 0xc6e92a43, - 0xc6e92a43, 0xc6e92a43, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6eb9e94, 0xc6ee12e6, - 0xc6ee12e6, 0xc6ee12e6, 0xc6ee12e6, 0xc6ee12e6, 0xc6f08737, 0xc6f08737, 0xc6f08737, 0xc6f08737, - 0xc6f08737, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f2fb89, 0xc6f56fda, 0xc6f56fda, - 0xc6f56fda, 0xc6f56fda, 0xc6f56fda, 0xc6f7e42c, 0x59800000, 0x59800000, 0x59800000, 0x5a000000, - 0x5a000000, 0x59329431, 0x591a8435, 0x58a0c708, 0x40c90fdb, 0x41490fdb, 0x41c90fdb, 0x493fbf56, - 0x4aefaf3a, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x439d1463, 0x441d1463, 0x441d1463, - 0x441d1463, 0x441d1463, 0x441d1463, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, 0x446b9e94, - 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x449d1463, 0x44c4597c, 0x44c4597c, 0x44c4597c, - 0x44c4597c, 0x44c4597c, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x44eb9e94, 0x450971d6, - 0x450971d6, 0x450971d6, 0x450971d6, 0x450971d6, 0x451d1463, 0x451d1463, 0x451d1463, 0x451d1463, - 0x451d1463, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4530b6ef, 0x4544597c, 0x4544597c, - 0x4544597c, 0x4544597c, 0x4544597c, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, 0x4557fc08, - 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x456b9e94, 0x457f4121, 0x457f4121, 0x457f4121, - 0x457f4121, 0x457f4121, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x458971d6, 0x4593431d, - 0x4593431d, 0x4593431d, 0x4593431d, 0x4593431d, 0x459d1463, 0x459d1463, 0x459d1463, 0x459d1463, - 0x459d1463, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45a6e5a9, 0x45b0b6ef, 0x45b0b6ef, - 0x45b0b6ef, 0x45b0b6ef, 0x45b0b6ef, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, 0x45ba8835, - 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45c4597c, 0x45ce2ac2, 0x45ce2ac2, 0x45ce2ac2, - 0x45ce2ac2, 0x45ce2ac2, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45d7fc08, 0x45e1cd4e, - 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45e1cd4e, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, 0x45eb9e94, - 0x45eb9e94, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45f56fda, 0x45ff4121, 0x45ff4121, - 0x45ff4121, 0x45ff4121, 0x45ff4121, 0x46048933, 0x46048933, 0x46048933, 0x46048933, 0x46048933, - 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460971d6, 0x460e5a7a, 0x460e5a7a, 0x460e5a7a, - 0x460e5a7a, 0x460e5a7a, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x4613431d, 0x46182bc0, - 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x46182bc0, 0x461d1463, 0x461d1463, 0x461d1463, 0x461d1463, - 0x461d1463, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4621fd06, 0x4626e5a9, 0x4626e5a9, - 0x4626e5a9, 0x4626e5a9, 0x4626e5a9, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, 0x462bce4c, -] )), bitcast(float32_t, Vec(uint32_t)( [ - 0x3f7ffffd, 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffb, - 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f7ffff8, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, 0x3f7ffffa, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7ffffc, 0x3f7ffffc, 0x3f7ffffc, - 0x3f7ffffc, 0x3f7ffffc, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, 0x3f7ffffd, - 0x3f7ffffd, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7ffffb, 0x3f7ffffb, - 0x3f7ffffb, 0x3f7ffffb, 0x3f7ffffb, 0x3f800000, 0xbef89807, 0xbef89807, 0xbef89807, 0xbf074c8c, - 0xbf074c8c, 0x3e975720, 0xbf544b72, 0xbee4059b, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f3479c1, - 0x3f4e4104, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, 0x3f7ffffe, - 0x3f7ffffe, 0x3f7ffffe, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, - 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f7fffff, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, - 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, 0x3f800000, -] )) ), -] diff --git a/npsr/trig/tests/data/large.py.py b/npsr/trig/tests/data/large.py.py deleted file mode 100644 index 3c3b912..0000000 --- a/npsr/trig/tests/data/large.py.py +++ /dev/null @@ -1,46 +0,0 @@ -from pathlib import Path -from generator import py_array, sollya, pad_list - - -def generate(func, prec): - """Generate a large sin/cos table using Sollya.""" - return sollya( - f""" - prec = {200}; - display = hexadecimal; - procedure trig_func(input) {{ - sc = {prec}(input); - if (sc != infty && sc != -infty) then {{ - print{prec}(sc); - print{prec}({func}(sc)); - }}; - }}; - """, - from_path=Path(__file__).parent / "large.sollya", - ) - - -print("from numpy_sr import Vec, bitcast, float32_t, float64_t, uint32_t, uint64_t\n") - -for func in ["sin", "cos"]: - chunk_size = 512 - for prec, lane, ulane in [ - ("double", "float64_t", "uint64_t"), - ("single", "float32_t", "uint32_t"), - ]: - data = pad_list(generate(func, prec), chunk_size) - print(f"{func}_{lane} = [") - for i in range(0, len(data), chunk_size): - chunk = data[i : i + chunk_size] - print( - f"\n################ chunk {i} ################\n", - "(", - f"bitcast({lane}, Vec({ulane})(", - py_array(chunk[::2], col=8), - ")),", - f"bitcast({lane}, Vec({ulane})(", - py_array(chunk[1::2], col=8), - "))", - "),", - ) - print("]") diff --git a/npsr/trig/tests/data/large.sollya b/npsr/trig/tests/data/large.sollya deleted file mode 100644 index 479acfb..0000000 --- a/npsr/trig/tests/data/large.sollya +++ /dev/null @@ -1,164 +0,0 @@ -// procedure trig_func(input) { -// return printsingle(sin(input)); -// }; - -large_args = [||]; - -// 1. Systematic multiples of pi with perturbations -for k from 100 to 100000 by 100 do { - base = pi * k; - large_args = large_args @ [|base|]; - large_args = large_args @ [|base + 1e-15|]; - large_args = large_args @ [|base - 1e-15|]; - large_args = large_args @ [|base + 1e-12|]; - large_args = large_args @ [|base - 1e-12|]; -}; - -// 2. Systematic multiples of pi/2 with perturbations -for k from 100 to 100000 by 137 do { - base = pi/2 * k; - large_args = large_args @ [|base|]; - large_args = large_args @ [|base + 1e-15|]; - large_args = large_args @ [|base - 1e-15|]; - large_args = large_args @ [|base + 1e-14|]; - large_args = large_args @ [|base - 1e-14|]; -}; - -// 3. Powers of 2 and nearby values (floating point boundaries) -for e from 10 to 50 do { - base = 2^e; - large_args = large_args @ [|base|]; - large_args = large_args @ [|base + 1|]; - large_args = large_args @ [|base - 1|]; - large_args = large_args @ [|base + 0.5|]; - large_args = large_args @ [|base - 0.5|]; -}; - -// 4. Powers of 10 ranges -for e from 3 to 18 do { - base = 10^e; - large_args = large_args @ [|base|]; - large_args = large_args @ [|base * 1.1|]; - large_args = large_args @ [|base * 0.9|]; - large_args = large_args @ [|base + 1|]; - large_args = large_args @ [|base - 1|]; -}; - -// 5. Fibonacci-like sequences (often problematic for range reduction) -fib_scale = [|1, 1|]; // Reset -for i from 2 to 20 do { - next_fib = fib_scale[i-1] + fib_scale[i-2]; - fib_scale = fib_scale @ [|next_fib|]; - large_args = large_args @ [|next_fib * 1000|]; - large_args = large_args @ [|next_fib * 10000|]; - -}; - -// 6. Prime number scales (irregular patterns) -primes = [|101, 103, 107, 109, 113, 127, 131, 137, 139, 149, 151, 157, 163, 167, 173, 179, - 181, 191, 193, 197, 199, 211, 223, 227, 229, 233, 239, 241, 251, 257, 263, 269, - 271, 277, 281, 283, 293, 307, 311, 313, 317, 331, 337, 347, 349, 353, 359, 367|]; -for i from 0 to length(primes) - 1 do { - p = primes[i]; - large_args = large_args @ [|p * 1000|]; - large_args = large_args @ [|p * 10000|]; - large_args = large_args @ [|p * 100000|]; - large_args = large_args @ [|p * pi|]; - large_args = large_args @ [|p * pi/2|]; -}; - -// 7. Arguments near IEEE 754 double precision limits -large_args = large_args @ [|1.7976931348623157e+308 / 2|]; // Near max double / 2 -large_args = large_args @ [|1e308|]; -large_args = large_args @ [|1e307|]; -large_args = large_args @ [|1e306|]; - -// 8. Machine epsilon scaled values (precision boundaries) -eps = 2.220446049250313e-16; // double precision machine epsilon -for scale from 12 to 20 do { - base = 2^scale; - large_args = large_args @ [|base + eps * base|]; - large_args = large_args @ [|base - eps * base|]; - large_args = large_args @ [|base + eps * base * 2|]; - large_args = large_args @ [|base - eps * base * 2|]; -}; - -// 9. Transcendental number multiples -large_args = large_args @ [|exp(1) * 1e6|]; // e * 1M -large_args = large_args @ [|exp(1) * 1e7|]; // e * 10M -large_args = large_args @ [|exp(1) * 1e8|]; // e * 100M -large_args = large_args @ [|sqrt(2) * 1e6|]; // sqrt(2) * 1M -large_args = large_args @ [|sqrt(2) * 1e7|]; // sqrt(2) * 10M -large_args = large_args @ [|log(2) * 1e8|]; // ln(2) * 100M -large_args = large_args @ [|log(10) * 1e7|]; // ln(10) * 10M - -// 10. Arguments designed to stress specific range reduction algorithms -// Cody-Waite constants and their problematic neighbors -cody_waite_pi_hi = 3.1415926218032837; -cody_waite_pi_lo = 3.1786509424591227e-08; -for scale from 1000 to 1000000 by 1000 do { - large_args = large_args @ [|cody_waite_pi_hi * scale|]; - large_args = large_args @ [|cody_waite_pi_lo * scale * 1e8|]; -}; - -// 11. Payne-Hanek problematic arguments -// Arguments where naive range reduction fails -large_args = large_args @ [|0x1.921fb54442d18p+0 * 1e6|]; // pi with specific bit pattern -large_args = large_args @ [|0x1.921fb54442d19p+0 * 1e6|]; // pi + 1 ulp -large_args = large_args @ [|0x1.921fb54442d17p+0 * 1e6|]; // pi - 1 ulp - -// 12. Random large values in different ranges -for e from 6 to 17 do { - base = 10^e; - // Add some pseudo-random values in each range - large_args = large_args @ [|base * 0.123456789|]; - large_args = large_args @ [|base * 0.987654321|]; - large_args = large_args @ [|base * 0.314159265|]; - large_args = large_args @ [|base * 0.271828182|]; - large_args = large_args @ [|base * 0.577215664|]; // Euler-Mascheroni constant - large_args = large_args @ [|base * 0.866025403|]; // sqrt(3)/2 - large_args = large_args @ [|base * 0.707106781|]; // sqrt(2)/2 -}; - -// 13. Negative versions of all critical ranges -neg_critical = [||]; -for i from 0 to min(500, length(large_args) - 1) do { - neg_critical = neg_critical @ [|-large_args[i]|]; -}; -large_args = large_args @ neg_critical; - -// 14. Arguments that expose specific algorithmic weaknesses -// Values near 2^52 (where double precision integer representation changes) -large_args = large_args @ [|4503599627370496.0|]; // 2^52 -large_args = large_args @ [|4503599627370497.0|]; // 2^52 + 1 -large_args = large_args @ [|4503599627370495.0|]; // 2^52 - 1 -large_args = large_args @ [|9007199254740992.0|]; // 2^53 -large_args = large_args @ [|9007199254740991.0|]; // 2^53 - 1 - -// 15. Additional stress test values -stress_values = [| - // Mathematical constants scaled up - pi * 1e15, exp(1) * 1e15, sqrt(2) * 1e15, - - // Values that have caused issues in other implementations - 6.2831853071795864769, // 2*pi with specific precision - 12.566370614359172954, // 4*pi - 25.132741228718345908, // 8*pi - - // Large odd multiples of pi/4 - pi/4 * 999999, pi/4 * 9999999, - - // Values near overflow in intermediate calculations - 1e154, 1e155, 1e156, - - // Challenging values for specific processor architectures - 0x1.fffffffffffffp+1023, // Near max normal double - 0x1.fffffffffffffp+1022 -|]; - -large_args = large_args @ stress_values; -num_cases = length(large_args) - 1; -for i from 0 to num_cases do { - arg = large_args[i]; - trig_func(arg); -}; diff --git a/npsr/trig/tests/test_sincos.py b/npsr/trig/tests/test_sincos.py deleted file mode 100644 index 6c18522..0000000 --- a/npsr/trig/tests/test_sincos.py +++ /dev/null @@ -1,26 +0,0 @@ -from pytest import mark -from numpy_sr import Precise -from .data import large as large_data - - -@mark.parametrize( - "prec, max_ulp", - [ - (Precise(), 1), - (Precise(kLowAccuracy=True), 4), - ], -) -class TestSinCos: - @mark.parametrize("lane_str", ["float64_t", "float32_t"]) - def test_sin_stress(self, prec, max_ulp, lane_str): - data = getattr(large_data, f"sin_{lane_str}") - for input, expected in data: - actual = Sin(prec, input) - assert_ulp(actual, expected, input, max_ulp=max_ulp) - - @mark.parametrize("lane_str", ["float64_t", "float32_t"]) - def test_cos_stress(self, prec, max_ulp, lane_str): - data = getattr(large_data, f"cos_{lane_str}") - for input, expected in data: - actual = Cos(prec, input) - assert_ulp(actual, expected, input, max_ulp=max_ulp) diff --git a/npsr/utils-inl.h b/npsr/utils-inl.h index 919b3bd..59cbdae 100644 --- a/npsr/utils-inl.h +++ b/npsr/utils-inl.h @@ -11,11 +11,10 @@ HWY_BEFORE_NAMESPACE(); namespace npsr::HWY_NAMESPACE { -using namespace hwy; -using namespace hwy::HWY_NAMESPACE; -template >, typename V = Vec> +template >, typename V = VFromD> HWY_API V LutX2(const T *lut, VU idx) { + using namespace hn; D d; return GatherIndex(d, lut, BitCast(RebindToSigned(), idx)); #if 0 diff --git a/pyproject.toml b/pyproject.toml index a80cbdb..f5fc80e 100644 --- a/pyproject.toml +++ b/pyproject.toml @@ -37,22 +37,5 @@ package = 'numpy_sr' [tool.spin.commands] "Build" = [ - ".spin/cmds.py:test", - ".spin/cmds.py:build", ".spin/cmds.py:generate", ] -"Environments" = [ - "spin.cmds.meson.run", - ".spin/cmds.py:ipython", - ".spin/cmds.py:python", - "spin.cmds.meson.gdb", - "spin.cmds.meson.lldb" -] -# "Documentation" = [ -# ".spin/cmds.py:docs", -# ".spin/cmds.py:changelog", -# ".spin/cmds.py:notes", -# ".spin/cmds.py:check_docs", -# ".spin/cmds.py:check_tutorials", -# ] -# "Metrics" = [".spin/cmds.py:bench"] diff --git a/tools/__init__.py b/tools/__init__.py deleted file mode 100644 index e69de29..0000000 diff --git a/tools/generator.py b/tools/generator.py deleted file mode 100644 index c5aac49..0000000 --- a/tools/generator.py +++ /dev/null @@ -1,181 +0,0 @@ -#!/usr/bin/env python3 - -import subprocess -import textwrap -import tempfile -import os -import re -import pathlib -import glob -import runpy -import sys -import inspect -from itertools import chain - -curdir = pathlib.Path(__file__).parent -rootdir = curdir.parent -sys.path.insert(0, str(curdir)) - - -def sollya(expr, as_int=None, from_path=None, dump=False, encoding="utf-8"): - """Sollya wrapper with comprehensive message filtering using temp file""" - expr = textwrap.dedent(expr).strip() - # Create temporary file - with tempfile.NamedTemporaryFile( - mode="w", suffix=".sollya", delete=False, encoding=encoding - ) as f: - f.write(expr + "\n") - if from_path: - with open(from_path, "r", encoding=encoding) as rf: - f.write(rf.read().strip()) - f.write("\n") - temp_file = f.name - - try: - # Execute Sollya with temp file - result = subprocess.run(["sollya", temp_file], capture_output=True, text=True) - if dump: - with open(temp_file, "r") as f: - raise TypeError(f.read() + "-" * 20 + result.stdout.strip()) - # Define patterns to filter out - ignore_patterns = [ - r"^Warning", # Warnings - r"^The precision has been set", # Precision messages - r"^Display mode is ", # Default precision messages - r"^\s*$", # Empty lines - ] - - lines = result.stdout.strip().split("\n") - filtered = [] - - for line in lines: - line = line.strip() - if line: - # Check if line matches any ignore pattern - should_ignore = any( - re.match(pattern, line) for pattern in ignore_patterns - ) - if not should_ignore: - filtered.append(line) - if as_int: - return [int(num, base=as_int) for num in filtered] - return filtered - - finally: - # Clean up temp file - os.unlink(temp_file) - - -def c_header(*lines, namespace, inspect_idx=1): - """Generate C++ header with optional namespace""" - caller_frame = inspect.stack()[inspect_idx] - caller_filepath = caller_frame.filename - file = pathlib.Path(caller_filepath).resolve() - rfile = str(file.relative_to(rootdir)) - guard_name = rfile.upper().replace("/", "_").replace(".", "_").replace("-", "_") - header = [ - f"// Do not edit this file, it is generated by {rfile}", - "// use `spin generate -f` to force regeneration", - f"#ifndef {guard_name}", - f"#define {guard_name}", - ] - header.extend([f"namespace {namespace} {{ namespace {{"]) - header.extend(lines) - header.append("}} // namespace {namespace}") - header.append(f"#endif // {guard_name}") - return "\n".join(header) - - -def array(data, col, sfx, indent, start, end): - """Generate a nicely aligned C-style array.""" - # Convert all values to strings with suffix - str_data = [f"{x}{sfx}," for x in data] - str_data = ["0.0f," if s == "0f," else s for s in str_data] - # Determine the max width for each value (for alignment) - width = max(len(s) for s in str_data) - pad = " " * indent - lines = [] - for i in range(0, len(str_data), col): - chunk = str_data[i : i + col] - line = " ".join(s.ljust(width) for s in chunk) - lines.append(pad + line) - - return start + "\n" + "\n".join(lines) + "\n" + end - - -def py_array(data, col=8, sfx="", indent=4): - return array(data, col, sfx, indent, "[", "]") - - -def c_array(data, col=8, sfx="", indent=4): - return array(data, col, sfx, indent, "{", "};") - - -def main(force): - path = rootdir / "npsr" - patterns = (f"{path}/**/data/*.h.py", f"{path}/**/data/*.py.py") - files = list(chain.from_iterable(glob.glob(p, recursive=True) for p in patterns)) - - for f in files: - out = f.replace(".h.py", ".h").replace(".py.py", ".py") - - # check if the file exists - if not force and pathlib.Path(out).exists(): - print(f"Skipping {out}, file already exists") - continue - - print(f"Generating {out} from {f}") - with open(out, "w") as fd: - old_stdout = sys.stdout - sys.stdout = fd - try: - runpy.run_path(f) - finally: - sys.stdout = old_stdout - - -def pad_list(data, pad_length=512): - """ - Pad a list to make its length a multiple of pad_length by repeating elements from the list itself. - - Required because the C++ testing unit validates: - - Array size must be >= lane count - - Array size must be divisible by lane count - - Without padding, arrays get rejected with: - "each array size must be aligned and >= its lane count" - - Args: - data (list): Input list to be padded - pad_length (int): Required alignment boundary (default: 512) - - Returns: - list: Padded list that passes C++ validation - """ - if not data: - return data - - length = len(data) - remainder = length % pad_length - if remainder != 0: - padding_needed = pad_length - remainder - # Repeat the list cyclically - padding = (data * ((padding_needed // length) + 1))[:padding_needed] - data.extend(padding) - return data - - -if __name__ == "__main__": - import argparse - - parser = argparse.ArgumentParser( - description="Generate C++ headers/python templates from Python scripts." - ) - parser.add_argument( - "-f", - "--force", - action="store_true", - help="Force regenerate all files, even if they already exist.", - ) - args = parser.parse_args() - main(force=args.force) diff --git a/tools/sollya/core.sol b/tools/sollya/core.sol new file mode 100644 index 0000000..66ac25b --- /dev/null +++ b/tools/sollya/core.sol @@ -0,0 +1,311 @@ +prec = 512; +display = hexadecimal; +verbosity = 3; +showmessagenumbers = on; + +THE_OUTPUT_LINES = [||]; +THE_DISPLAY_STACK = [||]; +THE_PREC_STACK = [||]; + +Float32 = { + .kName = "float32", + .kSize = 32, + .kExpBits = 8, + .kMantBits = 23, + .kDigits = 24, + .kDigits10 = 6, + .kMaxDigits10 = 9, + .kMinExp = -126, + .kMinExp10 = -37, + .kBias = 127, + .kMaxExp10 = 38, + .kMinExpDenorm = -149, + .kMaxExpBiased = 254, + .kMin = 0x1p-126, + .kLowest = -0x1.fffffep127, + .kMax = 0x1.fffffep127, + .kEps = 0x1p-23, + .kDenormMin = 0x1p-149, + .kPyName = "float32_t", + .kCSFX = "f", + .kCName = "float", + .kCUint = "uint32_t", + .kCUintSFX = "u", + .kRound = single(x), + .kRoundStr = "single", + .kPrintDigits = "printsingle" +}; + +Float64 = { + .kName = "float64", + .kSize = 64, + .kExpBits = 11, + .kMantBits = 52, + .kDigits = 53, + .kDigits10 = 15, + .kMaxDigits10 = 17, + .kMinExp = -1022, + .kMinExp10 = -307, + .kBias = 1023, + .kMaxExp10 = 308, + .kMinExpDenorm = -1074, + .kMaxExpBiased = 2046, + .kMin = 0x1p-1022, + .kLowest = -0x1.fffffffffffffp1023, + .kMax = 0x1.fffffffffffffp1023, + .kEps = 0x1p-52, + .kDenormMin = 0x1p-1074, + .kPyName = "float64_t", + .kCSFX = "", + .kCName = "double", + .kCUint = "uint64_t", + .kCUintSFX = "ull", + .kRound = double(x), + .kRoundStr = "double", + .kPrintDigits = "printdouble" +}; + +procedure RightShift(pN, pK) { + return floor(pN / 2^pK); +}; + +procedure LeftShift(pN, pK) { + return pN * 2^pK; +}; + +procedure Join(pList, pSep) { + var r, i, v; + r = ""; + for i in pList do { + v = i @ pSep; + r = r @ v; + }; + return r; +}; + +procedure PyEval(pCode = ...) { + var code; + write(Join(pCode, "\n")) > PYTEMP_FILE_PATH; + code = bashevaluate("python3 " @ PYTEMP_FILE_PATH); + return code; +}; + +procedure SolEval(pCode = ...) { + var code; + write(Join(pCode, "\n") @ "quit;") > PYTEMP_FILE_PATH; + code = bashevaluate("sollya " @ PYTEMP_FILE_PATH); + return code; +}; + +procedure ToDigits(pT, pA) { + var i, code, prfunc, $; + code = ""; + prfunc = pT.kPrintDigits @ "("; + for i in pA do { + code = code @ (prfunc @ i @ ");"); + }; + $.hex = SolEval(code); + $.ints = PyEval( + "x = '''", + $.hex, + "'''", + "x = [str(int(l, base=0x10)) for l in x.splitlines() if l.strip()]", + "print('[|', ', '.join(x), '|];')" + ); + return parse($.ints); +}; + +procedure FromDigits(pT, pA) { + var i, code, $; + SetDisplay(decimal); + $.hex = PyEval( + "x = (", + ToStringPyArray(pA, 8), + ")", + "rstr = '" @ pT.kRoundStr @ "'", + "pad = '0" @ pT.kSize / 4 @ "x'", + "x = [f'{rstr}(0x{format(l, pad)})' for l in x]", + "print('[|', ', '.join(x), '|];')" + ); + RestoreDisplay(); + return parse($.hex); +}; + +procedure ToStringArray(pData, pSFX, pColNum) { + var r, r_final, i, j, col_widths, $; + r = [||]; + for i from 0 to length(pData) - 1 do { + $.v = pData[i] @ pSFX @ ", "; + if ($.v == "0f, ") then $.v = "0.0f, "; + r = r :. $.v; + }; + // Determine the max width for each column + col_widths = [||]; + for i from 0 to pColNum - 1 do { + col_widths = col_widths :. 0; + }; + for i from 0 to length(r) - 1 do { + $.idx = mod(i, pColNum); + if (length(r[i]) > col_widths[$.idx]) then { + col_widths[$.idx] = length(r[i]); + }; + }; + + // Create paddding string + $.pad = ""; + for i from 1 to 2 do $.pad = $.pad @ " "; + + // Build lines array + r_final = ""; + i = 0; + while (i < length(r)) do { + var chunks, chunk, line; + // Create chunk of 'col' elements + chunks = [||]; + for j from 0 to pColNum - 1 do { + if (i + j < length(r)) then { + chunks = chunks :. r[i + j]; + }; + }; + line = $.pad; + for j from 0 to length(chunks) - 1 do { + $.idx = mod(i + j, pColNum); + chunk = chunks[j]; + // Left-justify to width + while (length(chunk) < col_widths[$.idx]) do { + chunk = chunk @ " "; + }; + line = line @ chunk; + }; + r_final = r_final @ line @ "\n"; + i = i + pColNum; + }; + return r_final; +}; + +procedure ToStringCArray(pArr, pSFX, pNumCol) { + return "{\n" @ ToStringArray(pArr, pSFX, pNumCol) @ "};"; +}; + +procedure ToStringPyArray(pArr, pNumCol) { + return "[\n" @ ToStringArray(pArr, "", pNumCol) @ "]"; +}; + +procedure ConstantsFromArray(pArr) { + var r, i, j, $; + r = [||]; + $.exact = head(pArr); + $.remainder = 0; + for i in tail(pArr) do { + $.r_mod = head(i); + for j in tail(i) do { + $.val = round($.exact - $.remainder, j, $.r_mod); + $.remainder = $.remainder + $.val; + r = r :. $.val; + }; + }; + return r; +}; +procedure Constants(pArgs = ...) { + return ConstantsFromArray(pArgs); +}; + +procedure Append(pLines = ...) { + suppressmessage(56); + THE_OUTPUT_LINES = THE_OUTPUT_LINES @ pLines; + unsuppressmessage(56); +}; + +procedure SetDisplay(pMod) { + suppressmessage(56); + THE_DISPLAY_STACK = display .: THE_DISPLAY_STACK; + unsuppressmessage(56); + display = pMod; +}; + +procedure RestoreDisplay() { + Assert( + length(THE_DISPLAY_STACK) > 0, + "Display stack is empty, cannot restore display." + ); + display = head(THE_DISPLAY_STACK); + suppressmessage(56); + if (length(THE_DISPLAY_STACK) == 1) then { + THE_DISPLAY_STACK = [||]; + } else { + THE_DISPLAY_STACK = tail(THE_DISPLAY_STACK); + }; + unsuppressmessage(56); +}; + +procedure SetPrec(pPrec) { + suppressmessage(56); + THE_PREC_STACK = prec .: THE_PREC_STACK; + unsuppressmessage(56); + prec = pPrec; +}; + +procedure RestorePrec() { + Assert( + length(THE_PREC_STACK) > 0, + "Prec stack is empty, cannot restore prec." + ); + prec = head(THE_PREC_STACK); + suppressmessage(56); + if (length(THE_PREC_STACK) == 1) then { + THE_PREC_STACK = [||]; + } else { + THE_PREC_STACK = tail(THE_PREC_STACK); + }; + unsuppressmessage(56); +}; + +procedure Assert(pCondition, pMessage) { + if (!pCondition) then { + "Assertion failed: " @ pMessage; + PyEval( + "import os, signal; from pathlib import Path;", + "Path('" @OUTPUT_FILE_PATH@ "').unlink(missing_ok=True)", + "os.kill(os.getppid(), signal.SIGKILL)" + ); + }; +}; + +procedure Dump() { + var i; + for i in THE_OUTPUT_LINES do { + i; + }; + Assert(false, "Dump"); +}; + +procedure Write() { + write(Join(THE_OUTPUT_LINES, "\n")) > OUTPUT_FILE_PATH; + suppressmessage(56); + THE_OUTPUT_LINES = [||]; + unsuppressmessage(56); +}; + +procedure WriteCPPHeader(pNamespace = ...) { + var i, $; + $.pre = [| + "// Auto-generated by " @ SOURCE_FILE_PATH, + "// Use `spin generate -f` to force regeneration", + "#ifndef " @ SOURCE_GUARD_NAME, + "#define " @ SOURCE_GUARD_NAME, + "" + |]; + $.post = [||]; + for i in pNamespace do { + vNamespace = "namespace " @ i; + $.pre = $.pre :. (vNamespace @ " {"); + $.post = $.post :. ("} // " @ vNamespace); + }; + $.post = $.post @ [| + "", + "#endif // " @ SOURCE_GUARD_NAME + |]; + Append @ ($.pre @ THE_OUTPUT_LINES @ $.post); + Write(); +}; + diff --git a/tools/sollya/generate.py b/tools/sollya/generate.py new file mode 100644 index 0000000..c2f8738 --- /dev/null +++ b/tools/sollya/generate.py @@ -0,0 +1,89 @@ +#!/usr/bin/env python3 +import subprocess +import tempfile +import os +import pathlib +import glob +import sys +from itertools import chain + +curdir = pathlib.Path(__file__).parent +rootdir = curdir.parent.parent +sys.path.insert(0, str(curdir)) + + +def sollya(sollya_file, out, encoding="utf-8"): + print(f"Executing {sollya_file}...") + rout = str(pathlib.Path(out).resolve().relative_to(rootdir)) + rsoll = str(pathlib.Path(sollya_file).resolve().relative_to(rootdir)) + guard_name = rout.upper().replace("/", "_").replace(".", "_").replace("-", "_") + + with tempfile.NamedTemporaryFile( + mode="w", suffix=".py", delete=False, encoding=encoding + ) as f: + pycode_temp = f.name + + pre = "\n".join( + [ + f'SOURCE_GUARD_NAME = "{guard_name}";', + f'SOURCE_FILE_PATH = "{rsoll}";', + f'OUTPUT_FILE_PATH = "{out}";', + f'PYTEMP_FILE_PATH = "{pycode_temp}";', + f'execute("{curdir/"core.sol"}");', + ] + ) + + with tempfile.NamedTemporaryFile( + mode="w", suffix=".sol", delete=False, encoding=encoding + ) as f: + f.write(pre + "\n") + with open(sollya_file, "r", encoding=encoding) as rf: + f.write(rf.read().strip()) + f.write("quit;\n") + sollya_temp = f.name + + try: + # Execute Sollya with temp file + result = subprocess.run( + ["sollya", sollya_temp], cwd=pathlib.Path(sollya_file).parent + ) + if result.returncode != 0: + raise RuntimeError(f"Sollya execution failed with code {result.returncode}") + finally: + # Clean up temp file + os.unlink(sollya_temp) + os.unlink(pycode_temp) + + +def main(force): + print("Generating sollya files...") + path = rootdir / "npsr" + exts = ["*.h", "*.py", "*.csv"] + from_exts = [f"{ext}.sol" for ext in exts] + patterns = [f"{path}/**/data/{ext}" for ext in from_exts] + files = list(chain.from_iterable(glob.glob(p, recursive=True) for p in patterns)) + + for f in files: + out = f + for frm, to in zip(from_exts, exts): + out = out.replace(frm[1:], to[1:]) + if not force and pathlib.Path(out).exists(): + print(f"Skipping {out}, file already exists") + continue + sollya(f, out) + + +if __name__ == "__main__": + import argparse + + parser = argparse.ArgumentParser( + description="Generate C++ headers/python templates from Python scripts." + ) + parser.add_argument( + "-f", + "--force", + action="store_true", + help="Force regenerate all files, even if they already exist.", + ) + args = parser.parse_args() + main(force=args.force) From 300b6bc7083f8c4a5e97efb6687bf6570ce75b79 Mon Sep 17 00:00:00 2001 From: Sayed Adel Date: Mon, 28 Jul 2025 20:43:11 +0300 Subject: [PATCH 20/20] remove auto-generated data (will be added in a separate PR) --- npsr/trig/data/approx.h | 1563 ------------------------ npsr/trig/data/constants.h | 57 - npsr/trig/data/data.h | 11 - npsr/trig/data/high.h | 54 - npsr/trig/data/reduction.h | 2320 ------------------------------------ 5 files changed, 4005 deletions(-) delete mode 100644 npsr/trig/data/approx.h delete mode 100644 npsr/trig/data/constants.h delete mode 100644 npsr/trig/data/data.h delete mode 100644 npsr/trig/data/high.h delete mode 100644 npsr/trig/data/reduction.h diff --git a/npsr/trig/data/approx.h b/npsr/trig/data/approx.h deleted file mode 100644 index 9b8d717..0000000 --- a/npsr/trig/data/approx.h +++ /dev/null @@ -1,1563 +0,0 @@ -// Auto-generated by npsr/trig/data/approx.h.sol -// Use `spin generate -f` to force regeneration -#ifndef NPSR_TRIG_DATA_APPROX_H -#define NPSR_TRIG_DATA_APPROX_H - -namespace npsr::trig::data { -template constexpr char kSinApproxTable[] = {}; -template <> constexpr float kSinApproxTable[] = -{ - 0.0f, 0x1p0f, 0.0f, 0.0f, - -0x1.3bcfbep-12f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, - -0x1.3bc39p-10f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, - -0x1.63253p-9f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, - -0x1.3b92e2p-8f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, - -0x1.ecdc78p-8f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, - -0x1.62aa04p-7f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, - -0x1.e26c16p-7f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, - -0x1.3ad06p-6f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, - -0x1.8e18a8p-6f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, - -0x1.eb0208p-6f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, - -0x1.28bf18p-5f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, - -0x1.60beaap-5f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, - -0x1.9d7714p-5f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, - -0x1.dedefcp-5f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, - -0x1.127624p-4f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, - -0x1.37ca18p-4f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, - -0x1.5f6598p-4f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, - -0x1.894286p-4f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, - -0x1.b55a7p-4f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, - -0x1.e3a688p-4f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, - -0x1.0a0fd4p-3f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, - -0x1.235f2ep-3f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, - -0x1.3dbd6ap-3f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, - -0x1.592676p-3f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, - -0x1.759618p-3f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, - -0x1.9307eep-3f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, - -0x1.b1776ep-3f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, - -0x1.d0dfe6p-3f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, - -0x1.f13c7ep-3f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, - -0x1.09441cp-2f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, - -0x1.1a5efap-2f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, - -0x1.2bec34p-2f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, - -0x1.3de916p-2f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, - -0x1.5052dap-2f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, - -0x1.6326a8p-2f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, - -0x1.76619cp-2f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, - -0x1.8a00bap-2f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, - -0x1.9e01p-2f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, - -0x1.b25f56p-2f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, - -0x1.c71898p-2f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, - -0x1.dc2996p-2f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, - -0x1.f18f0cp-2f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, - -0x1.d16c9p-8f, 0x1p-1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, - -0x1.d4a2c8p-6f, 0x1p-1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, - -0x1.9cc8b4p-5f, 0x1p-1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, - -0x1.28bbfep-4f, 0x1p-1f, 0x1.ced7bp-1f, -0x1.786712p-26f, - -0x1.8421bp-4f, 0x1p-1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, - -0x1.e08756p-4f, 0x1p-1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, - -0x1.1eef5ap-3f, 0x1p-1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, - -0x1.4e0cb2p-3f, 0x1p-1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, - -0x1.7d946ep-3f, 0x1p-1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, - -0x1.ad7f3ap-3f, 0x1p-1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, - -0x1.ddc5b4p-3f, 0x1p-1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, - -0x1.cc0d0ap-8f, 0x1p-2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, - -0x1.fa3ecap-6f, 0x1p-2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, - -0x1.c1d1fp-5f, 0x1p-2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, - -0x1.43bd78p-4f, 0x1p-2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, - -0x1.a6fdf2p-4f, 0x1p-2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, - -0x1.536352p-9f, 0x1p-3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, - -0x1.ba165p-6f, 0x1p-3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, - -0x1.a55beep-5f, 0x1p-3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, - -0x1.b82684p-7f, 0x1p-4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, - -0x1.b7aa82p-8f, 0x1p-5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, - 0.0f, 0.0f, 0x1p0f, 0.0f, - -0x1.003242p5f, 0x1p5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, - -0x1.00c8fcp4f, 0x1p4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, - -0x1.025aa4p3f, 0x1p3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, - -0x1.0322f4p3f, 0x1p3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, - -0x1.03eacap3f, 0x1p3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, - -0x1.096408p2f, 0x1p2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, - -0x1.0af10ap2f, 0x1p2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, - -0x1.0c7c5cp2f, 0x1p2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, - -0x1.0e05c2p2f, 0x1p2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, - -0x1.0f8cfcp2f, 0x1p2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, - -0x1.2223a4p1f, 0x1p1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, - -0x1.25280cp1f, 0x1p1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, - -0x1.2826bap1f, 0x1p1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, - -0x1.2b1f34p1f, 0x1p1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, - -0x1.2e110ap1f, 0x1p1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, - -0x1.30fbc6p1f, 0x1p1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, - -0x1.33def2p1f, 0x1p1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, - -0x1.36ba2p1f, 0x1p1f, 0x1.ced7bp-1f, -0x1.786712p-26f, - -0x1.398cdep1f, 0x1p1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, - -0x1.3c56bap1f, 0x1p1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, - -0x1.3f174ap1f, 0x1p1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, - -0x1.839c3cp0f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, - -0x1.88f59ap0f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, - -0x1.8e39dap0f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, - -0x1.93682ap0f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, - -0x1.987fcp0f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, - -0x1.9d7fd2p0f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, - -0x1.a2679ap0f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, - -0x1.a73656p0f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, - -0x1.abeb4ap0f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, - -0x1.b085bap0f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, - -0x1.b504f4p0f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, - -0x1.b96842p0f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, - -0x1.bdaefap0f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, - -0x1.c1d87p0f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, - -0x1.c5e404p0f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, - -0x1.c9d112p0f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, - -0x1.cd9f02p0f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, - -0x1.d14d3ep0f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, - -0x1.d4db32p0f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, - -0x1.d84852p0f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, - -0x1.db941ap0f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, - -0x1.debe06p0f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, - -0x1.e1c598p0f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, - -0x1.e4aa5ap0f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, - -0x1.e76bd8p0f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, - -0x1.ea09a6p0f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, - -0x1.ec835ep0f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, - -0x1.eed89ep0f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, - -0x1.f10908p0f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, - -0x1.f31448p0f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, - -0x1.f4fa0ap0f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, - -0x1.f6ba08p0f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, - -0x1.f853f8p0f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, - -0x1.f9c79ep0f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, - -0x1.fb14bep0f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, - -0x1.fc3b28p0f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, - -0x1.fd3aacp0f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, - -0x1.fe1324p0f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, - -0x1.fec46ep0f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, - -0x1.ff4e6ep0f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, - -0x1.ffb11p0f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, - -0x1.ffec44p0f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, - -0x1p1f, 0x1p0f, 0.0f, 0.0f, - -0x1.ffec44p0f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, - -0x1.ffb11p0f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, - -0x1.ff4e6ep0f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, - -0x1.fec46ep0f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, - -0x1.fe1324p0f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, - -0x1.fd3aacp0f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, - -0x1.fc3b28p0f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, - -0x1.fb14bep0f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, - -0x1.f9c79ep0f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, - -0x1.f853f8p0f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, - -0x1.f6ba08p0f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, - -0x1.f4fa0ap0f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, - -0x1.f31448p0f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, - -0x1.f10908p0f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, - -0x1.eed89ep0f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, - -0x1.ec835ep0f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, - -0x1.ea09a6p0f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, - -0x1.e76bd8p0f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, - -0x1.e4aa5ap0f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, - -0x1.e1c598p0f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, - -0x1.debe06p0f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, - -0x1.db941ap0f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, - -0x1.d84852p0f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, - -0x1.d4db32p0f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, - -0x1.d14d3ep0f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, - -0x1.cd9f02p0f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, - -0x1.c9d112p0f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, - -0x1.c5e404p0f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, - -0x1.c1d87p0f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, - -0x1.bdaefap0f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, - -0x1.b96842p0f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, - -0x1.b504f4p0f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, - -0x1.b085bap0f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, - -0x1.abeb4ap0f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, - -0x1.a73656p0f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, - -0x1.a2679ap0f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, - -0x1.9d7fd2p0f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, - -0x1.987fcp0f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, - -0x1.93682ap0f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, - -0x1.8e39dap0f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, - -0x1.88f59ap0f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, - -0x1.839c3cp0f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, - -0x1.3f174ap1f, 0x1p1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, - -0x1.3c56bap1f, 0x1p1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, - -0x1.398cdep1f, 0x1p1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, - -0x1.36ba2p1f, 0x1p1f, -0x1.ced7bp-1f, 0x1.786712p-26f, - -0x1.33def2p1f, 0x1p1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, - -0x1.30fbc6p1f, 0x1p1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, - -0x1.2e110ap1f, 0x1p1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, - -0x1.2b1f34p1f, 0x1p1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, - -0x1.2826bap1f, 0x1p1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, - -0x1.25280cp1f, 0x1p1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, - -0x1.2223a4p1f, 0x1p1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, - -0x1.0f8cfcp2f, 0x1p2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, - -0x1.0e05c2p2f, 0x1p2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, - -0x1.0c7c5cp2f, 0x1p2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, - -0x1.0af10ap2f, 0x1p2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, - -0x1.096408p2f, 0x1p2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, - -0x1.03eacap3f, 0x1p3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, - -0x1.0322f4p3f, 0x1p3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, - -0x1.025aa4p3f, 0x1p3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, - -0x1.00c8fcp4f, 0x1p4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, - -0x1.003242p5f, 0x1p5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, - 0.0f, 0.0f, -0x1p0f, 0.0f, - -0x1.b7aa82p-8f, 0x1p-5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, - -0x1.b82684p-7f, 0x1p-4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, - -0x1.a55beep-5f, 0x1p-3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, - -0x1.ba165p-6f, 0x1p-3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, - -0x1.536352p-9f, 0x1p-3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, - -0x1.a6fdf2p-4f, 0x1p-2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, - -0x1.43bd78p-4f, 0x1p-2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, - -0x1.c1d1fp-5f, 0x1p-2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, - -0x1.fa3ecap-6f, 0x1p-2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, - -0x1.cc0d0ap-8f, 0x1p-2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, - -0x1.ddc5b4p-3f, 0x1p-1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, - -0x1.ad7f3ap-3f, 0x1p-1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, - -0x1.7d946ep-3f, 0x1p-1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, - -0x1.4e0cb2p-3f, 0x1p-1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, - -0x1.1eef5ap-3f, 0x1p-1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, - -0x1.e08756p-4f, 0x1p-1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, - -0x1.8421bp-4f, 0x1p-1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, - -0x1.28bbfep-4f, 0x1p-1f, -0x1.ced7bp-1f, 0x1.786712p-26f, - -0x1.9cc8b4p-5f, 0x1p-1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, - -0x1.d4a2c8p-6f, 0x1p-1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, - -0x1.d16c9p-8f, 0x1p-1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, - -0x1.f18f0cp-2f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, - -0x1.dc2996p-2f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, - -0x1.c71898p-2f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, - -0x1.b25f56p-2f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, - -0x1.9e01p-2f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, - -0x1.8a00bap-2f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, - -0x1.76619cp-2f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, - -0x1.6326a8p-2f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, - -0x1.5052dap-2f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, - -0x1.3de916p-2f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, - -0x1.2bec34p-2f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, - -0x1.1a5efap-2f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, - -0x1.09441cp-2f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, - -0x1.f13c7ep-3f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, - -0x1.d0dfe6p-3f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, - -0x1.b1776ep-3f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, - -0x1.9307eep-3f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, - -0x1.759618p-3f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, - -0x1.592676p-3f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, - -0x1.3dbd6ap-3f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, - -0x1.235f2ep-3f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, - -0x1.0a0fd4p-3f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, - -0x1.e3a688p-4f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, - -0x1.b55a7p-4f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, - -0x1.894286p-4f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, - -0x1.5f6598p-4f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, - -0x1.37ca18p-4f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, - -0x1.127624p-4f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, - -0x1.dedefcp-5f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, - -0x1.9d7714p-5f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, - -0x1.60beaap-5f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, - -0x1.28bf18p-5f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, - -0x1.eb0208p-6f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, - -0x1.8e18a8p-6f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, - -0x1.3ad06p-6f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, - -0x1.e26c16p-7f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, - -0x1.62aa04p-7f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, - -0x1.ecdc78p-8f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, - -0x1.3b92e2p-8f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, - -0x1.63253p-9f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, - -0x1.3bc39p-10f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, - -0x1.3bcfbep-12f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, -}; - -template <> constexpr double kSinApproxTable[] = -{ - 0, 0x1p0, 0, 0, - -0x1.3bd2c8da49511p-14, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, - -0x1.3bcfbd9979a27p-12, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, - -0x1.6344004228d8bp-11, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, - -0x1.3bc390d250439p-10, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, - -0x1.ed534e31ca57fp-10, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, - -0x1.63252fe77c5ebp-9, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, - -0x1.e350342a4f6e6p-9, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, - -0x1.3b92e176d6d31p-8, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, - -0x1.8f501492cc296p-8, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, - -0x1.ecdc78f30165cp-8, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, - -0x1.2a1a39a8a2fb7p-7, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, - -0x1.62aa03dd6ba58p-7, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, - -0x1.a01b6cdbd995ep-7, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, - -0x1.e26c163ad15b3p-7, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, - -0x1.14ccb8bdbf114p-6, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, - -0x1.3ad06011469fbp-6, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, - -0x1.633f89e9a1a66p-6, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, - -0x1.8e18a73634ee7p-6, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, - -0x1.bb5a11138a4c9p-6, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, - -0x1.eb0208db9e51bp-6, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, - -0x1.0e875c1b8c3dap-5, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, - -0x1.28bf1897b69ccp-5, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, - -0x1.44273720f48bcp-5, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, - -0x1.60bea939d225ap-5, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, - -0x1.7e8454b32ef34p-5, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, - -0x1.9d7713b71eee1p-5, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, - -0x1.bd95b4d43e819p-5, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, - -0x1.dedefb09791b4p-5, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, - -0x1.00a8cee920eabp-4, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, - -0x1.127624999ee1dp-4, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, - -0x1.24d6cee3afb2ap-4, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, - -0x1.37ca1866b95cfp-4, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, - -0x1.4b4f461b0cbaap-4, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, - -0x1.5f6597591b633p-4, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, - -0x1.740c45e0e512p-4, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, - -0x1.894285e19c468p-4, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, - -0x1.9f07860181d1ep-4, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, - -0x1.b55a6f65f7058p-4, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, - -0x1.cc3a65bbc6327p-4, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, - -0x1.e3a6873fa1279p-4, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, - -0x1.fb9decc6d55b8p-4, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, - -0x1.0a0fd4e41ab5ap-3, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, - -0x1.169566329bcb7p-3, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, - -0x1.235f2eb9a470ap-3, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, - -0x1.306cb042aa3bap-3, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, - -0x1.3dbd69fabf802p-3, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, - -0x1.4b50d8778abbdp-3, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, - -0x1.592675bc57974p-3, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, - -0x1.673db93f41479p-3, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, - -0x1.759617ee761f9p-3, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, - -0x1.842f0435941afp-3, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, - -0x1.9307ee031e2fdp-3, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, - -0x1.a22042ce0a2f9p-3, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, - -0x1.b1776d9b67013p-3, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, - -0x1.c10cd7041afccp-3, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, - -0x1.d0dfe53aba2fdp-3, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, - -0x1.e0effc1174505p-3, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, - -0x1.f13c7d001a249p-3, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, - -0x1.00e263951d11fp-2, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, - -0x1.09441bb2aa0a2p-2, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, - -0x1.11c3141f91b3ep-2, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, - -0x1.1a5ef902000d3p-2, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, - -0x1.23177562aaea3p-2, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, - -0x1.2bec333018867p-2, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, - -0x1.34dcdb41f0f85p-2, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, - -0x1.3de9155c5a642p-2, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, - -0x1.471088335fce7p-2, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, - -0x1.5052d96e626c1p-2, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, - -0x1.59afadab954d4p-2, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, - -0x1.6326a8838342ep-2, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, - -0x1.6cb76c8c9ed8fp-2, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, - -0x1.76619b5edc454p-2, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, - -0x1.8024d59755257p-2, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, - -0x1.8a00badbf5e8ep-2, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, - -0x1.93f4e9df34c1bp-2, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, - -0x1.9e010063d1f96p-2, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, - -0x1.a8249b40a182cp-2, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, - -0x1.b25f56645da43p-2, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, - -0x1.bcb0ccd98294fp-2, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, - -0x1.c71898ca32e6fp-2, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, - -0x1.d19653842496fp-2, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, - -0x1.dc29957c969bbp-2, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, - -0x1.e6d1f6544ece3p-2, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, - -0x1.f18f0cdba0025p-2, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, - -0x1.fc606f1678292p-2, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, - -0x1.d16c901d95181p-8, 0x1p-1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, - -0x1.23e6ad10872a7p-6, 0x1p-1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, - -0x1.d4a2c7f909c4ep-6, 0x1p-1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, - -0x1.4344523c8e3b5p-5, 0x1p-1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, - -0x1.9cc8b3671dd0fp-5, 0x1p-1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, - -0x1.f6db13ff708cbp-5, 0x1p-1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, - -0x1.28bbfd87a8cffp-4, 0x1p-1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, - -0x1.564df524b00dap-4, 0x1p-1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, - -0x1.8421af15c49d7p-4, 0x1p-1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, - -0x1.b2356710db0a3p-4, 0x1p-1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, - -0x1.e087565455a75p-4, 0x1p-1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, - -0x1.078ad9dc46632p-3, 0x1p-1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, - -0x1.1eef59e0b74c3p-3, 0x1p-1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, - -0x1.367044581b074p-3, 0x1p-1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, - -0x1.4e0cb14a9c046p-3, 0x1p-1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, - -0x1.65c3b7b0e312cp-3, 0x1p-1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, - -0x1.7d946d7d133fdp-3, 0x1p-1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, - -0x1.957de7a3cfd5dp-3, 0x1p-1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, - -0x1.ad7f3a254c1f5p-3, 0x1p-1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, - -0x1.c597781664984p-3, 0x1p-1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, - -0x1.ddc5b3a9c1311p-3, 0x1p-1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, - -0x1.f608fe39004a4p-3, 0x1p-1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, - -0x1.cc0d09bd41caap-8, 0x1p-2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, - -0x1.36580d5d5e775p-6, 0x1p-2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, - -0x1.fa3ecac0d84e8p-6, 0x1p-2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, - -0x1.5f57f693feebep-5, 0x1p-2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, - -0x1.c1d1f0e5967d5p-5, 0x1p-2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, - -0x1.1244c435e819dp-4, 0x1p-2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, - -0x1.43bd776e98073p-4, 0x1p-2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, - -0x1.755129dad834cp-4, 0x1p-2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, - -0x1.a6fdf22e33d8cp-4, 0x1p-2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, - -0x1.d8c1e624a1513p-4, 0x1p-2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, - -0x1.536352ad19e39p-9, 0x1p-3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, - -0x1.e43d1c309e958p-7, 0x1p-3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, - -0x1.ba1650f592f5p-6, 0x1p-3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, - -0x1.4125feacab7cep-5, 0x1p-3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, - -0x1.a55beda63cc14p-5, 0x1p-3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, - -0x1.35230c0fbe402p-10, 0x1p-4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, - -0x1.b82683bc89fbp-7, 0x1p-4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, - -0x1.a4f3514d75466p-6, 0x1p-4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, - -0x1.b7aa821726608p-8, 0x1p-5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, - -0x1.b78b80c84e1eep-9, 0x1p-6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, - 0, 0, 0x1p0, 0, - -0x1.000c90e8fe6f6p6, 0x1p6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, - -0x1.003242abef46dp5, 0x1p5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, - -0x1.0096c32baca2bp4, 0x1p4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, - -0x1.00c8fb2f886ecp4, 0x1p4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, - -0x1.00fb2b73cfc1p4, 0x1p4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, - -0x1.025aa41259c34p3, 0x1p3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, - -0x1.02beda0153548p3, 0x1p3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, - -0x1.0322f4d785368p3, 0x1p3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, - -0x1.0386f0b8f3d86p3, 0x1p3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, - -0x1.03eac9cad52e6p3, 0x1p3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, - -0x1.089cf8676d7acp2, 0x1p2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, - -0x1.096408374730ap2, 0x1p2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, - -0x1.0a2abb58949f3p2, 0x1p2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, - -0x1.0af10a22459fep2, 0x1p2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, - -0x1.0bb6ecef285fap2, 0x1p2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, - -0x1.0c7c5c1e34d3p2, 0x1p2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, - -0x1.0d415012d8023p2, 0x1p2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, - -0x1.0e05c1353f27bp2, 0x1p2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, - -0x1.0ec9a7f2a2a19p2, 0x1p2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, - -0x1.0f8cfcbd90af9p2, 0x1p2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, - -0x1.209f701c6ffb6p1, 0x1p1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, - -0x1.2223a4c563ecfp1, 0x1p1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, - -0x1.23a6887e99b68p1, 0x1p1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, - -0x1.25280c5dab3e1p1, 0x1p1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, - -0x1.26a82185c302ap1, 0x1p1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, - -0x1.2826b9282eccp1, 0x1p1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, - -0x1.29a3c484f1cedp1, 0x1p1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, - -0x1.2b1f34eb563fcp1, 0x1p1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, - -0x1.2c98fbba7e4f9p1, 0x1p1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, - -0x1.2e110a61f48b4p1, 0x1p1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, - -0x1.2f8752623b99dp1, 0x1p1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, - -0x1.30fbc54d5d52cp1, 0x1p1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, - -0x1.326e54c77927bp1, 0x1p1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, - -0x1.33def28751db1p1, 0x1p1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, - -0x1.354d9056da7f9p1, 0x1p1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, - -0x1.36ba2013c2b98p1, 0x1p1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, - -0x1.382493b0023ddp1, 0x1p1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, - -0x1.398cdd326388cp1, 0x1p1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, - -0x1.3af2eeb70dc71p1, 0x1p1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, - -0x1.3c56ba700dec7p1, 0x1p1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, - -0x1.3db832a5def1bp1, 0x1p1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, - -0x1.3f1749b7f1357p1, 0x1p1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, - -0x1.80e7e43a61f5bp0, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, - -0x1.839c3cc917ff7p0, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, - -0x1.864b826aec4c7p0, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, - -0x1.88f59aa0da591p0, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, - -0x1.8b9a6b1ef6da4p0, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, - -0x1.8e39d9cd73464p0, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, - -0x1.90d3ccc99f5acp0, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, - -0x1.93682a66e896fp0, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, - -0x1.95f6d92fd79f5p0, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, - -0x1.987fbfe70b81ap0, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, - -0x1.9b02c58832cf9p0, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, - -0x1.9d7fd1490285dp0, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, - -0x1.9ff6ca9a2ab6ap0, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, - -0x1.a267992848eebp0, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, - -0x1.a4d224dcd849cp0, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, - -0x1.a73655df1f2f5p0, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, - -0x1.a99414951aacbp0, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, - -0x1.abeb49a46765p0, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, - -0x1.ae3bddf3280c6p0, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, - -0x1.b085baa8e966fp0, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, - -0x1.b2c8c92f83c1fp0, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, - -0x1.b504f333f9de6p0, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, - -0x1.b73a22a755457p0, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, - -0x1.b96841bf7ffcbp0, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, - -0x1.bb8f3af81b931p0, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, - -0x1.bdaef913557d7p0, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, - -0x1.bfc7671ab8bb8p0, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, - -0x1.c1d8705ffcbb7p0, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, - -0x1.c3e2007dd175fp0, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, - -0x1.c5e40358a8bap0, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, - -0x1.c7de651f7ca06p0, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, - -0x1.c9d1124c931fep0, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, - -0x1.cbbbf7a63eba1p0, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, - -0x1.cd9f023f9c3ap0, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, - -0x1.cf7a1f794d7cap0, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, - -0x1.d14d3d02313c1p0, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, - -0x1.d31848d817d71p0, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, - -0x1.d4db3148750d2p0, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, - -0x1.d695e4f10ea88p0, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, - -0x1.d84852c0a81p0, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, - -0x1.d9f269f7aab89p0, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, - -0x1.db941a28cb71fp0, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, - -0x1.dd2d5339ac869p0, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, - -0x1.debe05637ca95p0, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, - -0x1.e046213392aa5p0, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, - -0x1.e1c5978c05ed8p0, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, - -0x1.e33c59a4439cep0, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, - -0x1.e4aa5909a08fap0, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, - -0x1.e60f879fe7e2ep0, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, - -0x1.e76bd7a1e63b9p0, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, - -0x1.e8bf3ba1f1aeep0, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, - -0x1.ea09a68a6e49dp0, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, - -0x1.eb4b0b9e4f345p0, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, - -0x1.ec835e79946a3p0, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, - -0x1.edb29311c504dp0, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, - -0x1.eed89db66611ep0, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, - -0x1.eff573116df15p0, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, - -0x1.f1090827b4372p0, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, - -0x1.f21352595e0bfp0, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, - -0x1.f314476247089p0, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, - -0x1.f40bdd5a66886p0, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, - -0x1.f4fa0ab6316edp0, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, - -0x1.f5dec646f85bap0, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, - -0x1.f6ba073b424b2p0, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, - -0x1.f78bc51f239e1p0, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, - -0x1.f853f7dc9186cp0, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, - -0x1.f91297bbb1d6dp0, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, - -0x1.f9c79d63272c4p0, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, - -0x1.fa7301d859796p0, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, - -0x1.fb14be7fbae58p0, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, - -0x1.fbaccd1d0903cp0, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, - -0x1.fc3b27d38a5d5p0, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, - -0x1.fcbfc926484cdp0, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, - -0x1.fd3aabf84528bp0, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, - -0x1.fdabcb8caeba1p0, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, - -0x1.fe1323870cfeap0, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, - -0x1.fe70afeb6d33dp0, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, - -0x1.fec46d1e89293p0, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, - -0x1.ff0e57e5ead85p0, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, - -0x1.ff4e6d680c41dp0, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, - -0x1.ff84ab2c738d7p0, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, - -0x1.ffb10f1bcb6bfp0, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, - -0x1.ffd3977ff7baep0, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, - -0x1.ffec430426686p0, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, - -0x1.fffb10b4dc96ep0, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, - -0x1p1, 0x1p0, 0, 0, - -0x1.fffb10b4dc96ep0, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, - -0x1.ffec430426686p0, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, - -0x1.ffd3977ff7baep0, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, - -0x1.ffb10f1bcb6bfp0, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, - -0x1.ff84ab2c738d7p0, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, - -0x1.ff4e6d680c41dp0, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, - -0x1.ff0e57e5ead85p0, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, - -0x1.fec46d1e89293p0, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, - -0x1.fe70afeb6d33dp0, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, - -0x1.fe1323870cfeap0, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, - -0x1.fdabcb8caeba1p0, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, - -0x1.fd3aabf84528bp0, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, - -0x1.fcbfc926484cdp0, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, - -0x1.fc3b27d38a5d5p0, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, - -0x1.fbaccd1d0903cp0, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, - -0x1.fb14be7fbae58p0, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, - -0x1.fa7301d859796p0, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, - -0x1.f9c79d63272c4p0, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, - -0x1.f91297bbb1d6dp0, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, - -0x1.f853f7dc9186cp0, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, - -0x1.f78bc51f239e1p0, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, - -0x1.f6ba073b424b2p0, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, - -0x1.f5dec646f85bap0, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, - -0x1.f4fa0ab6316edp0, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, - -0x1.f40bdd5a66886p0, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, - -0x1.f314476247089p0, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, - -0x1.f21352595e0bfp0, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, - -0x1.f1090827b4372p0, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, - -0x1.eff573116df15p0, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, - -0x1.eed89db66611ep0, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, - -0x1.edb29311c504dp0, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, - -0x1.ec835e79946a3p0, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, - -0x1.eb4b0b9e4f345p0, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, - -0x1.ea09a68a6e49dp0, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, - -0x1.e8bf3ba1f1aeep0, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, - -0x1.e76bd7a1e63b9p0, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, - -0x1.e60f879fe7e2ep0, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, - -0x1.e4aa5909a08fap0, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, - -0x1.e33c59a4439cep0, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, - -0x1.e1c5978c05ed8p0, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, - -0x1.e046213392aa5p0, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, - -0x1.debe05637ca95p0, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, - -0x1.dd2d5339ac869p0, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, - -0x1.db941a28cb71fp0, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, - -0x1.d9f269f7aab89p0, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, - -0x1.d84852c0a81p0, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, - -0x1.d695e4f10ea88p0, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, - -0x1.d4db3148750d2p0, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, - -0x1.d31848d817d71p0, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, - -0x1.d14d3d02313c1p0, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, - -0x1.cf7a1f794d7cap0, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, - -0x1.cd9f023f9c3ap0, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, - -0x1.cbbbf7a63eba1p0, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, - -0x1.c9d1124c931fep0, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, - -0x1.c7de651f7ca06p0, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, - -0x1.c5e40358a8bap0, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, - -0x1.c3e2007dd175fp0, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, - -0x1.c1d8705ffcbb7p0, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, - -0x1.bfc7671ab8bb8p0, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, - -0x1.bdaef913557d7p0, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, - -0x1.bb8f3af81b931p0, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, - -0x1.b96841bf7ffcbp0, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, - -0x1.b73a22a755457p0, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, - -0x1.b504f333f9de6p0, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, - -0x1.b2c8c92f83c1fp0, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, - -0x1.b085baa8e966fp0, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, - -0x1.ae3bddf3280c6p0, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, - -0x1.abeb49a46765p0, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, - -0x1.a99414951aacbp0, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, - -0x1.a73655df1f2f5p0, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, - -0x1.a4d224dcd849cp0, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, - -0x1.a267992848eebp0, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, - -0x1.9ff6ca9a2ab6ap0, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, - -0x1.9d7fd1490285dp0, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, - -0x1.9b02c58832cf9p0, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, - -0x1.987fbfe70b81ap0, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, - -0x1.95f6d92fd79f5p0, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, - -0x1.93682a66e896fp0, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, - -0x1.90d3ccc99f5acp0, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, - -0x1.8e39d9cd73464p0, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, - -0x1.8b9a6b1ef6da4p0, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, - -0x1.88f59aa0da591p0, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, - -0x1.864b826aec4c7p0, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, - -0x1.839c3cc917ff7p0, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, - -0x1.80e7e43a61f5bp0, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, - -0x1.3f1749b7f1357p1, 0x1p1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, - -0x1.3db832a5def1bp1, 0x1p1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, - -0x1.3c56ba700dec7p1, 0x1p1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, - -0x1.3af2eeb70dc71p1, 0x1p1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, - -0x1.398cdd326388cp1, 0x1p1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, - -0x1.382493b0023ddp1, 0x1p1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, - -0x1.36ba2013c2b98p1, 0x1p1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, - -0x1.354d9056da7f9p1, 0x1p1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, - -0x1.33def28751db1p1, 0x1p1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, - -0x1.326e54c77927bp1, 0x1p1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, - -0x1.30fbc54d5d52cp1, 0x1p1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, - -0x1.2f8752623b99dp1, 0x1p1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, - -0x1.2e110a61f48b4p1, 0x1p1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, - -0x1.2c98fbba7e4f9p1, 0x1p1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, - -0x1.2b1f34eb563fcp1, 0x1p1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, - -0x1.29a3c484f1cedp1, 0x1p1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, - -0x1.2826b9282eccp1, 0x1p1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, - -0x1.26a82185c302ap1, 0x1p1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, - -0x1.25280c5dab3e1p1, 0x1p1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, - -0x1.23a6887e99b68p1, 0x1p1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, - -0x1.2223a4c563ecfp1, 0x1p1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, - -0x1.209f701c6ffb6p1, 0x1p1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, - -0x1.0f8cfcbd90af9p2, 0x1p2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, - -0x1.0ec9a7f2a2a19p2, 0x1p2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, - -0x1.0e05c1353f27bp2, 0x1p2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, - -0x1.0d415012d8023p2, 0x1p2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, - -0x1.0c7c5c1e34d3p2, 0x1p2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, - -0x1.0bb6ecef285fap2, 0x1p2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, - -0x1.0af10a22459fep2, 0x1p2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, - -0x1.0a2abb58949f3p2, 0x1p2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, - -0x1.096408374730ap2, 0x1p2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, - -0x1.089cf8676d7acp2, 0x1p2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, - -0x1.03eac9cad52e6p3, 0x1p3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, - -0x1.0386f0b8f3d86p3, 0x1p3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, - -0x1.0322f4d785368p3, 0x1p3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, - -0x1.02beda0153548p3, 0x1p3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, - -0x1.025aa41259c34p3, 0x1p3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, - -0x1.00fb2b73cfc1p4, 0x1p4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, - -0x1.00c8fb2f886ecp4, 0x1p4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, - -0x1.0096c32baca2bp4, 0x1p4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, - -0x1.003242abef46dp5, 0x1p5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, - -0x1.000c90e8fe6f6p6, 0x1p6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, - 0, 0, -0x1p0, 0, - -0x1.b78b80c84e1eep-9, 0x1p-6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, - -0x1.b7aa821726608p-8, 0x1p-5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, - -0x1.a4f3514d75466p-6, 0x1p-4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, - -0x1.b82683bc89fbp-7, 0x1p-4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, - -0x1.35230c0fbe402p-10, 0x1p-4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, - -0x1.a55beda63cc14p-5, 0x1p-3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, - -0x1.4125feacab7cep-5, 0x1p-3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, - -0x1.ba1650f592f5p-6, 0x1p-3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, - -0x1.e43d1c309e958p-7, 0x1p-3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, - -0x1.536352ad19e39p-9, 0x1p-3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, - -0x1.d8c1e624a1513p-4, 0x1p-2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, - -0x1.a6fdf22e33d8cp-4, 0x1p-2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, - -0x1.755129dad834cp-4, 0x1p-2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, - -0x1.43bd776e98073p-4, 0x1p-2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, - -0x1.1244c435e819dp-4, 0x1p-2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, - -0x1.c1d1f0e5967d5p-5, 0x1p-2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, - -0x1.5f57f693feebep-5, 0x1p-2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, - -0x1.fa3ecac0d84e8p-6, 0x1p-2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, - -0x1.36580d5d5e775p-6, 0x1p-2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, - -0x1.cc0d09bd41caap-8, 0x1p-2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, - -0x1.f608fe39004a4p-3, 0x1p-1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, - -0x1.ddc5b3a9c1311p-3, 0x1p-1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, - -0x1.c597781664984p-3, 0x1p-1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, - -0x1.ad7f3a254c1f5p-3, 0x1p-1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, - -0x1.957de7a3cfd5dp-3, 0x1p-1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, - -0x1.7d946d7d133fdp-3, 0x1p-1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, - -0x1.65c3b7b0e312cp-3, 0x1p-1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, - -0x1.4e0cb14a9c046p-3, 0x1p-1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, - -0x1.367044581b074p-3, 0x1p-1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, - -0x1.1eef59e0b74c3p-3, 0x1p-1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, - -0x1.078ad9dc46632p-3, 0x1p-1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, - -0x1.e087565455a75p-4, 0x1p-1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, - -0x1.b2356710db0a3p-4, 0x1p-1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, - -0x1.8421af15c49d7p-4, 0x1p-1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, - -0x1.564df524b00dap-4, 0x1p-1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, - -0x1.28bbfd87a8cffp-4, 0x1p-1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, - -0x1.f6db13ff708cbp-5, 0x1p-1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, - -0x1.9cc8b3671dd0fp-5, 0x1p-1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, - -0x1.4344523c8e3b5p-5, 0x1p-1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, - -0x1.d4a2c7f909c4ep-6, 0x1p-1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, - -0x1.23e6ad10872a7p-6, 0x1p-1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, - -0x1.d16c901d95181p-8, 0x1p-1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, - -0x1.fc606f1678292p-2, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, - -0x1.f18f0cdba0025p-2, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, - -0x1.e6d1f6544ece3p-2, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, - -0x1.dc29957c969bbp-2, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, - -0x1.d19653842496fp-2, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, - -0x1.c71898ca32e6fp-2, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, - -0x1.bcb0ccd98294fp-2, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, - -0x1.b25f56645da43p-2, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, - -0x1.a8249b40a182cp-2, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, - -0x1.9e010063d1f96p-2, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, - -0x1.93f4e9df34c1bp-2, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, - -0x1.8a00badbf5e8ep-2, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, - -0x1.8024d59755257p-2, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, - -0x1.76619b5edc454p-2, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, - -0x1.6cb76c8c9ed8fp-2, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, - -0x1.6326a8838342ep-2, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, - -0x1.59afadab954d4p-2, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, - -0x1.5052d96e626c1p-2, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, - -0x1.471088335fce7p-2, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, - -0x1.3de9155c5a642p-2, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, - -0x1.34dcdb41f0f85p-2, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, - -0x1.2bec333018867p-2, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, - -0x1.23177562aaea3p-2, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, - -0x1.1a5ef902000d3p-2, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, - -0x1.11c3141f91b3ep-2, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, - -0x1.09441bb2aa0a2p-2, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, - -0x1.00e263951d11fp-2, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, - -0x1.f13c7d001a249p-3, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, - -0x1.e0effc1174505p-3, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, - -0x1.d0dfe53aba2fdp-3, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, - -0x1.c10cd7041afccp-3, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, - -0x1.b1776d9b67013p-3, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, - -0x1.a22042ce0a2f9p-3, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, - -0x1.9307ee031e2fdp-3, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, - -0x1.842f0435941afp-3, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, - -0x1.759617ee761f9p-3, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, - -0x1.673db93f41479p-3, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, - -0x1.592675bc57974p-3, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, - -0x1.4b50d8778abbdp-3, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, - -0x1.3dbd69fabf802p-3, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, - -0x1.306cb042aa3bap-3, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, - -0x1.235f2eb9a470ap-3, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, - -0x1.169566329bcb7p-3, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, - -0x1.0a0fd4e41ab5ap-3, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, - -0x1.fb9decc6d55b8p-4, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, - -0x1.e3a6873fa1279p-4, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, - -0x1.cc3a65bbc6327p-4, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, - -0x1.b55a6f65f7058p-4, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, - -0x1.9f07860181d1ep-4, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, - -0x1.894285e19c468p-4, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, - -0x1.740c45e0e512p-4, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, - -0x1.5f6597591b633p-4, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, - -0x1.4b4f461b0cbaap-4, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, - -0x1.37ca1866b95cfp-4, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, - -0x1.24d6cee3afb2ap-4, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, - -0x1.127624999ee1dp-4, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, - -0x1.00a8cee920eabp-4, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, - -0x1.dedefb09791b4p-5, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, - -0x1.bd95b4d43e819p-5, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, - -0x1.9d7713b71eee1p-5, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, - -0x1.7e8454b32ef34p-5, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, - -0x1.60bea939d225ap-5, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, - -0x1.44273720f48bcp-5, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, - -0x1.28bf1897b69ccp-5, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, - -0x1.0e875c1b8c3dap-5, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, - -0x1.eb0208db9e51bp-6, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, - -0x1.bb5a11138a4c9p-6, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, - -0x1.8e18a73634ee7p-6, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, - -0x1.633f89e9a1a66p-6, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, - -0x1.3ad06011469fbp-6, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, - -0x1.14ccb8bdbf114p-6, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, - -0x1.e26c163ad15b3p-7, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, - -0x1.a01b6cdbd995ep-7, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, - -0x1.62aa03dd6ba58p-7, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, - -0x1.2a1a39a8a2fb7p-7, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, - -0x1.ecdc78f30165cp-8, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, - -0x1.8f501492cc296p-8, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, - -0x1.3b92e176d6d31p-8, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, - -0x1.e350342a4f6e6p-9, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, - -0x1.63252fe77c5ebp-9, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, - -0x1.ed534e31ca57fp-10, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, - -0x1.3bc390d250439p-10, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, - -0x1.6344004228d8bp-11, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, - -0x1.3bcfbd9979a27p-12, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, - -0x1.3bd2c8da49511p-14, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, -}; - -template constexpr char kCosApproxTable[] = {}; -template <> constexpr float kCosApproxTable[] = -{ - 0.0f, 0.0f, 0x1p0f, 0.0f, - -0x1.003242p5f, 0x1p5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, - -0x1.00c8fcp4f, 0x1p4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, - -0x1.025aa4p3f, 0x1p3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, - -0x1.0322f4p3f, 0x1p3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, - -0x1.03eacap3f, 0x1p3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, - -0x1.096408p2f, 0x1p2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, - -0x1.0af10ap2f, 0x1p2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, - -0x1.0c7c5cp2f, 0x1p2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, - -0x1.0e05c2p2f, 0x1p2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, - -0x1.0f8cfcp2f, 0x1p2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, - -0x1.2223a4p1f, 0x1p1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, - -0x1.25280cp1f, 0x1p1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, - -0x1.2826bap1f, 0x1p1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, - -0x1.2b1f34p1f, 0x1p1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, - -0x1.2e110ap1f, 0x1p1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, - -0x1.30fbc6p1f, 0x1p1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, - -0x1.33def2p1f, 0x1p1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, - -0x1.36ba2p1f, 0x1p1f, 0x1.ced7bp-1f, -0x1.786712p-26f, - -0x1.398cdep1f, 0x1p1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, - -0x1.3c56bap1f, 0x1p1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, - -0x1.3f174ap1f, 0x1p1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, - -0x1.839c3cp0f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, - -0x1.88f59ap0f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, - -0x1.8e39dap0f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, - -0x1.93682ap0f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, - -0x1.987fcp0f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, - -0x1.9d7fd2p0f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, - -0x1.a2679ap0f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, - -0x1.a73656p0f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, - -0x1.abeb4ap0f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, - -0x1.b085bap0f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, - -0x1.b504f4p0f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, - -0x1.b96842p0f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, - -0x1.bdaefap0f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, - -0x1.c1d87p0f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, - -0x1.c5e404p0f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, - -0x1.c9d112p0f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, - -0x1.cd9f02p0f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, - -0x1.d14d3ep0f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, - -0x1.d4db32p0f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, - -0x1.d84852p0f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, - -0x1.db941ap0f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, - -0x1.debe06p0f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, - -0x1.e1c598p0f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, - -0x1.e4aa5ap0f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, - -0x1.e76bd8p0f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, - -0x1.ea09a6p0f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, - -0x1.ec835ep0f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, - -0x1.eed89ep0f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, - -0x1.f10908p0f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, - -0x1.f31448p0f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, - -0x1.f4fa0ap0f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, - -0x1.f6ba08p0f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, - -0x1.f853f8p0f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, - -0x1.f9c79ep0f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, - -0x1.fb14bep0f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, - -0x1.fc3b28p0f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, - -0x1.fd3aacp0f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, - -0x1.fe1324p0f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, - -0x1.fec46ep0f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, - -0x1.ff4e6ep0f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, - -0x1.ffb11p0f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, - -0x1.ffec44p0f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, - -0x1p1f, 0x1p0f, 0.0f, 0.0f, - -0x1.ffec44p0f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, - -0x1.ffb11p0f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, - -0x1.ff4e6ep0f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, - -0x1.fec46ep0f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, - -0x1.fe1324p0f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, - -0x1.fd3aacp0f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, - -0x1.fc3b28p0f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, - -0x1.fb14bep0f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, - -0x1.f9c79ep0f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, - -0x1.f853f8p0f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, - -0x1.f6ba08p0f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, - -0x1.f4fa0ap0f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, - -0x1.f31448p0f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, - -0x1.f10908p0f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, - -0x1.eed89ep0f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, - -0x1.ec835ep0f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, - -0x1.ea09a6p0f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, - -0x1.e76bd8p0f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, - -0x1.e4aa5ap0f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, - -0x1.e1c598p0f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, - -0x1.debe06p0f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, - -0x1.db941ap0f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, - -0x1.d84852p0f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, - -0x1.d4db32p0f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, - -0x1.d14d3ep0f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, - -0x1.cd9f02p0f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, - -0x1.c9d112p0f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, - -0x1.c5e404p0f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, - -0x1.c1d87p0f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, - -0x1.bdaefap0f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, - -0x1.b96842p0f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, - -0x1.b504f4p0f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, - -0x1.b085bap0f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, - -0x1.abeb4ap0f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, - -0x1.a73656p0f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, - -0x1.a2679ap0f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, - -0x1.9d7fd2p0f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, - -0x1.987fcp0f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, - -0x1.93682ap0f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, - -0x1.8e39dap0f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, - -0x1.88f59ap0f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, - -0x1.839c3cp0f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, - -0x1.3f174ap1f, 0x1p1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, - -0x1.3c56bap1f, 0x1p1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, - -0x1.398cdep1f, 0x1p1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, - -0x1.36ba2p1f, 0x1p1f, -0x1.ced7bp-1f, 0x1.786712p-26f, - -0x1.33def2p1f, 0x1p1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, - -0x1.30fbc6p1f, 0x1p1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, - -0x1.2e110ap1f, 0x1p1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, - -0x1.2b1f34p1f, 0x1p1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, - -0x1.2826bap1f, 0x1p1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, - -0x1.25280cp1f, 0x1p1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, - -0x1.2223a4p1f, 0x1p1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, - -0x1.0f8cfcp2f, 0x1p2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, - -0x1.0e05c2p2f, 0x1p2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, - -0x1.0c7c5cp2f, 0x1p2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, - -0x1.0af10ap2f, 0x1p2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, - -0x1.096408p2f, 0x1p2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, - -0x1.03eacap3f, 0x1p3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, - -0x1.0322f4p3f, 0x1p3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, - -0x1.025aa4p3f, 0x1p3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, - -0x1.00c8fcp4f, 0x1p4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, - -0x1.003242p5f, 0x1p5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, - 0.0f, 0.0f, -0x1p0f, 0.0f, - -0x1.b7aa82p-8f, 0x1p-5f, -0x1.ffd886p-1f, -0x1.099a1ap-30f, - -0x1.b82684p-7f, 0x1p-4f, -0x1.ff621ep-1f, -0x1.bcb6bep-28f, - -0x1.a55beep-5f, 0x1p-3f, -0x1.fe9cdap-1f, -0x1.a03108p-26f, - -0x1.ba165p-6f, 0x1p-3f, -0x1.fd88dap-1f, -0x1.e89292p-28f, - -0x1.536352p-9f, 0x1p-3f, -0x1.fc2648p-1f, 0x1.e3cc06p-26f, - -0x1.a6fdf2p-4f, 0x1p-2f, -0x1.fa7558p-1f, 0x1.eeb5d2p-30f, - -0x1.43bd78p-4f, 0x1p-2f, -0x1.f8765p-1f, 0x1.63ad16p-27f, - -0x1.c1d1fp-5f, 0x1p-2f, -0x1.f6297cp-1f, -0x1.feeb96p-26f, - -0x1.fa3ecap-6f, 0x1p-2f, -0x1.f38f3ap-1f, -0x1.8c9cb2p-26f, - -0x1.cc0d0ap-8f, 0x1p-2f, -0x1.f0a7fp-1f, 0x1.1b73cap-27f, - -0x1.ddc5b4p-3f, 0x1p-1f, -0x1.ed740ep-1f, -0x1.da1258p-27f, - -0x1.ad7f3ap-3f, 0x1p-1f, -0x1.e9f416p-1f, 0x1.273a44p-26f, - -0x1.7d946ep-3f, 0x1p-1f, -0x1.e6288ep-1f, -0x1.891c22p-26f, - -0x1.4e0cb2p-3f, 0x1p-1f, -0x1.e2121p-1f, -0x1.3da1bap-27f, - -0x1.1eef5ap-3f, 0x1p-1f, -0x1.ddb13cp-1f, 0x1.2667b8p-26f, - -0x1.e08756p-4f, 0x1p-1f, -0x1.d906bcp-1f, -0x1.e651a8p-26f, - -0x1.8421bp-4f, 0x1p-1f, -0x1.d4134ep-1f, 0x1.d646d8p-26f, - -0x1.28bbfep-4f, 0x1p-1f, -0x1.ced7bp-1f, 0x1.786712p-26f, - -0x1.9cc8b4p-5f, 0x1p-1f, -0x1.c954b2p-1f, -0x1.3411f4p-29f, - -0x1.d4a2c8p-6f, 0x1p-1f, -0x1.c38b3p-1f, 0x1.cfe84ap-26f, - -0x1.d16c9p-8f, 0x1p-1f, -0x1.bd7c0ap-1f, -0x1.8df2a6p-26f, - -0x1.f18f0cp-2f, 0x1p0f, -0x1.b72834p-1f, -0x1.465b9p-27f, - -0x1.dc2996p-2f, 0x1p0f, -0x1.b090a6p-1f, 0x1.fabf8p-27f, - -0x1.c71898p-2f, 0x1p0f, -0x1.a9b662p-1f, -0x1.21d434p-26f, - -0x1.b25f56p-2f, 0x1p0f, -0x1.a29a7ap-1f, -0x1.189e08p-31f, - -0x1.9e01p-2f, 0x1p0f, -0x1.9b3e04p-1f, -0x1.fce1dp-27f, - -0x1.8a00bap-2f, 0x1p0f, -0x1.93a224p-1f, -0x1.324c8p-26f, - -0x1.76619cp-2f, 0x1p0f, -0x1.8bc806p-1f, -0x1.62a2e8p-26f, - -0x1.6326a8p-2f, 0x1p0f, -0x1.83b0ep-1f, -0x1.7ff2eep-26f, - -0x1.5052dap-2f, 0x1p0f, -0x1.7b5df2p-1f, -0x1.3557d8p-28f, - -0x1.3de916p-2f, 0x1p0f, -0x1.72d084p-1f, 0x1.02000ep-26f, - -0x1.2bec34p-2f, 0x1p0f, -0x1.6a09e6p-1f, -0x1.9fcef4p-27f, - -0x1.1a5efap-2f, 0x1p0f, -0x1.610b76p-1f, 0x1.5c5a64p-26f, - -0x1.09441cp-2f, 0x1p0f, -0x1.57d694p-1f, 0x1.6e626cp-26f, - -0x1.f13c7ep-3f, 0x1p0f, -0x1.4e6cacp-1f, 0x1.070686p-27f, - -0x1.d0dfe6p-3f, 0x1p0f, -0x1.44cf32p-1f, -0x1.424776p-27f, - -0x1.b1776ep-3f, 0x1p0f, -0x1.3affa2p-1f, -0x1.240a18p-26f, - -0x1.9307eep-3f, 0x1p0f, -0x1.30ff8p-1f, 0x1.8f47e6p-28f, - -0x1.759618p-3f, 0x1p0f, -0x1.26d054p-1f, -0x1.9ba25cp-26f, - -0x1.592676p-3f, 0x1p0f, -0x1.1c73b4p-1f, 0x1.9465cep-27f, - -0x1.3dbd6ap-3f, 0x1p0f, -0x1.11eb36p-1f, 0x1.7c969cp-26f, - -0x1.235f2ep-3f, 0x1p0f, -0x1.07387ap-1f, 0x1.b74004p-27f, - -0x1.0a0fd4p-3f, 0x1p0f, -0x1.f8ba4ep-2f, 0x1.01d952p-28f, - -0x1.e3a688p-4f, 0x1p0f, -0x1.e2b5d4p-2f, 0x1.fe4272p-28f, - -0x1.b55a7p-4f, 0x1p0f, -0x1.cc66eap-2f, 0x1.b38ee8p-28f, - -0x1.894286p-4f, 0x1p0f, -0x1.b5d1p-2f, -0x1.3c2b98p-27f, - -0x1.5f6598p-4f, 0x1p0f, -0x1.9ef794p-2f, -0x1.d476c6p-29f, - -0x1.37ca18p-4f, 0x1p0f, -0x1.87de2ap-2f, -0x1.abaa58p-28f, - -0x1.127624p-4f, 0x1p0f, -0x1.708854p-2f, 0x1.e0b74cp-27f, - -0x1.dedefcp-5f, 0x1p0f, -0x1.58f9a8p-2f, 0x1.4a9c04p-27f, - -0x1.9d7714p-5f, 0x1p0f, -0x1.4135cap-2f, 0x1.7d134p-27f, - -0x1.60beaap-5f, 0x1p0f, -0x1.294062p-2f, -0x1.dab3ep-27f, - -0x1.28bf18p-5f, 0x1p0f, -0x1.111d26p-2f, -0x1.58fb3cp-29f, - -0x1.eb0208p-6f, 0x1p0f, -0x1.f19f98p-3f, 0x1.37a83ap-29f, - -0x1.8e18a8p-6f, 0x1p0f, -0x1.c0b826p-3f, -0x1.4fc9ecp-28f, - -0x1.3ad06p-6f, 0x1p0f, -0x1.8f8b84p-3f, 0x1.cb2cfap-30f, - -0x1.e26c16p-7f, 0x1p0f, -0x1.5e2144p-3f, -0x1.22cff2p-29f, - -0x1.62aa04p-7f, 0x1p0f, -0x1.2c8106p-3f, -0x1.d1cc28p-28f, - -0x1.ecdc78p-8f, 0x1p0f, -0x1.f564e6p-4f, 0x1.2ad19ep-29f, - -0x1.3b92e2p-8f, 0x1p0f, -0x1.917a6cp-4f, 0x1.eb25eap-31f, - -0x1.63253p-9f, 0x1p0f, -0x1.2d520ap-4f, 0x1.a63cc2p-29f, - -0x1.3bc39p-10f, 0x1p0f, -0x1.91f66p-5f, 0x1.de44fep-30f, - -0x1.3bcfbep-12f, 0x1p0f, -0x1.92156p-6f, 0x1.0b933p-31f, - 0.0f, 0x1p0f, 0.0f, 0.0f, - -0x1.3bcfbep-12f, 0x1p0f, 0x1.92156p-6f, -0x1.0b933p-31f, - -0x1.3bc39p-10f, 0x1p0f, 0x1.91f66p-5f, -0x1.de44fep-30f, - -0x1.63253p-9f, 0x1p0f, 0x1.2d520ap-4f, -0x1.a63cc2p-29f, - -0x1.3b92e2p-8f, 0x1p0f, 0x1.917a6cp-4f, -0x1.eb25eap-31f, - -0x1.ecdc78p-8f, 0x1p0f, 0x1.f564e6p-4f, -0x1.2ad19ep-29f, - -0x1.62aa04p-7f, 0x1p0f, 0x1.2c8106p-3f, 0x1.d1cc28p-28f, - -0x1.e26c16p-7f, 0x1p0f, 0x1.5e2144p-3f, 0x1.22cff2p-29f, - -0x1.3ad06p-6f, 0x1p0f, 0x1.8f8b84p-3f, -0x1.cb2cfap-30f, - -0x1.8e18a8p-6f, 0x1p0f, 0x1.c0b826p-3f, 0x1.4fc9ecp-28f, - -0x1.eb0208p-6f, 0x1p0f, 0x1.f19f98p-3f, -0x1.37a83ap-29f, - -0x1.28bf18p-5f, 0x1p0f, 0x1.111d26p-2f, 0x1.58fb3cp-29f, - -0x1.60beaap-5f, 0x1p0f, 0x1.294062p-2f, 0x1.dab3ep-27f, - -0x1.9d7714p-5f, 0x1p0f, 0x1.4135cap-2f, -0x1.7d134p-27f, - -0x1.dedefcp-5f, 0x1p0f, 0x1.58f9a8p-2f, -0x1.4a9c04p-27f, - -0x1.127624p-4f, 0x1p0f, 0x1.708854p-2f, -0x1.e0b74cp-27f, - -0x1.37ca18p-4f, 0x1p0f, 0x1.87de2ap-2f, 0x1.abaa58p-28f, - -0x1.5f6598p-4f, 0x1p0f, 0x1.9ef794p-2f, 0x1.d476c6p-29f, - -0x1.894286p-4f, 0x1p0f, 0x1.b5d1p-2f, 0x1.3c2b98p-27f, - -0x1.b55a7p-4f, 0x1p0f, 0x1.cc66eap-2f, -0x1.b38ee8p-28f, - -0x1.e3a688p-4f, 0x1p0f, 0x1.e2b5d4p-2f, -0x1.fe4272p-28f, - -0x1.0a0fd4p-3f, 0x1p0f, 0x1.f8ba4ep-2f, -0x1.01d952p-28f, - -0x1.235f2ep-3f, 0x1p0f, 0x1.07387ap-1f, -0x1.b74004p-27f, - -0x1.3dbd6ap-3f, 0x1p0f, 0x1.11eb36p-1f, -0x1.7c969cp-26f, - -0x1.592676p-3f, 0x1p0f, 0x1.1c73b4p-1f, -0x1.9465cep-27f, - -0x1.759618p-3f, 0x1p0f, 0x1.26d054p-1f, 0x1.9ba25cp-26f, - -0x1.9307eep-3f, 0x1p0f, 0x1.30ff8p-1f, -0x1.8f47e6p-28f, - -0x1.b1776ep-3f, 0x1p0f, 0x1.3affa2p-1f, 0x1.240a18p-26f, - -0x1.d0dfe6p-3f, 0x1p0f, 0x1.44cf32p-1f, 0x1.424776p-27f, - -0x1.f13c7ep-3f, 0x1p0f, 0x1.4e6cacp-1f, -0x1.070686p-27f, - -0x1.09441cp-2f, 0x1p0f, 0x1.57d694p-1f, -0x1.6e626cp-26f, - -0x1.1a5efap-2f, 0x1p0f, 0x1.610b76p-1f, -0x1.5c5a64p-26f, - -0x1.2bec34p-2f, 0x1p0f, 0x1.6a09e6p-1f, 0x1.9fcef4p-27f, - -0x1.3de916p-2f, 0x1p0f, 0x1.72d084p-1f, -0x1.02000ep-26f, - -0x1.5052dap-2f, 0x1p0f, 0x1.7b5df2p-1f, 0x1.3557d8p-28f, - -0x1.6326a8p-2f, 0x1p0f, 0x1.83b0ep-1f, 0x1.7ff2eep-26f, - -0x1.76619cp-2f, 0x1p0f, 0x1.8bc806p-1f, 0x1.62a2e8p-26f, - -0x1.8a00bap-2f, 0x1p0f, 0x1.93a224p-1f, 0x1.324c8p-26f, - -0x1.9e01p-2f, 0x1p0f, 0x1.9b3e04p-1f, 0x1.fce1dp-27f, - -0x1.b25f56p-2f, 0x1p0f, 0x1.a29a7ap-1f, 0x1.189e08p-31f, - -0x1.c71898p-2f, 0x1p0f, 0x1.a9b662p-1f, 0x1.21d434p-26f, - -0x1.dc2996p-2f, 0x1p0f, 0x1.b090a6p-1f, -0x1.fabf8p-27f, - -0x1.f18f0cp-2f, 0x1p0f, 0x1.b72834p-1f, 0x1.465b9p-27f, - -0x1.d16c9p-8f, 0x1p-1f, 0x1.bd7c0ap-1f, 0x1.8df2a6p-26f, - -0x1.d4a2c8p-6f, 0x1p-1f, 0x1.c38b3p-1f, -0x1.cfe84ap-26f, - -0x1.9cc8b4p-5f, 0x1p-1f, 0x1.c954b2p-1f, 0x1.3411f4p-29f, - -0x1.28bbfep-4f, 0x1p-1f, 0x1.ced7bp-1f, -0x1.786712p-26f, - -0x1.8421bp-4f, 0x1p-1f, 0x1.d4134ep-1f, -0x1.d646d8p-26f, - -0x1.e08756p-4f, 0x1p-1f, 0x1.d906bcp-1f, 0x1.e651a8p-26f, - -0x1.1eef5ap-3f, 0x1p-1f, 0x1.ddb13cp-1f, -0x1.2667b8p-26f, - -0x1.4e0cb2p-3f, 0x1p-1f, 0x1.e2121p-1f, 0x1.3da1bap-27f, - -0x1.7d946ep-3f, 0x1p-1f, 0x1.e6288ep-1f, 0x1.891c22p-26f, - -0x1.ad7f3ap-3f, 0x1p-1f, 0x1.e9f416p-1f, -0x1.273a44p-26f, - -0x1.ddc5b4p-3f, 0x1p-1f, 0x1.ed740ep-1f, 0x1.da1258p-27f, - -0x1.cc0d0ap-8f, 0x1p-2f, 0x1.f0a7fp-1f, -0x1.1b73cap-27f, - -0x1.fa3ecap-6f, 0x1p-2f, 0x1.f38f3ap-1f, 0x1.8c9cb2p-26f, - -0x1.c1d1fp-5f, 0x1p-2f, 0x1.f6297cp-1f, 0x1.feeb96p-26f, - -0x1.43bd78p-4f, 0x1p-2f, 0x1.f8765p-1f, -0x1.63ad16p-27f, - -0x1.a6fdf2p-4f, 0x1p-2f, 0x1.fa7558p-1f, -0x1.eeb5d2p-30f, - -0x1.536352p-9f, 0x1p-3f, 0x1.fc2648p-1f, -0x1.e3cc06p-26f, - -0x1.ba165p-6f, 0x1p-3f, 0x1.fd88dap-1f, 0x1.e89292p-28f, - -0x1.a55beep-5f, 0x1p-3f, 0x1.fe9cdap-1f, 0x1.a03108p-26f, - -0x1.b82684p-7f, 0x1p-4f, 0x1.ff621ep-1f, 0x1.bcb6bep-28f, - -0x1.b7aa82p-8f, 0x1p-5f, 0x1.ffd886p-1f, 0x1.099a1ap-30f, -}; - -template <> constexpr double kCosApproxTable[] = -{ - 0, 0, 0x1p0, 0, - -0x1.000c90e8fe6f6p6, 0x1p6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, - -0x1.003242abef46dp5, 0x1p5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, - -0x1.0096c32baca2bp4, 0x1p4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, - -0x1.00c8fb2f886ecp4, 0x1p4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, - -0x1.00fb2b73cfc1p4, 0x1p4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, - -0x1.025aa41259c34p3, 0x1p3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, - -0x1.02beda0153548p3, 0x1p3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, - -0x1.0322f4d785368p3, 0x1p3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, - -0x1.0386f0b8f3d86p3, 0x1p3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, - -0x1.03eac9cad52e6p3, 0x1p3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, - -0x1.089cf8676d7acp2, 0x1p2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, - -0x1.096408374730ap2, 0x1p2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, - -0x1.0a2abb58949f3p2, 0x1p2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, - -0x1.0af10a22459fep2, 0x1p2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, - -0x1.0bb6ecef285fap2, 0x1p2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, - -0x1.0c7c5c1e34d3p2, 0x1p2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, - -0x1.0d415012d8023p2, 0x1p2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, - -0x1.0e05c1353f27bp2, 0x1p2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, - -0x1.0ec9a7f2a2a19p2, 0x1p2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, - -0x1.0f8cfcbd90af9p2, 0x1p2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, - -0x1.209f701c6ffb6p1, 0x1p1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, - -0x1.2223a4c563ecfp1, 0x1p1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, - -0x1.23a6887e99b68p1, 0x1p1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, - -0x1.25280c5dab3e1p1, 0x1p1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, - -0x1.26a82185c302ap1, 0x1p1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, - -0x1.2826b9282eccp1, 0x1p1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, - -0x1.29a3c484f1cedp1, 0x1p1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, - -0x1.2b1f34eb563fcp1, 0x1p1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, - -0x1.2c98fbba7e4f9p1, 0x1p1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, - -0x1.2e110a61f48b4p1, 0x1p1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, - -0x1.2f8752623b99dp1, 0x1p1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, - -0x1.30fbc54d5d52cp1, 0x1p1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, - -0x1.326e54c77927bp1, 0x1p1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, - -0x1.33def28751db1p1, 0x1p1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, - -0x1.354d9056da7f9p1, 0x1p1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, - -0x1.36ba2013c2b98p1, 0x1p1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, - -0x1.382493b0023ddp1, 0x1p1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, - -0x1.398cdd326388cp1, 0x1p1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, - -0x1.3af2eeb70dc71p1, 0x1p1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, - -0x1.3c56ba700dec7p1, 0x1p1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, - -0x1.3db832a5def1bp1, 0x1p1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, - -0x1.3f1749b7f1357p1, 0x1p1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, - -0x1.80e7e43a61f5bp0, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, - -0x1.839c3cc917ff7p0, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, - -0x1.864b826aec4c7p0, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, - -0x1.88f59aa0da591p0, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, - -0x1.8b9a6b1ef6da4p0, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, - -0x1.8e39d9cd73464p0, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, - -0x1.90d3ccc99f5acp0, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, - -0x1.93682a66e896fp0, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, - -0x1.95f6d92fd79f5p0, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, - -0x1.987fbfe70b81ap0, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, - -0x1.9b02c58832cf9p0, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, - -0x1.9d7fd1490285dp0, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, - -0x1.9ff6ca9a2ab6ap0, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, - -0x1.a267992848eebp0, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, - -0x1.a4d224dcd849cp0, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, - -0x1.a73655df1f2f5p0, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, - -0x1.a99414951aacbp0, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, - -0x1.abeb49a46765p0, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, - -0x1.ae3bddf3280c6p0, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, - -0x1.b085baa8e966fp0, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, - -0x1.b2c8c92f83c1fp0, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, - -0x1.b504f333f9de6p0, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, - -0x1.b73a22a755457p0, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, - -0x1.b96841bf7ffcbp0, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, - -0x1.bb8f3af81b931p0, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, - -0x1.bdaef913557d7p0, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, - -0x1.bfc7671ab8bb8p0, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, - -0x1.c1d8705ffcbb7p0, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, - -0x1.c3e2007dd175fp0, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, - -0x1.c5e40358a8bap0, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, - -0x1.c7de651f7ca06p0, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, - -0x1.c9d1124c931fep0, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, - -0x1.cbbbf7a63eba1p0, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, - -0x1.cd9f023f9c3ap0, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, - -0x1.cf7a1f794d7cap0, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, - -0x1.d14d3d02313c1p0, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, - -0x1.d31848d817d71p0, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, - -0x1.d4db3148750d2p0, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, - -0x1.d695e4f10ea88p0, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, - -0x1.d84852c0a81p0, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, - -0x1.d9f269f7aab89p0, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, - -0x1.db941a28cb71fp0, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, - -0x1.dd2d5339ac869p0, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, - -0x1.debe05637ca95p0, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, - -0x1.e046213392aa5p0, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, - -0x1.e1c5978c05ed8p0, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, - -0x1.e33c59a4439cep0, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, - -0x1.e4aa5909a08fap0, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, - -0x1.e60f879fe7e2ep0, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, - -0x1.e76bd7a1e63b9p0, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, - -0x1.e8bf3ba1f1aeep0, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, - -0x1.ea09a68a6e49dp0, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, - -0x1.eb4b0b9e4f345p0, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, - -0x1.ec835e79946a3p0, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, - -0x1.edb29311c504dp0, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, - -0x1.eed89db66611ep0, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, - -0x1.eff573116df15p0, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, - -0x1.f1090827b4372p0, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, - -0x1.f21352595e0bfp0, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, - -0x1.f314476247089p0, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, - -0x1.f40bdd5a66886p0, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, - -0x1.f4fa0ab6316edp0, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, - -0x1.f5dec646f85bap0, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, - -0x1.f6ba073b424b2p0, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, - -0x1.f78bc51f239e1p0, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, - -0x1.f853f7dc9186cp0, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, - -0x1.f91297bbb1d6dp0, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, - -0x1.f9c79d63272c4p0, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, - -0x1.fa7301d859796p0, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, - -0x1.fb14be7fbae58p0, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, - -0x1.fbaccd1d0903cp0, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, - -0x1.fc3b27d38a5d5p0, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, - -0x1.fcbfc926484cdp0, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, - -0x1.fd3aabf84528bp0, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, - -0x1.fdabcb8caeba1p0, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, - -0x1.fe1323870cfeap0, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, - -0x1.fe70afeb6d33dp0, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, - -0x1.fec46d1e89293p0, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, - -0x1.ff0e57e5ead85p0, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, - -0x1.ff4e6d680c41dp0, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, - -0x1.ff84ab2c738d7p0, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, - -0x1.ffb10f1bcb6bfp0, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, - -0x1.ffd3977ff7baep0, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, - -0x1.ffec430426686p0, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, - -0x1.fffb10b4dc96ep0, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, - -0x1p1, 0x1p0, 0, 0, - -0x1.fffb10b4dc96ep0, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, - -0x1.ffec430426686p0, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, - -0x1.ffd3977ff7baep0, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, - -0x1.ffb10f1bcb6bfp0, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, - -0x1.ff84ab2c738d7p0, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, - -0x1.ff4e6d680c41dp0, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, - -0x1.ff0e57e5ead85p0, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, - -0x1.fec46d1e89293p0, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, - -0x1.fe70afeb6d33dp0, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, - -0x1.fe1323870cfeap0, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, - -0x1.fdabcb8caeba1p0, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, - -0x1.fd3aabf84528bp0, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, - -0x1.fcbfc926484cdp0, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, - -0x1.fc3b27d38a5d5p0, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, - -0x1.fbaccd1d0903cp0, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, - -0x1.fb14be7fbae58p0, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, - -0x1.fa7301d859796p0, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, - -0x1.f9c79d63272c4p0, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, - -0x1.f91297bbb1d6dp0, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, - -0x1.f853f7dc9186cp0, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, - -0x1.f78bc51f239e1p0, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, - -0x1.f6ba073b424b2p0, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, - -0x1.f5dec646f85bap0, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, - -0x1.f4fa0ab6316edp0, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, - -0x1.f40bdd5a66886p0, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, - -0x1.f314476247089p0, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, - -0x1.f21352595e0bfp0, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, - -0x1.f1090827b4372p0, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, - -0x1.eff573116df15p0, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, - -0x1.eed89db66611ep0, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, - -0x1.edb29311c504dp0, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, - -0x1.ec835e79946a3p0, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, - -0x1.eb4b0b9e4f345p0, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, - -0x1.ea09a68a6e49dp0, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, - -0x1.e8bf3ba1f1aeep0, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, - -0x1.e76bd7a1e63b9p0, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, - -0x1.e60f879fe7e2ep0, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, - -0x1.e4aa5909a08fap0, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, - -0x1.e33c59a4439cep0, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, - -0x1.e1c5978c05ed8p0, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, - -0x1.e046213392aa5p0, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, - -0x1.debe05637ca95p0, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, - -0x1.dd2d5339ac869p0, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, - -0x1.db941a28cb71fp0, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, - -0x1.d9f269f7aab89p0, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, - -0x1.d84852c0a81p0, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, - -0x1.d695e4f10ea88p0, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, - -0x1.d4db3148750d2p0, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, - -0x1.d31848d817d71p0, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, - -0x1.d14d3d02313c1p0, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, - -0x1.cf7a1f794d7cap0, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, - -0x1.cd9f023f9c3ap0, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, - -0x1.cbbbf7a63eba1p0, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, - -0x1.c9d1124c931fep0, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, - -0x1.c7de651f7ca06p0, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, - -0x1.c5e40358a8bap0, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, - -0x1.c3e2007dd175fp0, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, - -0x1.c1d8705ffcbb7p0, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, - -0x1.bfc7671ab8bb8p0, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, - -0x1.bdaef913557d7p0, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, - -0x1.bb8f3af81b931p0, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, - -0x1.b96841bf7ffcbp0, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, - -0x1.b73a22a755457p0, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, - -0x1.b504f333f9de6p0, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, - -0x1.b2c8c92f83c1fp0, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, - -0x1.b085baa8e966fp0, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, - -0x1.ae3bddf3280c6p0, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, - -0x1.abeb49a46765p0, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, - -0x1.a99414951aacbp0, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, - -0x1.a73655df1f2f5p0, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, - -0x1.a4d224dcd849cp0, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, - -0x1.a267992848eebp0, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, - -0x1.9ff6ca9a2ab6ap0, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, - -0x1.9d7fd1490285dp0, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, - -0x1.9b02c58832cf9p0, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, - -0x1.987fbfe70b81ap0, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, - -0x1.95f6d92fd79f5p0, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, - -0x1.93682a66e896fp0, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, - -0x1.90d3ccc99f5acp0, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, - -0x1.8e39d9cd73464p0, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, - -0x1.8b9a6b1ef6da4p0, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, - -0x1.88f59aa0da591p0, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, - -0x1.864b826aec4c7p0, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, - -0x1.839c3cc917ff7p0, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, - -0x1.80e7e43a61f5bp0, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, - -0x1.3f1749b7f1357p1, 0x1p1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, - -0x1.3db832a5def1bp1, 0x1p1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, - -0x1.3c56ba700dec7p1, 0x1p1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, - -0x1.3af2eeb70dc71p1, 0x1p1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, - -0x1.398cdd326388cp1, 0x1p1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, - -0x1.382493b0023ddp1, 0x1p1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, - -0x1.36ba2013c2b98p1, 0x1p1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, - -0x1.354d9056da7f9p1, 0x1p1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, - -0x1.33def28751db1p1, 0x1p1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, - -0x1.326e54c77927bp1, 0x1p1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, - -0x1.30fbc54d5d52cp1, 0x1p1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, - -0x1.2f8752623b99dp1, 0x1p1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, - -0x1.2e110a61f48b4p1, 0x1p1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, - -0x1.2c98fbba7e4f9p1, 0x1p1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, - -0x1.2b1f34eb563fcp1, 0x1p1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, - -0x1.29a3c484f1cedp1, 0x1p1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, - -0x1.2826b9282eccp1, 0x1p1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, - -0x1.26a82185c302ap1, 0x1p1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, - -0x1.25280c5dab3e1p1, 0x1p1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, - -0x1.23a6887e99b68p1, 0x1p1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, - -0x1.2223a4c563ecfp1, 0x1p1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, - -0x1.209f701c6ffb6p1, 0x1p1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, - -0x1.0f8cfcbd90af9p2, 0x1p2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, - -0x1.0ec9a7f2a2a19p2, 0x1p2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, - -0x1.0e05c1353f27bp2, 0x1p2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, - -0x1.0d415012d8023p2, 0x1p2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, - -0x1.0c7c5c1e34d3p2, 0x1p2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, - -0x1.0bb6ecef285fap2, 0x1p2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, - -0x1.0af10a22459fep2, 0x1p2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, - -0x1.0a2abb58949f3p2, 0x1p2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, - -0x1.096408374730ap2, 0x1p2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, - -0x1.089cf8676d7acp2, 0x1p2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, - -0x1.03eac9cad52e6p3, 0x1p3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, - -0x1.0386f0b8f3d86p3, 0x1p3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, - -0x1.0322f4d785368p3, 0x1p3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, - -0x1.02beda0153548p3, 0x1p3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, - -0x1.025aa41259c34p3, 0x1p3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, - -0x1.00fb2b73cfc1p4, 0x1p4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, - -0x1.00c8fb2f886ecp4, 0x1p4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, - -0x1.0096c32baca2bp4, 0x1p4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, - -0x1.003242abef46dp5, 0x1p5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, - -0x1.000c90e8fe6f6p6, 0x1p6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, - 0, 0, -0x1p0, 0, - -0x1.b78b80c84e1eep-9, 0x1p-6, -0x1.fff62169b92dbp-1, -0x1.5dda3cp-55, - -0x1.b7aa821726608p-8, 0x1p-5, -0x1.ffd886084cd0dp-1, 0x1.1354d4p-55, - -0x1.a4f3514d75466p-6, 0x1p-4, -0x1.ffa72effef75dp-1, 0x1.8b4cdcp-55, - -0x1.b82683bc89fbp-7, 0x1p-4, -0x1.ff621e3796d7ep-1, 0x1.c57bc2p-57, - -0x1.35230c0fbe402p-10, 0x1p-4, -0x1.ff095658e71adp-1, -0x1.01a8cep-55, - -0x1.a55beda63cc14p-5, 0x1p-3, -0x1.fe9cdad01883ap-1, -0x1.521eccp-57, - -0x1.4125feacab7cep-5, 0x1p-3, -0x1.fe1cafcbd5b09p-1, -0x1.a23e32p-57, - -0x1.ba1650f592f5p-6, 0x1p-3, -0x1.fd88da3d12526p-1, 0x1.87df62p-55, - -0x1.e43d1c309e958p-7, 0x1p-3, -0x1.fce15fd6da67bp-1, 0x1.5dd6f8p-56, - -0x1.536352ad19e39p-9, 0x1p-3, -0x1.fc26470e19fd3p-1, -0x1.1ec866p-55, - -0x1.d8c1e624a1513p-4, 0x1p-2, -0x1.fb5797195d741p-1, -0x1.1bfac6p-56, - -0x1.a6fdf22e33d8cp-4, 0x1p-2, -0x1.fa7557f08a517p-1, 0x1.7a0a8cp-55, - -0x1.755129dad834cp-4, 0x1p-2, -0x1.f97f924c9099bp-1, 0x1.e2ae0ep-55, - -0x1.43bd776e98073p-4, 0x1p-2, -0x1.f8764fa714ba9p-1, -0x1.ab2566p-56, - -0x1.1244c435e819dp-4, 0x1p-2, -0x1.f7599a3a12077p-1, -0x1.84f31cp-55, - -0x1.c1d1f0e5967d5p-5, 0x1p-2, -0x1.f6297cff75cbp-1, -0x1.562172p-56, - -0x1.5f57f693feebep-5, 0x1p-2, -0x1.f4e603b0b2f2dp-1, 0x1.8ee01ep-56, - -0x1.fa3ecac0d84e8p-6, 0x1p-2, -0x1.f38f3ac64e589p-1, 0x1.d7bafap-56, - -0x1.36580d5d5e775p-6, 0x1p-2, -0x1.f2252f7763adap-1, 0x1.20cb8p-55, - -0x1.cc0d09bd41caap-8, 0x1p-2, -0x1.f0a7efb9230d7p-1, -0x1.52c7acp-56, - -0x1.f608fe39004a4p-3, 0x1p-1, -0x1.ef178a3e473c2p-1, -0x1.6310a6p-55, - -0x1.ddc5b3a9c1311p-3, 0x1p-1, -0x1.ed740e7684963p-1, -0x1.e82c78p-56, - -0x1.c597781664984p-3, 0x1p-1, -0x1.ebbd8c8df0b74p-1, -0x1.c6c8c6p-56, - -0x1.ad7f3a254c1f5p-3, 0x1p-1, -0x1.e9f4156c62ddap-1, -0x1.760b1ep-55, - -0x1.957de7a3cfd5dp-3, 0x1p-1, -0x1.e817bab4cd10dp-1, 0x1.d0afe6p-56, - -0x1.7d946d7d133fdp-3, 0x1p-1, -0x1.e6288ec48e112p-1, 0x1.16b56ep-57, - -0x1.65c3b7b0e312cp-3, 0x1p-1, -0x1.e426a4b2bc17ep-1, -0x1.a87388p-55, - -0x1.4e0cb14a9c046p-3, 0x1p-1, -0x1.e212104f686e5p-1, 0x1.014c76p-55, - -0x1.367044581b074p-3, 0x1p-1, -0x1.dfeae622dbe2bp-1, 0x1.514ea8p-55, - -0x1.1eef59e0b74c3p-3, 0x1p-1, -0x1.ddb13b6ccc23cp-1, -0x1.83c37cp-55, - -0x1.078ad9dc46632p-3, 0x1p-1, -0x1.db6526238a09bp-1, 0x1.adee7ep-56, - -0x1.e087565455a75p-4, 0x1p-1, -0x1.d906bcf328d46p-1, -0x1.457e6p-56, - -0x1.b2356710db0a3p-4, 0x1p-1, -0x1.d696173c9e68bp-1, 0x1.e8c61cp-56, - -0x1.8421af15c49d7p-4, 0x1p-1, -0x1.d4134d14dc93ap-1, 0x1.4ef528p-55, - -0x1.564df524b00dap-4, 0x1p-1, -0x1.d17e7743e35dcp-1, 0x1.101da2p-58, - -0x1.28bbfd87a8cffp-4, 0x1p-1, -0x1.ced7af43cc773p-1, 0x1.e7b6bap-58, - -0x1.f6db13ff708cbp-5, 0x1p-1, -0x1.cc1f0f3fcfc5cp-1, -0x1.e57612p-56, - -0x1.9cc8b3671dd0fp-5, 0x1p-1, -0x1.c954b213411f5p-1, 0x1.2fb76p-58, - -0x1.4344523c8e3b5p-5, 0x1p-1, -0x1.c678b3488739bp-1, -0x1.d86cacp-57, - -0x1.d4a2c7f909c4ep-6, 0x1p-1, -0x1.c38b2f180bdb1p-1, 0x1.6e0b16p-56, - -0x1.23e6ad10872a7p-6, 0x1p-1, -0x1.c08c426725549p-1, -0x1.b157fcp-58, - -0x1.d16c901d95181p-8, 0x1p-1, -0x1.bd7c0ac6f952ap-1, 0x1.825a72p-55, - -0x1.fc606f1678292p-2, 0x1p0, -0x1.ba5aa673590d2p-1, -0x1.7ea4e2p-55, - -0x1.f18f0cdba0025p-2, 0x1p0, -0x1.b728345196e3ep-1, 0x1.bc69f2p-55, - -0x1.e6d1f6544ece3p-2, 0x1p0, -0x1.b3e4d3ef55712p-1, 0x1.eb6b8ap-55, - -0x1.dc29957c969bbp-2, 0x1p0, -0x1.b090a581502p-1, 0x1.926da2p-55, - -0x1.d19653842496fp-2, 0x1p0, -0x1.ad2bc9e21d511p-1, 0x1.47fbep-55, - -0x1.c71898ca32e6fp-2, 0x1p0, -0x1.a9b66290ea1a3p-1, -0x1.9f630ep-60, - -0x1.bcb0ccd98294fp-2, 0x1p0, -0x1.a63091b02fae2p-1, 0x1.e91114p-56, - -0x1.b25f56645da43p-2, 0x1p0, -0x1.a29a7a0462782p-1, 0x1.128bbp-56, - -0x1.a8249b40a182cp-2, 0x1p0, -0x1.9ef43ef29af94p-1, -0x1.b1dfcap-56, - -0x1.9e010063d1f96p-2, 0x1p0, -0x1.9b3e047f38741p-1, 0x1.30ee28p-55, - -0x1.93f4e9df34c1bp-2, 0x1p0, -0x1.9777ef4c7d742p-1, 0x1.15479ap-55, - -0x1.8a00badbf5e8ep-2, 0x1p0, -0x1.93a22499263fbp-1, -0x1.3d419ap-55, - -0x1.8024d59755257p-2, 0x1p0, -0x1.8fbcca3ef940dp-1, 0x1.6dfa98p-57, - -0x1.76619b5edc454p-2, 0x1p0, -0x1.8bc806b151741p-1, 0x1.2c5e12p-55, - -0x1.6cb76c8c9ed8fp-2, 0x1p0, -0x1.87c400fba2ebfp-1, 0x1.2dabcp-55, - -0x1.6326a8838342ep-2, 0x1p0, -0x1.83b0e0bff976ep-1, 0x1.6f420ep-56, - -0x1.59afadab954d4p-2, 0x1p0, -0x1.7f8ece3571771p-1, 0x1.9c8d8cp-55, - -0x1.5052d96e626c1p-2, 0x1p0, -0x1.7b5df226aafafp-1, 0x1.0f537ap-56, - -0x1.471088335fce7p-2, 0x1p0, -0x1.771e75f037261p-1, -0x1.5cfce8p-56, - -0x1.3de9155c5a642p-2, 0x1p0, -0x1.72d0837efff96p-1, -0x1.0d4efp-55, - -0x1.34dcdb41f0f85p-2, 0x1p0, -0x1.6e74454eaa8afp-1, 0x1.dbc03cp-55, - -0x1.2bec333018867p-2, 0x1p0, -0x1.6a09e667f3bcdp-1, 0x1.bdd34p-55, - -0x1.23177562aaea3p-2, 0x1p0, -0x1.6591925f0783dp-1, -0x1.c3d64ep-55, - -0x1.1a5ef902000d3p-2, 0x1p0, -0x1.610b7551d2cdfp-1, 0x1.251b34p-56, - -0x1.11c3141f91b3ep-2, 0x1p0, -0x1.5c77bbe65018cp-1, -0x1.069ea8p-55, - -0x1.09441bb2aa0a2p-2, 0x1p0, -0x1.57d69348cecap-1, 0x1.757208p-55, - -0x1.00e263951d11fp-2, 0x1p0, -0x1.5328292a35596p-1, 0x1.a12eb8p-56, - -0x1.f13c7d001a249p-3, 0x1p0, -0x1.4e6cabbe3e5e9p-1, -0x1.3c293ep-57, - -0x1.e0effc1174505p-3, 0x1p0, -0x1.49a449b9b0939p-1, 0x1.27ee16p-55, - -0x1.d0dfe53aba2fdp-3, 0x1p0, -0x1.44cf325091dd6p-1, -0x1.8076a2p-57, - -0x1.c10cd7041afccp-3, 0x1p0, -0x1.3fed9534556d4p-1, -0x1.369166p-55, - -0x1.b1776d9b67013p-3, 0x1p0, -0x1.3affa292050b9p-1, -0x1.e3e25ep-56, - -0x1.a22042ce0a2f9p-3, 0x1p0, -0x1.36058b10659f3p-1, 0x1.1fcb3ap-55, - -0x1.9307ee031e2fdp-3, 0x1p0, -0x1.30ff7fce17035p-1, 0x1.efcc62p-57, - -0x1.842f0435941afp-3, 0x1p0, -0x1.2bedb25faf3eap-1, 0x1.14981cp-58, - -0x1.759617ee761f9p-3, 0x1p0, -0x1.26d054cdd12dfp-1, 0x1.5da742p-55, - -0x1.673db93f41479p-3, 0x1p0, -0x1.21a799933eb59p-1, 0x1.3a7b16p-55, - -0x1.592675bc57974p-3, 0x1p0, -0x1.1c73b39ae68c8p-1, -0x1.b25dd2p-55, - -0x1.4b50d8778abbdp-3, 0x1p0, -0x1.1734d63dedb49p-1, 0x1.7eef2cp-55, - -0x1.3dbd69fabf802p-3, 0x1p0, -0x1.11eb3541b4b23p-1, 0x1.ef23b6p-55, - -0x1.306cb042aa3bap-3, 0x1p0, -0x1.0c9704d5d898fp-1, 0x1.8d3d7cp-55, - -0x1.235f2eb9a470ap-3, 0x1p0, -0x1.073879922ffeep-1, 0x1.a5a014p-55, - -0x1.169566329bcb7p-3, 0x1p0, -0x1.01cfc874c3eb7p-1, 0x1.34a35ep-56, - -0x1.0a0fd4e41ab5ap-3, 0x1p0, -0x1.f8ba4dbf89abap-2, 0x1.2ec1fcp-60, - -0x1.fb9decc6d55b8p-4, 0x1p0, -0x1.edc1952ef78d6p-2, 0x1.dd0f7cp-56, - -0x1.e3a6873fa1279p-4, 0x1p0, -0x1.e2b5d3806f63bp-2, -0x1.e0d89p-58, - -0x1.cc3a65bbc6327p-4, 0x1p0, -0x1.d79775b86e389p-2, -0x1.550ec8p-56, - -0x1.b55a6f65f7058p-4, 0x1p0, -0x1.cc66e9931c45ep-2, -0x1.6850e4p-58, - -0x1.9f07860181d1ep-4, 0x1p0, -0x1.c1249d8011ee7p-2, 0x1.813aaap-56, - -0x1.894285e19c468p-4, 0x1p0, -0x1.b5d1009e15ccp-2, -0x1.5b362cp-57, - -0x1.740c45e0e512p-4, 0x1p0, -0x1.aa6c82b6d3fcap-2, 0x1.d5f106p-56, - -0x1.5f6597591b633p-4, 0x1p0, -0x1.9ef7943a8ed8ap-2, -0x1.6da812p-57, - -0x1.4b4f461b0cbaap-4, 0x1p0, -0x1.9372a63bc93d7p-2, -0x1.684318p-57, - -0x1.37ca1866b95cfp-4, 0x1p0, -0x1.87de2a6aea963p-2, 0x1.72cedcp-57, - -0x1.24d6cee3afb2ap-4, 0x1p0, -0x1.7c3a9311dcce7p-2, -0x1.9a3f2p-62, - -0x1.127624999ee1dp-4, 0x1p0, -0x1.7088530fa459fp-2, 0x1.44b19ep-56, - -0x1.00a8cee920eabp-4, 0x1p0, -0x1.64c7ddd3f27c6p-2, -0x1.10d2b4p-58, - -0x1.dedefb09791b4p-5, 0x1p0, -0x1.58f9a75ab1fddp-2, 0x1.efdc0cp-62, - -0x1.bd95b4d43e819p-5, 0x1p0, -0x1.4d1e24278e76ap-2, -0x1.24172p-57, - -0x1.9d7713b71eee1p-5, 0x1p0, -0x1.4135c94176601p-2, -0x1.0c97c4p-56, - -0x1.7e8454b32ef34p-5, 0x1p0, -0x1.35410c2e18152p-2, 0x1.3cb002p-56, - -0x1.60bea939d225ap-5, 0x1p0, -0x1.294062ed59f06p-2, 0x1.5d28dap-56, - -0x1.44273720f48bcp-5, 0x1p0, -0x1.1d3443f4cdb3ep-2, 0x1.720d4p-57, - -0x1.28bf1897b69ccp-5, 0x1p0, -0x1.111d262b1f677p-2, -0x1.824c2p-56, - -0x1.0e875c1b8c3dap-5, 0x1p0, -0x1.04fb80e37fdaep-2, 0x1.412cdap-63, - -0x1.eb0208db9e51bp-6, 0x1p0, -0x1.f19f97b215f1bp-3, 0x1.42deeep-57, - -0x1.bb5a11138a4c9p-6, 0x1p0, -0x1.d934fe5454311p-3, -0x1.75b922p-57, - -0x1.8e18a73634ee7p-6, 0x1p0, -0x1.c0b826a7e4f63p-3, 0x1.af1438p-62, - -0x1.633f89e9a1a66p-6, 0x1p0, -0x1.a82a025b00451p-3, 0x1.87905ep-57, - -0x1.3ad06011469fbp-6, 0x1p0, -0x1.8f8b83c69a60bp-3, 0x1.26d19ap-57, - -0x1.14ccb8bdbf114p-6, 0x1p0, -0x1.76dd9de50bf31p-3, -0x1.1d5eeep-57, - -0x1.e26c163ad15b3p-7, 0x1p0, -0x1.5e214448b3fc6p-3, -0x1.531ff6p-57, - -0x1.a01b6cdbd995ep-7, 0x1p0, -0x1.45576b1293e5ap-3, 0x1.285a24p-58, - -0x1.62aa03dd6ba58p-7, 0x1p0, -0x1.2c8106e8e613ap-3, -0x1.13000ap-58, - -0x1.2a1a39a8a2fb7p-7, 0x1p0, -0x1.139f0cedaf577p-3, 0x1.523434p-57, - -0x1.ecdc78f30165cp-8, 0x1p0, -0x1.f564e56a9730ep-4, -0x1.a27046p-59, - -0x1.8f501492cc296p-8, 0x1p0, -0x1.c3785c79ec2d5p-4, 0x1.4f39dep-61, - -0x1.3b92e176d6d31p-8, 0x1p0, -0x1.917a6bc29b42cp-4, 0x1.e2718cp-60, - -0x1.e350342a4f6e6p-9, 0x1p0, -0x1.5f6d00a9aa419p-4, 0x1.f4022cp-59, - -0x1.63252fe77c5ebp-9, 0x1p0, -0x1.2d52092ce19f6p-4, 0x1.9a088ap-59, - -0x1.ed534e31ca57fp-10, 0x1p0, -0x1.f656e79f820ep-5, 0x1.2e1ebep-61, - -0x1.3bc390d250439p-10, 0x1p0, -0x1.91f65f10dd814p-5, 0x1.912bdp-61, - -0x1.6344004228d8bp-11, 0x1p0, -0x1.2d865759455cdp-5, -0x1.686f64p-61, - -0x1.3bcfbd9979a27p-12, 0x1p0, -0x1.92155f7a3667ep-6, 0x1.b1d63p-64, - -0x1.3bd2c8da49511p-14, 0x1p0, -0x1.921d1fcdec784p-7, -0x1.9878eap-61, - 0, 0x1p0, 0, 0, - -0x1.3bd2c8da49511p-14, 0x1p0, 0x1.921d1fcdec784p-7, 0x1.9878eap-61, - -0x1.3bcfbd9979a27p-12, 0x1p0, 0x1.92155f7a3667ep-6, -0x1.b1d63p-64, - -0x1.6344004228d8bp-11, 0x1p0, 0x1.2d865759455cdp-5, 0x1.686f64p-61, - -0x1.3bc390d250439p-10, 0x1p0, 0x1.91f65f10dd814p-5, -0x1.912bdp-61, - -0x1.ed534e31ca57fp-10, 0x1p0, 0x1.f656e79f820ep-5, -0x1.2e1ebep-61, - -0x1.63252fe77c5ebp-9, 0x1p0, 0x1.2d52092ce19f6p-4, -0x1.9a088ap-59, - -0x1.e350342a4f6e6p-9, 0x1p0, 0x1.5f6d00a9aa419p-4, -0x1.f4022cp-59, - -0x1.3b92e176d6d31p-8, 0x1p0, 0x1.917a6bc29b42cp-4, -0x1.e2718cp-60, - -0x1.8f501492cc296p-8, 0x1p0, 0x1.c3785c79ec2d5p-4, -0x1.4f39dep-61, - -0x1.ecdc78f30165cp-8, 0x1p0, 0x1.f564e56a9730ep-4, 0x1.a27046p-59, - -0x1.2a1a39a8a2fb7p-7, 0x1p0, 0x1.139f0cedaf577p-3, -0x1.523434p-57, - -0x1.62aa03dd6ba58p-7, 0x1p0, 0x1.2c8106e8e613ap-3, 0x1.13000ap-58, - -0x1.a01b6cdbd995ep-7, 0x1p0, 0x1.45576b1293e5ap-3, -0x1.285a24p-58, - -0x1.e26c163ad15b3p-7, 0x1p0, 0x1.5e214448b3fc6p-3, 0x1.531ff6p-57, - -0x1.14ccb8bdbf114p-6, 0x1p0, 0x1.76dd9de50bf31p-3, 0x1.1d5eeep-57, - -0x1.3ad06011469fbp-6, 0x1p0, 0x1.8f8b83c69a60bp-3, -0x1.26d19ap-57, - -0x1.633f89e9a1a66p-6, 0x1p0, 0x1.a82a025b00451p-3, -0x1.87905ep-57, - -0x1.8e18a73634ee7p-6, 0x1p0, 0x1.c0b826a7e4f63p-3, -0x1.af1438p-62, - -0x1.bb5a11138a4c9p-6, 0x1p0, 0x1.d934fe5454311p-3, 0x1.75b922p-57, - -0x1.eb0208db9e51bp-6, 0x1p0, 0x1.f19f97b215f1bp-3, -0x1.42deeep-57, - -0x1.0e875c1b8c3dap-5, 0x1p0, 0x1.04fb80e37fdaep-2, -0x1.412cdap-63, - -0x1.28bf1897b69ccp-5, 0x1p0, 0x1.111d262b1f677p-2, 0x1.824c2p-56, - -0x1.44273720f48bcp-5, 0x1p0, 0x1.1d3443f4cdb3ep-2, -0x1.720d4p-57, - -0x1.60bea939d225ap-5, 0x1p0, 0x1.294062ed59f06p-2, -0x1.5d28dap-56, - -0x1.7e8454b32ef34p-5, 0x1p0, 0x1.35410c2e18152p-2, -0x1.3cb002p-56, - -0x1.9d7713b71eee1p-5, 0x1p0, 0x1.4135c94176601p-2, 0x1.0c97c4p-56, - -0x1.bd95b4d43e819p-5, 0x1p0, 0x1.4d1e24278e76ap-2, 0x1.24172p-57, - -0x1.dedefb09791b4p-5, 0x1p0, 0x1.58f9a75ab1fddp-2, -0x1.efdc0cp-62, - -0x1.00a8cee920eabp-4, 0x1p0, 0x1.64c7ddd3f27c6p-2, 0x1.10d2b4p-58, - -0x1.127624999ee1dp-4, 0x1p0, 0x1.7088530fa459fp-2, -0x1.44b19ep-56, - -0x1.24d6cee3afb2ap-4, 0x1p0, 0x1.7c3a9311dcce7p-2, 0x1.9a3f2p-62, - -0x1.37ca1866b95cfp-4, 0x1p0, 0x1.87de2a6aea963p-2, -0x1.72cedcp-57, - -0x1.4b4f461b0cbaap-4, 0x1p0, 0x1.9372a63bc93d7p-2, 0x1.684318p-57, - -0x1.5f6597591b633p-4, 0x1p0, 0x1.9ef7943a8ed8ap-2, 0x1.6da812p-57, - -0x1.740c45e0e512p-4, 0x1p0, 0x1.aa6c82b6d3fcap-2, -0x1.d5f106p-56, - -0x1.894285e19c468p-4, 0x1p0, 0x1.b5d1009e15ccp-2, 0x1.5b362cp-57, - -0x1.9f07860181d1ep-4, 0x1p0, 0x1.c1249d8011ee7p-2, -0x1.813aaap-56, - -0x1.b55a6f65f7058p-4, 0x1p0, 0x1.cc66e9931c45ep-2, 0x1.6850e4p-58, - -0x1.cc3a65bbc6327p-4, 0x1p0, 0x1.d79775b86e389p-2, 0x1.550ec8p-56, - -0x1.e3a6873fa1279p-4, 0x1p0, 0x1.e2b5d3806f63bp-2, 0x1.e0d89p-58, - -0x1.fb9decc6d55b8p-4, 0x1p0, 0x1.edc1952ef78d6p-2, -0x1.dd0f7cp-56, - -0x1.0a0fd4e41ab5ap-3, 0x1p0, 0x1.f8ba4dbf89abap-2, -0x1.2ec1fcp-60, - -0x1.169566329bcb7p-3, 0x1p0, 0x1.01cfc874c3eb7p-1, -0x1.34a35ep-56, - -0x1.235f2eb9a470ap-3, 0x1p0, 0x1.073879922ffeep-1, -0x1.a5a014p-55, - -0x1.306cb042aa3bap-3, 0x1p0, 0x1.0c9704d5d898fp-1, -0x1.8d3d7cp-55, - -0x1.3dbd69fabf802p-3, 0x1p0, 0x1.11eb3541b4b23p-1, -0x1.ef23b6p-55, - -0x1.4b50d8778abbdp-3, 0x1p0, 0x1.1734d63dedb49p-1, -0x1.7eef2cp-55, - -0x1.592675bc57974p-3, 0x1p0, 0x1.1c73b39ae68c8p-1, 0x1.b25dd2p-55, - -0x1.673db93f41479p-3, 0x1p0, 0x1.21a799933eb59p-1, -0x1.3a7b16p-55, - -0x1.759617ee761f9p-3, 0x1p0, 0x1.26d054cdd12dfp-1, -0x1.5da742p-55, - -0x1.842f0435941afp-3, 0x1p0, 0x1.2bedb25faf3eap-1, -0x1.14981cp-58, - -0x1.9307ee031e2fdp-3, 0x1p0, 0x1.30ff7fce17035p-1, -0x1.efcc62p-57, - -0x1.a22042ce0a2f9p-3, 0x1p0, 0x1.36058b10659f3p-1, -0x1.1fcb3ap-55, - -0x1.b1776d9b67013p-3, 0x1p0, 0x1.3affa292050b9p-1, 0x1.e3e25ep-56, - -0x1.c10cd7041afccp-3, 0x1p0, 0x1.3fed9534556d4p-1, 0x1.369166p-55, - -0x1.d0dfe53aba2fdp-3, 0x1p0, 0x1.44cf325091dd6p-1, 0x1.8076a2p-57, - -0x1.e0effc1174505p-3, 0x1p0, 0x1.49a449b9b0939p-1, -0x1.27ee16p-55, - -0x1.f13c7d001a249p-3, 0x1p0, 0x1.4e6cabbe3e5e9p-1, 0x1.3c293ep-57, - -0x1.00e263951d11fp-2, 0x1p0, 0x1.5328292a35596p-1, -0x1.a12eb8p-56, - -0x1.09441bb2aa0a2p-2, 0x1p0, 0x1.57d69348cecap-1, -0x1.757208p-55, - -0x1.11c3141f91b3ep-2, 0x1p0, 0x1.5c77bbe65018cp-1, 0x1.069ea8p-55, - -0x1.1a5ef902000d3p-2, 0x1p0, 0x1.610b7551d2cdfp-1, -0x1.251b34p-56, - -0x1.23177562aaea3p-2, 0x1p0, 0x1.6591925f0783dp-1, 0x1.c3d64ep-55, - -0x1.2bec333018867p-2, 0x1p0, 0x1.6a09e667f3bcdp-1, -0x1.bdd34p-55, - -0x1.34dcdb41f0f85p-2, 0x1p0, 0x1.6e74454eaa8afp-1, -0x1.dbc03cp-55, - -0x1.3de9155c5a642p-2, 0x1p0, 0x1.72d0837efff96p-1, 0x1.0d4efp-55, - -0x1.471088335fce7p-2, 0x1p0, 0x1.771e75f037261p-1, 0x1.5cfce8p-56, - -0x1.5052d96e626c1p-2, 0x1p0, 0x1.7b5df226aafafp-1, -0x1.0f537ap-56, - -0x1.59afadab954d4p-2, 0x1p0, 0x1.7f8ece3571771p-1, -0x1.9c8d8cp-55, - -0x1.6326a8838342ep-2, 0x1p0, 0x1.83b0e0bff976ep-1, -0x1.6f420ep-56, - -0x1.6cb76c8c9ed8fp-2, 0x1p0, 0x1.87c400fba2ebfp-1, -0x1.2dabcp-55, - -0x1.76619b5edc454p-2, 0x1p0, 0x1.8bc806b151741p-1, -0x1.2c5e12p-55, - -0x1.8024d59755257p-2, 0x1p0, 0x1.8fbcca3ef940dp-1, -0x1.6dfa98p-57, - -0x1.8a00badbf5e8ep-2, 0x1p0, 0x1.93a22499263fbp-1, 0x1.3d419ap-55, - -0x1.93f4e9df34c1bp-2, 0x1p0, 0x1.9777ef4c7d742p-1, -0x1.15479ap-55, - -0x1.9e010063d1f96p-2, 0x1p0, 0x1.9b3e047f38741p-1, -0x1.30ee28p-55, - -0x1.a8249b40a182cp-2, 0x1p0, 0x1.9ef43ef29af94p-1, 0x1.b1dfcap-56, - -0x1.b25f56645da43p-2, 0x1p0, 0x1.a29a7a0462782p-1, -0x1.128bbp-56, - -0x1.bcb0ccd98294fp-2, 0x1p0, 0x1.a63091b02fae2p-1, -0x1.e91114p-56, - -0x1.c71898ca32e6fp-2, 0x1p0, 0x1.a9b66290ea1a3p-1, 0x1.9f630ep-60, - -0x1.d19653842496fp-2, 0x1p0, 0x1.ad2bc9e21d511p-1, -0x1.47fbep-55, - -0x1.dc29957c969bbp-2, 0x1p0, 0x1.b090a581502p-1, -0x1.926da2p-55, - -0x1.e6d1f6544ece3p-2, 0x1p0, 0x1.b3e4d3ef55712p-1, -0x1.eb6b8ap-55, - -0x1.f18f0cdba0025p-2, 0x1p0, 0x1.b728345196e3ep-1, -0x1.bc69f2p-55, - -0x1.fc606f1678292p-2, 0x1p0, 0x1.ba5aa673590d2p-1, 0x1.7ea4e2p-55, - -0x1.d16c901d95181p-8, 0x1p-1, 0x1.bd7c0ac6f952ap-1, -0x1.825a72p-55, - -0x1.23e6ad10872a7p-6, 0x1p-1, 0x1.c08c426725549p-1, 0x1.b157fcp-58, - -0x1.d4a2c7f909c4ep-6, 0x1p-1, 0x1.c38b2f180bdb1p-1, -0x1.6e0b16p-56, - -0x1.4344523c8e3b5p-5, 0x1p-1, 0x1.c678b3488739bp-1, 0x1.d86cacp-57, - -0x1.9cc8b3671dd0fp-5, 0x1p-1, 0x1.c954b213411f5p-1, -0x1.2fb76p-58, - -0x1.f6db13ff708cbp-5, 0x1p-1, 0x1.cc1f0f3fcfc5cp-1, 0x1.e57612p-56, - -0x1.28bbfd87a8cffp-4, 0x1p-1, 0x1.ced7af43cc773p-1, -0x1.e7b6bap-58, - -0x1.564df524b00dap-4, 0x1p-1, 0x1.d17e7743e35dcp-1, -0x1.101da2p-58, - -0x1.8421af15c49d7p-4, 0x1p-1, 0x1.d4134d14dc93ap-1, -0x1.4ef528p-55, - -0x1.b2356710db0a3p-4, 0x1p-1, 0x1.d696173c9e68bp-1, -0x1.e8c61cp-56, - -0x1.e087565455a75p-4, 0x1p-1, 0x1.d906bcf328d46p-1, 0x1.457e6p-56, - -0x1.078ad9dc46632p-3, 0x1p-1, 0x1.db6526238a09bp-1, -0x1.adee7ep-56, - -0x1.1eef59e0b74c3p-3, 0x1p-1, 0x1.ddb13b6ccc23cp-1, 0x1.83c37cp-55, - -0x1.367044581b074p-3, 0x1p-1, 0x1.dfeae622dbe2bp-1, -0x1.514ea8p-55, - -0x1.4e0cb14a9c046p-3, 0x1p-1, 0x1.e212104f686e5p-1, -0x1.014c76p-55, - -0x1.65c3b7b0e312cp-3, 0x1p-1, 0x1.e426a4b2bc17ep-1, 0x1.a87388p-55, - -0x1.7d946d7d133fdp-3, 0x1p-1, 0x1.e6288ec48e112p-1, -0x1.16b56ep-57, - -0x1.957de7a3cfd5dp-3, 0x1p-1, 0x1.e817bab4cd10dp-1, -0x1.d0afe6p-56, - -0x1.ad7f3a254c1f5p-3, 0x1p-1, 0x1.e9f4156c62ddap-1, 0x1.760b1ep-55, - -0x1.c597781664984p-3, 0x1p-1, 0x1.ebbd8c8df0b74p-1, 0x1.c6c8c6p-56, - -0x1.ddc5b3a9c1311p-3, 0x1p-1, 0x1.ed740e7684963p-1, 0x1.e82c78p-56, - -0x1.f608fe39004a4p-3, 0x1p-1, 0x1.ef178a3e473c2p-1, 0x1.6310a6p-55, - -0x1.cc0d09bd41caap-8, 0x1p-2, 0x1.f0a7efb9230d7p-1, 0x1.52c7acp-56, - -0x1.36580d5d5e775p-6, 0x1p-2, 0x1.f2252f7763adap-1, -0x1.20cb8p-55, - -0x1.fa3ecac0d84e8p-6, 0x1p-2, 0x1.f38f3ac64e589p-1, -0x1.d7bafap-56, - -0x1.5f57f693feebep-5, 0x1p-2, 0x1.f4e603b0b2f2dp-1, -0x1.8ee01ep-56, - -0x1.c1d1f0e5967d5p-5, 0x1p-2, 0x1.f6297cff75cbp-1, 0x1.562172p-56, - -0x1.1244c435e819dp-4, 0x1p-2, 0x1.f7599a3a12077p-1, 0x1.84f31cp-55, - -0x1.43bd776e98073p-4, 0x1p-2, 0x1.f8764fa714ba9p-1, 0x1.ab2566p-56, - -0x1.755129dad834cp-4, 0x1p-2, 0x1.f97f924c9099bp-1, -0x1.e2ae0ep-55, - -0x1.a6fdf22e33d8cp-4, 0x1p-2, 0x1.fa7557f08a517p-1, -0x1.7a0a8cp-55, - -0x1.d8c1e624a1513p-4, 0x1p-2, 0x1.fb5797195d741p-1, 0x1.1bfac6p-56, - -0x1.536352ad19e39p-9, 0x1p-3, 0x1.fc26470e19fd3p-1, 0x1.1ec866p-55, - -0x1.e43d1c309e958p-7, 0x1p-3, 0x1.fce15fd6da67bp-1, -0x1.5dd6f8p-56, - -0x1.ba1650f592f5p-6, 0x1p-3, 0x1.fd88da3d12526p-1, -0x1.87df62p-55, - -0x1.4125feacab7cep-5, 0x1p-3, 0x1.fe1cafcbd5b09p-1, 0x1.a23e32p-57, - -0x1.a55beda63cc14p-5, 0x1p-3, 0x1.fe9cdad01883ap-1, 0x1.521eccp-57, - -0x1.35230c0fbe402p-10, 0x1p-4, 0x1.ff095658e71adp-1, 0x1.01a8cep-55, - -0x1.b82683bc89fbp-7, 0x1p-4, 0x1.ff621e3796d7ep-1, -0x1.c57bc2p-57, - -0x1.a4f3514d75466p-6, 0x1p-4, 0x1.ffa72effef75dp-1, -0x1.8b4cdcp-55, - -0x1.b7aa821726608p-8, 0x1p-5, 0x1.ffd886084cd0dp-1, -0x1.1354d4p-55, - -0x1.b78b80c84e1eep-9, 0x1p-6, 0x1.fff62169b92dbp-1, 0x1.5dda3cp-55, -}; - -} // namespace npsr::trig::data - -#endif // NPSR_TRIG_DATA_APPROX_H diff --git a/npsr/trig/data/constants.h b/npsr/trig/data/constants.h deleted file mode 100644 index 7161a0e..0000000 --- a/npsr/trig/data/constants.h +++ /dev/null @@ -1,57 +0,0 @@ -// Auto-generated by npsr/trig/data/constants.h.sol -// Use `spin generate -f` to force regeneration -#ifndef NPSR_TRIG_DATA_CONSTANTS_H -#define NPSR_TRIG_DATA_CONSTANTS_H - -namespace npsr::trig::data { -template constexpr char kPi[] = {}; -template <> constexpr float kPi[] = { - 0x1.921fb6p1f, -0x1.777a5cp-24f, -0x1.ee59dap-49f, -}; -template <> constexpr float kPi[] = { - 0x1.92p1f, 0x1.fb4p-11f, 0x1.444p-23f, 0x1.68c234p-38f, -}; -template <> constexpr double kPi[] = { - 0x1.921fb54442d18p1, 0x1.1a62633145c06p-53, 0x1.c1cd129024e09p-106, -}; -template <> constexpr double kPi[] = { - 0x1.921fb6p1, -0x1.777a5cp-24, -0x1.ee59dap-49, 0x1.98a2e03707345p-76, -}; - -template constexpr double kPiPrec35[] = { - 0x1.921fb5444p1, 0x1.68c234c4c6628p-38, -}; -template <> constexpr double kPiPrec35[] = { - 0x1.921fb6p1, -0x1.777a5cp-24, -0x1.ee59dap-49, -}; - -template constexpr char kPiMul2[] = {}; -template <> constexpr float kPiMul2[] = { - 0x1.921fb6p2f, -0x1.777a5cp-23f, -}; -template <> constexpr double kPiMul2[] = { - 0x1.921fb54442d18p2, 0x1.1a62633145c07p-52, -}; - -template constexpr double kPiDiv16Prec29[] = { - 0x1.921fb54442d18p-3, 0x1.1a62633p-57, 0x1.45c06e0e68948p-89, -}; -template <> constexpr double kPiDiv16Prec29[] = { - 0x1.921fb54p-3, 0x1.a626331p-61, 0x1.1701b839a252p-91, 0x1.10b461p-33, -}; - -template constexpr char kInvPi = '_'; -template <> constexpr float kInvPi = 0x1.45f306p-2f; -template <> constexpr double kInvPi = 0x1.45f306dc9c883p-2; - -template constexpr char kHalfPi = '_'; -template <> constexpr float kHalfPi = 0x1.921fb6p0f; -template <> constexpr double kHalfPi = 0x1.921fb54442d18p0; - -template constexpr char k16DivPi = '_'; -template <> constexpr float k16DivPi = 0x1.45f306p2f; -template <> constexpr double k16DivPi = 0x1.45f306dc9c883p2; - -} // namespace npsr::trig::data - -#endif // NPSR_TRIG_DATA_CONSTANTS_H diff --git a/npsr/trig/data/data.h b/npsr/trig/data/data.h deleted file mode 100644 index 658dd51..0000000 --- a/npsr/trig/data/data.h +++ /dev/null @@ -1,11 +0,0 @@ -// Auto-generated by npsr/trig/data/data.h.sol -// Use `spin generate -f` to force regeneration -#ifndef NPSR_TRIG_DATA_DATA_H -#define NPSR_TRIG_DATA_DATA_H - -#include "npsr/trig/data/constants.h" -#include "npsr/trig/data/high.h" -#include "npsr/trig/data/approx.h" -#include "npsr/trig/data/reduction.h" - -#endif // NPSR_TRIG_DATA_DATA_H diff --git a/npsr/trig/data/high.h b/npsr/trig/data/high.h deleted file mode 100644 index 211a908..0000000 --- a/npsr/trig/data/high.h +++ /dev/null @@ -1,54 +0,0 @@ -// Auto-generated by npsr/trig/data/high.h.sol -// Use `spin generate -f` to force regeneration -#ifndef NPSR_TRIG_DATA_HIGH_H -#define NPSR_TRIG_DATA_HIGH_H - -namespace npsr::trig::data { -constexpr double kHiSinKPi16Table[] = { - 0, - 0x1.8f8b83c69a60bp-3, - 0x1.87de2a6aea963p-2, - 0x1.1c73b39ae68c8p-1, - 0x1.6a09e667f3bcdp-1, - 0x1.a9b66290ea1a3p-1, - 0x1.d906bcf328d46p-1, - 0x1.f6297cff75cbp-1, - 0x1p0, - 0x1.f6297cff75cbp-1, - 0x1.d906bcf328d46p-1, - 0x1.a9b66290ea1a3p-1, - 0x1.6a09e667f3bcdp-1, - 0x1.1c73b39ae68c8p-1, - 0x1.87de2a6aea963p-2, - 0x1.8f8b83c69a60bp-3, -}; - -constexpr double kHiCosKPi16Table[] = { - 0x1p0, - 0x1.f6297cff75cbp-1, - 0x1.d906bcf328d46p-1, - 0x1.a9b66290ea1a3p-1, - 0x1.6a09e667f3bcdp-1, - 0x1.1c73b39ae68c8p-1, - 0x1.87de2a6aea963p-2, - 0x1.8f8b83c69a60bp-3, - 0, - -0x1.8f8b83c69a60bp-3, - -0x1.87de2a6aea963p-2, - -0x1.1c73b39ae68c8p-1, - -0x1.6a09e667f3bcdp-1, - -0x1.a9b66290ea1a3p-1, - -0x1.d906bcf328d46p-1, - -0x1.f6297cff75cbp-1, -}; - -constexpr double kPackedLowSinCosKPi16Table[] = { - 0, 0x1.56217bc626d19p-56, 0x1.457e6bc672cedp-56, 0x1.9f6303c8b25ddp-60, - -0x1.bdd34bc8bdd34p-55, 0x1.b25dd3c39f63p-55, -0x1.72ced3c7457e6p-57, -0x1.26d193c756217p-57, - 0, 0x1.26d193c756217p-57, 0x1.72ced3c7457e6p-57, -0x1.b25dd3c39f63p-55, - 0x1.bdd34bc8bdd34p-55, -0x1.9f6303c8b25ddp-60, -0x1.457e6bc672cedp-56, -0x1.56217bc626d19p-56, -}; - -} // namespace npsr::trig::data - -#endif // NPSR_TRIG_DATA_HIGH_H diff --git a/npsr/trig/data/reduction.h b/npsr/trig/data/reduction.h deleted file mode 100644 index 950afbe..0000000 --- a/npsr/trig/data/reduction.h +++ /dev/null @@ -1,2320 +0,0 @@ -// Auto-generated by npsr/trig/data/reduction.h.sol -// Use `spin generate -f` to force regeneration -#ifndef NPSR_TRIG_DATA_REDUCTION_H -#define NPSR_TRIG_DATA_REDUCTION_H - -namespace npsr::trig::data { -template constexpr T kLargeReductionTable[] = {}; -template <> constexpr uint32_t kLargeReductionTable[] = { - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 0u, - 0u, 0u, 1u, - 0u, 0u, 2u, - 0u, 0u, 5u, - 0u, 0u, 10u, - 0u, 0u, 20u, - 0u, 0u, 40u, - 0u, 0u, 81u, - 0u, 0u, 162u, - 0u, 0u, 325u, - 0u, 0u, 651u, - 0u, 0u, 1303u, - 0u, 0u, 2607u, - 0u, 0u, 5215u, - 0u, 0u, 10430u, - 0u, 0u, 20860u, - 0u, 0u, 41721u, - 0u, 0u, 83443u, - 0u, 0u, 166886u, - 0u, 0u, 333772u, - 0u, 0u, 667544u, - 0u, 0u, 1335088u, - 0u, 0u, 2670176u, - 0u, 0u, 5340353u, - 0u, 0u, 10680707u, - 0u, 0u, 21361414u, - 0u, 0u, 42722829u, - 0u, 0u, 85445659u, - 0u, 0u, 170891318u, - 0u, 0u, 341782637u, - 0u, 0u, 683565275u, - 0u, 0u, 1367130551u, - 0u, 0u, 2734261102u, - 0u, 1u, 1173554908u, - 0u, 2u, 2347109817u, - 0u, 5u, 399252338u, - 0u, 10u, 798504676u, - 0u, 20u, 1597009353u, - 0u, 40u, 3194018707u, - 0u, 81u, 2093070119u, - 0u, 162u, 4186140238u, - 0u, 325u, 4077313180u, - 0u, 651u, 3859659065u, - 0u, 1303u, 3424350834u, - 0u, 2607u, 2553734372u, - 0u, 5215u, 812501448u, - 0u, 10430u, 1625002897u, - 0u, 20860u, 3250005794u, - 0u, 41721u, 2205044292u, - 0u, 83443u, 115121288u, - 0u, 166886u, 230242576u, - 0u, 333772u, 460485152u, - 0u, 667544u, 920970305u, - 0u, 1335088u, 1841940610u, - 0u, 2670176u, 3683881221u, - 0u, 5340353u, 3072795146u, - 0u, 10680707u, 1850622997u, - 0u, 21361414u, 3701245994u, - 0u, 42722829u, 3107524692u, - 0u, 85445659u, 1920082089u, - 0u, 170891318u, 3840164178u, - 0u, 341782637u, 3385361061u, - 0u, 683565275u, 2475754826u, - 0u, 1367130551u, 656542356u, - 0u, 2734261102u, 1313084713u, - 1u, 1173554908u, 2626169427u, - 2u, 2347109817u, 957371559u, - 5u, 399252338u, 1914743119u, - 10u, 798504676u, 3829486239u, - 20u, 1597009353u, 3364005183u, - 40u, 3194018707u, 2433043071u, - 81u, 2093070119u, 571118846u, - 162u, 4186140238u, 1142237692u, - 325u, 4077313180u, 2284475384u, - 651u, 3859659065u, 273983472u, - 1303u, 3424350834u, 547966945u, - 2607u, 2553734372u, 1095933890u, - 5215u, 812501448u, 2191867780u, - 10430u, 1625002897u, 88768265u, - 20860u, 3250005794u, 177536531u, - 41721u, 2205044292u, 355073063u, - 83443u, 115121288u, 710146126u, - 166886u, 230242576u, 1420292253u, - 333772u, 460485152u, 2840584506u, - 667544u, 920970305u, 1386201717u, - 1335088u, 1841940610u, 2772403434u, - 2670176u, 3683881221u, 1249839573u, - 5340353u, 3072795146u, 2499679147u, - 10680707u, 1850622997u, 704390999u, - 21361414u, 3701245994u, 1408781999u, - 42722829u, 3107524692u, 2817563999u, - 85445659u, 1920082089u, 1340160702u, - 170891318u, 3840164178u, 2680321405u, - 341782637u, 3385361061u, 1065675514u, - 683565275u, 2475754826u, 2131351028u, - 1367130551u, 656542356u, 4262702056u, - 2734261102u, 1313084713u, 4230436817u, - 1173554908u, 2626169427u, 4165906339u, - 2347109817u, 957371559u, 4036845383u, - 399252338u, 1914743119u, 3778723471u, - 798504676u, 3829486239u, 3262479647u, - 1597009353u, 3364005183u, 2229991998u, - 3194018707u, 2433043071u, 165016701u, - 2093070119u, 571118846u, 330033402u, - 4186140238u, 1142237692u, 660066805u, - 4077313180u, 2284475384u, 1320133610u, - 3859659065u, 273983472u, 2640267220u, - 3424350834u, 547966945u, 985567145u, - 2553734372u, 1095933890u, 1971134291u, - 812501448u, 2191867780u, 3942268582u, - 1625002897u, 88768265u, 3589569869u, - 3250005794u, 177536531u, 2884172442u, - 2205044292u, 355073063u, 1473377588u, - 115121288u, 710146126u, 2946755177u, - 230242576u, 1420292253u, 1598543059u, - 460485152u, 2840584506u, 3197086118u, - 920970305u, 1386201717u, 2099204941u, - 1841940610u, 2772403434u, 4198409883u, - 3683881221u, 1249839573u, 4101852471u, - 3072795146u, 2499679147u, 3908737646u, - 1850622997u, 704390999u, 3522507997u, - 3701245994u, 1408781999u, 2750048699u, - 3107524692u, 2817563999u, 1205130103u, - 1920082089u, 1340160702u, 2410260206u, - 3840164178u, 2680321405u, 525553116u, - 3385361061u, 1065675514u, 1051106232u, - 2475754826u, 2131351028u, 2102212464u, - 656542356u, 4262702056u, 4204424928u, - 1313084713u, 4230436817u, 4113882560u, - 2626169427u, 4165906339u, 3932797825u, - 957371559u, 4036845383u, 3570628355u, - 1914743119u, 3778723471u, 2846289414u, - 3829486239u, 3262479647u, 1397611533u, - 3364005183u, 2229991998u, 2795223067u, - 2433043071u, 165016701u, 1295478838u, - 571118846u, 330033402u, 2590957677u, - 1142237692u, 660066805u, 886948059u, - 2284475384u, 1320133610u, 1773896118u, - 273983472u, 2640267220u, 3547792237u, - 547966945u, 985567145u, 2800617179u, - 1095933890u, 1971134291u, 1306267062u, - 2191867780u, 3942268582u, 2612534124u, - 88768265u, 3589569869u, 930100952u, - 177536531u, 2884172442u, 1860201905u, - 355073063u, 1473377588u, 3720403810u, - 710146126u, 2946755177u, 3145840325u, - 1420292253u, 1598543059u, 1996713354u, - 2840584506u, 3197086118u, 3993426708u, - 1386201717u, 2099204941u, 3691886121u, - 2772403434u, 4198409883u, 3088804946u, - 1249839573u, 4101852471u, 1882642597u, - 2499679147u, 3908737646u, 3765285194u, - 704390999u, 3522507997u, 3235603093u, - 1408781999u, 2750048699u, 2176238891u, - 2817563999u, 1205130103u, 57510486u, - 1340160702u, 2410260206u, 115020972u, - 2680321405u, 525553116u, 230041945u, - 1065675514u, 1051106232u, 460083891u, - 2131351028u, 2102212464u, 920167782u, - 4262702056u, 4204424928u, 1840335564u, - 4230436817u, 4113882560u, 3680671129u, - 4165906339u, 3932797825u, 3066374962u, - 4036845383u, 3570628355u, 1837782628u, - 3778723471u, 2846289414u, 3675565257u, - 3262479647u, 1397611533u, 3056163219u, - 2229991998u, 2795223067u, 1817359143u, - 165016701u, 1295478838u, 3634718287u, - 330033402u, 2590957677u, 2974469278u, - 660066805u, 886948059u, 1653971260u, - 1320133610u, 1773896118u, 3307942520u, - 2640267220u, 3547792237u, 2320917745u, - 985567145u, 2800617179u, 346868194u, - 1971134291u, 1306267062u, 693736388u, - 3942268582u, 2612534124u, 1387472776u, - 3589569869u, 930100952u, 2774945552u, - 2884172442u, 1860201905u, 1254923809u, - 1473377588u, 3720403810u, 2509847619u, - 2946755177u, 3145840325u, 724727943u, - 1598543059u, 1996713354u, 1449455886u, - 3197086118u, 3993426708u, 2898911772u, - 2099204941u, 3691886121u, 1502856249u, - 4198409883u, 3088804946u, 3005712498u, - 4101852471u, 1882642597u, 1716457700u, - 3908737646u, 3765285194u, 3432915400u, - 3522507997u, 3235603093u, 2570863504u, - 2750048699u, 2176238891u, 846759712u, - 1205130103u, 57510486u, 1693519425u, - 2410260206u, 115020972u, 3387038850u, - 525553116u, 230041945u, 2479110404u, - 1051106232u, 460083891u, 663253512u, - 2102212464u, 920167782u, 1326507024u, - 4204424928u, 1840335564u, 2653014048u, - 4113882560u, 3680671129u, 1011060801u, - 3932797825u, 3066374962u, 2022121603u, - 3570628355u, 1837782628u, 4044243207u, - 2846289414u, 3675565257u, 3793519119u, - 1397611533u, 3056163219u, 3292070943u, - 2795223067u, 1817359143u, 2289174591u, - 1295478838u, 3634718287u, 283381887u, - 2590957677u, 2974469278u, 566763775u, -};; - -template <> constexpr uint64_t kLargeReductionTable[] = { - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 0ull, - 0ull, 0ull, 1ull, - 0ull, 0ull, 2ull, - 0ull, 0ull, 5ull, - 0ull, 0ull, 10ull, - 0ull, 0ull, 20ull, - 0ull, 0ull, 40ull, - 0ull, 0ull, 81ull, - 0ull, 0ull, 162ull, - 0ull, 0ull, 325ull, - 0ull, 0ull, 651ull, - 0ull, 0ull, 1303ull, - 0ull, 0ull, 2607ull, - 0ull, 0ull, 5215ull, - 0ull, 0ull, 10430ull, - 0ull, 0ull, 20860ull, - 0ull, 0ull, 41721ull, - 0ull, 0ull, 83443ull, - 0ull, 0ull, 166886ull, - 0ull, 0ull, 333772ull, - 0ull, 0ull, 667544ull, - 0ull, 0ull, 1335088ull, - 0ull, 0ull, 2670176ull, - 0ull, 0ull, 5340353ull, - 0ull, 0ull, 10680707ull, - 0ull, 0ull, 21361414ull, - 0ull, 0ull, 42722829ull, - 0ull, 0ull, 85445659ull, - 0ull, 0ull, 170891318ull, - 0ull, 0ull, 341782637ull, - 0ull, 0ull, 683565275ull, - 0ull, 0ull, 1367130551ull, - 0ull, 0ull, 2734261102ull, - 0ull, 0ull, 5468522204ull, - 0ull, 0ull, 10937044409ull, - 0ull, 0ull, 21874088818ull, - 0ull, 0ull, 43748177636ull, - 0ull, 0ull, 87496355273ull, - 0ull, 0ull, 174992710547ull, - 0ull, 0ull, 349985421095ull, - 0ull, 0ull, 699970842190ull, - 0ull, 0ull, 1399941684380ull, - 0ull, 0ull, 2799883368761ull, - 0ull, 0ull, 5599766737522ull, - 0ull, 0ull, 11199533475044ull, - 0ull, 0ull, 22399066950088ull, - 0ull, 0ull, 44798133900177ull, - 0ull, 0ull, 89596267800354ull, - 0ull, 0ull, 179192535600708ull, - 0ull, 0ull, 358385071201416ull, - 0ull, 0ull, 716770142402832ull, - 0ull, 0ull, 1433540284805664ull, - 0ull, 0ull, 2867080569611329ull, - 0ull, 0ull, 5734161139222658ull, - 0ull, 0ull, 11468322278445317ull, - 0ull, 0ull, 22936644556890634ull, - 0ull, 0ull, 45873289113781269ull, - 0ull, 0ull, 91746578227562538ull, - 0ull, 0ull, 183493156455125076ull, - 0ull, 0ull, 366986312910250153ull, - 0ull, 0ull, 733972625820500306ull, - 0ull, 0ull, 1467945251641000613ull, - 0ull, 0ull, 2935890503282001226ull, - 0ull, 0ull, 5871781006564002452ull, - 0ull, 0ull, 11743562013128004905ull, - 0ull, 1ull, 5040379952546458195ull, - 0ull, 2ull, 10080759905092916391ull, - 0ull, 5ull, 1714775736476281167ull, - 0ull, 10ull, 3429551472952562335ull, - 0ull, 20ull, 6859102945905124671ull, - 0ull, 40ull, 13718205891810249343ull, - 0ull, 81ull, 8989667709910947070ull, - 0ull, 162ull, 17979335419821894140ull, - 0ull, 325ull, 17511926765934236664ull, - 0ull, 651ull, 16577109458158921712ull, - 0ull, 1303ull, 14707474842608291809ull, - 0ull, 2607ull, 10968205611507032002ull, - 0ull, 5215ull, 3489667149304512388ull, - 0ull, 10430ull, 6979334298609024777ull, - 0ull, 20860ull, 13958668597218049555ull, - 0ull, 41721ull, 9470593120726547495ull, - 0ull, 83443ull, 494442167743543374ull, - 0ull, 166886ull, 988884335487086749ull, - 0ull, 333772ull, 1977768670974173498ull, - 0ull, 667544ull, 3955537341948346997ull, - 0ull, 1335088ull, 7911074683896693994ull, - 0ull, 2670176ull, 15822149367793387989ull, - 0ull, 5340353ull, 13197554661877224363ull, - 0ull, 10680707ull, 7948365250044897111ull, - 0ull, 21361414ull, 15896730500089794223ull, - 0ull, 42722829ull, 13346716926470036831ull, - 0ull, 85445659ull, 8246689779230522046ull, - 0ull, 170891318ull, 16493379558461044093ull, - 0ull, 341782637ull, 14540015043212536570ull, - 0ull, 683565275ull, 10633286012715521524ull, - 0ull, 1367130551ull, 2819827951721491432ull, - 0ull, 2734261102ull, 5639655903442982865ull, - 0ull, 5468522204ull, 11279311806885965731ull, - 0ull, 10937044409ull, 4111879540062379847ull, - 0ull, 21874088818ull, 8223759080124759695ull, - 0ull, 43748177636ull, 16447518160249519391ull, - 0ull, 87496355273ull, 14448292246789487166ull, - 0ull, 174992710547ull, 10449840419869422717ull, - 0ull, 349985421095ull, 2452936766029293818ull, - 0ull, 699970842190ull, 4905873532058587637ull, - 0ull, 1399941684380ull, 9811747064117175274ull, - 0ull, 2799883368761ull, 1176750054524798932ull, - 0ull, 5599766737522ull, 2353500109049597865ull, - 0ull, 11199533475044ull, 4707000218099195731ull, - 0ull, 22399066950088ull, 9414000436198391462ull, - 0ull, 44798133900177ull, 381256798687231309ull, - 0ull, 89596267800354ull, 762513597374462618ull, - 0ull, 179192535600708ull, 1525027194748925236ull, - 0ull, 358385071201416ull, 3050054389497850473ull, - 0ull, 716770142402832ull, 6100108778995700947ull, - 0ull, 1433540284805664ull, 12200217557991401894ull, - 0ull, 2867080569611329ull, 5953691042273252173ull, - 0ull, 5734161139222658ull, 11907382084546504347ull, - 0ull, 11468322278445317ull, 5368020095383457079ull, - 0ull, 22936644556890634ull, 10736040190766914158ull, - 0ull, 45873289113781269ull, 3025336307824276701ull, - 0ull, 91746578227562538ull, 6050672615648553403ull, - 0ull, 183493156455125076ull, 12101345231297106807ull, - 0ull, 366986312910250153ull, 5755946388884661998ull, - 0ull, 733972625820500306ull, 11511892777769323996ull, - 0ull, 1467945251641000613ull, 4577041481829096376ull, - 0ull, 2935890503282001226ull, 9154082963658192752ull, - 0ull, 5871781006564002452ull, 18308165927316385504ull, - 0ull, 11743562013128004905ull, 18169587780923219392ull, - 1ull, 5040379952546458195ull, 17892431488136887169ull, - 2ull, 10080759905092916391ull, 17338118902564222723ull, - 5ull, 1714775736476281167ull, 16229493731418893830ull, - 10ull, 3429551472952562335ull, 14012243389128236045ull, - 20ull, 6859102945905124671ull, 9577742704546920475ull, - 40ull, 13718205891810249343ull, 708741335384289334ull, - 81ull, 8989667709910947070ull, 1417482670768578669ull, - 162ull, 17979335419821894140ull, 2834965341537157339ull, - 325ull, 17511926765934236664ull, 5669930683074314678ull, - 651ull, 16577109458158921712ull, 11339861366148629357ull, - 1303ull, 14707474842608291809ull, 4232978658587707099ull, - 2607ull, 10968205611507032002ull, 8465957317175414198ull, - 5215ull, 3489667149304512388ull, 16931914634350828396ull, - 10430ull, 6979334298609024777ull, 15417085194992105176ull, - 20860ull, 13958668597218049555ull, 12387426316274658737ull, - 41721ull, 9470593120726547495ull, 6328108558839765858ull, - 83443ull, 494442167743543374ull, 12656217117679531717ull, - 166886ull, 988884335487086749ull, 6865690161649511818ull, - 333772ull, 1977768670974173498ull, 13731380323299023636ull, - 667544ull, 3955537341948346997ull, 9016016572888495657ull, - 1335088ull, 7911074683896693994ull, 18032033145776991314ull, - 2670176ull, 15822149367793387989ull, 17617322217844431013ull, - 5340353ull, 13197554661877224363ull, 16787900361979310410ull, - 10680707ull, 7948365250044897111ull, 15129056650249069205ull, - 21361414ull, 15896730500089794223ull, 11811369226788586795ull, - 42722829ull, 13346716926470036831ull, 5175994379867621974ull, - 85445659ull, 8246689779230522046ull, 10351988759735243948ull, - 170891318ull, 16493379558461044093ull, 2257233445760936281ull, - 341782637ull, 14540015043212536570ull, 4514466891521872563ull, - 683565275ull, 10633286012715521524ull, 9028933783043745126ull, - 1367130551ull, 2819827951721491432ull, 18057867566087490252ull, - 2734261102ull, 5639655903442982865ull, 17668991058465428889ull, - 5468522204ull, 11279311806885965731ull, 16891238043221306162ull, - 10937044409ull, 4111879540062379847ull, 15335732012733060708ull, - 21874088818ull, 8223759080124759695ull, 12224719951756569801ull, - 43748177636ull, 16447518160249519391ull, 6002695829803587987ull, - 87496355273ull, 14448292246789487166ull, 12005391659607175975ull, - 174992710547ull, 10449840419869422717ull, 5564039245504800335ull, - 349985421095ull, 2452936766029293818ull, 11128078491009600670ull, - 699970842190ull, 4905873532058587637ull, 3809412908309649724ull, - 1399941684380ull, 9811747064117175274ull, 7618825816619299448ull, - 2799883368761ull, 1176750054524798932ull, 15237651633238598897ull, - 5599766737522ull, 2353500109049597865ull, 12028559192767646178ull, - 11199533475044ull, 4707000218099195731ull, 5610374311825740740ull, - 22399066950088ull, 9414000436198391462ull, 11220748623651481480ull, - 44798133900177ull, 381256798687231309ull, 3994753173593411344ull, - 89596267800354ull, 762513597374462618ull, 7989506347186822689ull, - 179192535600708ull, 1525027194748925236ull, 15979012694373645379ull, - 358385071201416ull, 3050054389497850473ull, 13511281315037739143ull, - 716770142402832ull, 6100108778995700947ull, 8575818556365926670ull, - 1433540284805664ull, 12200217557991401894ull, 17151637112731853340ull, - 2867080569611329ull, 5953691042273252173ull, 15856530151754155065ull, - 5734161139222658ull, 11907382084546504347ull, 13266316229798758514ull, - 11468322278445317ull, 5368020095383457079ull, 8085888385887965412ull, - 22936644556890634ull, 10736040190766914158ull, 16171776771775930824ull, - 45873289113781269ull, 3025336307824276701ull, 13896809469842310032ull, - 91746578227562538ull, 6050672615648553403ull, 9346874865975068448ull, - 183493156455125076ull, 12101345231297106807ull, 247005658240585281ull, - 366986312910250153ull, 5755946388884661998ull, 494011316481170562ull, - 733972625820500306ull, 11511892777769323996ull, 988022632962341124ull, - 1467945251641000613ull, 4577041481829096376ull, 1976045265924682248ull, - 2935890503282001226ull, 9154082963658192752ull, 3952090531849364496ull, - 5871781006564002452ull, 18308165927316385504ull, 7904181063698728992ull, - 11743562013128004905ull, 18169587780923219392ull, 15808362127397457985ull, - 5040379952546458195ull, 17892431488136887169ull, 13169980181085364355ull, - 10080759905092916391ull, 17338118902564222723ull, 7893216288461177095ull, - 1714775736476281167ull, 16229493731418893830ull, 15786432576922354191ull, - 3429551472952562335ull, 14012243389128236045ull, 13126121080135156767ull, - 6859102945905124671ull, 9577742704546920475ull, 7805498086560761919ull, - 13718205891810249343ull, 708741335384289334ull, 15610996173121523839ull, - 8989667709910947070ull, 1417482670768578669ull, 12775248272533496063ull, - 17979335419821894140ull, 2834965341537157339ull, 7103752471357440510ull, - 17511926765934236664ull, 5669930683074314678ull, 14207504942714881020ull, - 16577109458158921712ull, 11339861366148629357ull, 9968265811720210425ull, - 14707474842608291809ull, 4232978658587707099ull, 1489787549730869234ull, - 10968205611507032002ull, 8465957317175414198ull, 2979575099461738469ull, - 3489667149304512388ull, 16931914634350828396ull, 5959150198923476938ull, - 6979334298609024777ull, 15417085194992105176ull, 11918300397846953876ull, - 13958668597218049555ull, 12387426316274658737ull, 5389856721984356136ull, - 9470593120726547495ull, 6328108558839765858ull, 10779713443968712273ull, - 494442167743543374ull, 12656217117679531717ull, 3112682814227872930ull, - 988884335487086749ull, 6865690161649511818ull, 6225365628455745861ull, - 1977768670974173498ull, 13731380323299023636ull, 12450731256911491723ull, - 3955537341948346997ull, 9016016572888495657ull, 6454718440113431830ull, - 7911074683896693994ull, 18032033145776991314ull, 12909436880226863660ull, - 15822149367793387989ull, 17617322217844431013ull, 7372129686744175704ull, - 13197554661877224363ull, 16787900361979310410ull, 14744259373488351409ull, - 7948365250044897111ull, 15129056650249069205ull, 11041774673267151203ull, - 15896730500089794223ull, 11811369226788586795ull, 3636805272824750791ull, - 13346716926470036831ull, 5175994379867621974ull, 7273610545649501582ull, - 8246689779230522046ull, 10351988759735243948ull, 14547221091299003165ull, - 16493379558461044093ull, 2257233445760936281ull, 10647698108888454714ull, - 14540015043212536570ull, 4514466891521872563ull, 2848652144067357813ull, - 10633286012715521524ull, 9028933783043745126ull, 5697304288134715626ull, - 2819827951721491432ull, 18057867566087490252ull, 11394608576269431253ull, - 5639655903442982865ull, 17668991058465428889ull, 4342473078829310891ull, - 11279311806885965731ull, 16891238043221306162ull, 8684946157658621783ull, - 4111879540062379847ull, 15335732012733060708ull, 17369892315317243567ull, - 8223759080124759695ull, 12224719951756569801ull, 16293040556924935518ull, - 16447518160249519391ull, 6002695829803587987ull, 14139337040140319421ull, - 14448292246789487166ull, 12005391659607175975ull, 9831930006571087227ull, - 10449840419869422717ull, 5564039245504800335ull, 1217115939432622839ull, - 2452936766029293818ull, 11128078491009600670ull, 2434231878865245679ull, - 4905873532058587637ull, 3809412908309649724ull, 4868463757730491358ull, - 9811747064117175274ull, 7618825816619299448ull, 9736927515460982717ull, - 1176750054524798932ull, 15237651633238598897ull, 1027110957212413818ull, - 2353500109049597865ull, 12028559192767646178ull, 2054221914424827637ull, - 4707000218099195731ull, 5610374311825740740ull, 4108443828849655275ull, - 9414000436198391462ull, 11220748623651481480ull, 8216887657699310551ull, - 381256798687231309ull, 3994753173593411344ull, 16433775315398621102ull, - 762513597374462618ull, 7989506347186822689ull, 14420806557087690589ull, - 1525027194748925236ull, 15979012694373645379ull, 10394869040465829563ull, - 3050054389497850473ull, 13511281315037739143ull, 2342994007222107511ull, - 6100108778995700947ull, 8575818556365926670ull, 4685988014444215023ull, - 12200217557991401894ull, 17151637112731853340ull, 9371976028888430046ull, - 5953691042273252173ull, 15856530151754155065ull, 297207984067308476ull, - 11907382084546504347ull, 13266316229798758514ull, 594415968134616952ull, - 5368020095383457079ull, 8085888385887965412ull, 1188831936269233905ull, - 10736040190766914158ull, 16171776771775930824ull, 2377663872538467810ull, - 3025336307824276701ull, 13896809469842310032ull, 4755327745076935621ull, - 6050672615648553403ull, 9346874865975068448ull, 9510655490153871242ull, - 12101345231297106807ull, 247005658240585281ull, 574566906598190869ull, - 5755946388884661998ull, 494011316481170562ull, 1149133813196381739ull, - 11511892777769323996ull, 988022632962341124ull, 2298267626392763478ull, - 4577041481829096376ull, 1976045265924682248ull, 4596535252785526956ull, - 9154082963658192752ull, 3952090531849364496ull, 9193070505571053912ull, - 18308165927316385504ull, 7904181063698728992ull, 18386141011142107824ull, - 18169587780923219392ull, 15808362127397457985ull, 18325537948574664033ull, - 17892431488136887169ull, 13169980181085364355ull, 18204331823439776451ull, - 17338118902564222723ull, 7893216288461177095ull, 17961919573170001286ull, - 16229493731418893830ull, 15786432576922354191ull, 17477095072630450957ull, - 14012243389128236045ull, 13126121080135156767ull, 16507446071551350299ull, - 9577742704546920475ull, 7805498086560761919ull, 14568148069393148982ull, - 708741335384289334ull, 15610996173121523839ull, 10689552065076746349ull, - 1417482670768578669ull, 12775248272533496063ull, 2932360056443941083ull, - 2834965341537157339ull, 7103752471357440510ull, 5864720112887882167ull, - 5669930683074314678ull, 14207504942714881020ull, 11729440225775764334ull, - 11339861366148629357ull, 9968265811720210425ull, 5012136377841977052ull, - 4232978658587707099ull, 1489787549730869234ull, 10024272755683954105ull, - 8465957317175414198ull, 2979575099461738469ull, 1601801437658356594ull, - 16931914634350828396ull, 5959150198923476938ull, 3203602875316713188ull, - 15417085194992105176ull, 11918300397846953876ull, 6407205750633426377ull, - 12387426316274658737ull, 5389856721984356136ull, 12814411501266852754ull, - 6328108558839765858ull, 10779713443968712273ull, 7182078928824153892ull, - 12656217117679531717ull, 3112682814227872930ull, 14364157857648307784ull, - 6865690161649511818ull, 6225365628455745861ull, 10281571641587063953ull, - 13731380323299023636ull, 12450731256911491723ull, 2116399209464576291ull, - 9016016572888495657ull, 6454718440113431830ull, 4232798418929152582ull, - 18032033145776991314ull, 12909436880226863660ull, 8465596837858305165ull, - 17617322217844431013ull, 7372129686744175704ull, 16931193675716610331ull, - 16787900361979310410ull, 14744259373488351409ull, 15415643277723669047ull, - 15129056650249069205ull, 11041774673267151203ull, 12384542481737786478ull, - 11811369226788586795ull, 3636805272824750791ull, 6322340889766021340ull, - 5175994379867621974ull, 7273610545649501582ull, 12644681779532042680ull, - 10351988759735243948ull, 14547221091299003165ull, 6842619485354533745ull, - 2257233445760936281ull, 10647698108888454714ull, 13685238970709067491ull, - 4514466891521872563ull, 2848652144067357813ull, 8923733867708583367ull, - 9028933783043745126ull, 5697304288134715626ull, 17847467735417166734ull, - 18057867566087490252ull, 11394608576269431253ull, 17248191397124781853ull, - 17668991058465428889ull, 4342473078829310891ull, 16049638720540012090ull, - 16891238043221306162ull, 8684946157658621783ull, 13652533367370472564ull, - 15335732012733060708ull, 17369892315317243567ull, 8858322661031393513ull, - 12224719951756569801ull, 16293040556924935518ull, 17716645322062787026ull, - 6002695829803587987ull, 14139337040140319421ull, 16986546570416022436ull, - 12005391659607175975ull, 9831930006571087227ull, 15526349067122493256ull, - 5564039245504800335ull, 1217115939432622839ull, 12605954060535434896ull, - 11128078491009600670ull, 2434231878865245679ull, 6765164047361318177ull, - 3809412908309649724ull, 4868463757730491358ull, 13530328094722636354ull, - 7618825816619299448ull, 9736927515460982717ull, 8613912115735721092ull, - 15237651633238598897ull, 1027110957212413818ull, 17227824231471442185ull, - 12028559192767646178ull, 2054221914424827637ull, 16008904389233332754ull, - 5610374311825740740ull, 4108443828849655275ull, 13571064704757113892ull, - 11220748623651481480ull, 8216887657699310551ull, 8695385335804676169ull, - 3994753173593411344ull, 16433775315398621102ull, 17390770671609352339ull, - 7989506347186822689ull, 14420806557087690589ull, 16334797269509153062ull, - 15979012694373645379ull, 10394869040465829563ull, 14222850465308754509ull, - 13511281315037739143ull, 2342994007222107511ull, 9998956856907957403ull, - 8575818556365926670ull, 4685988014444215023ull, 1551169640106363191ull, - 17151637112731853340ull, 9371976028888430046ull, 3102339280212726382ull, - 15856530151754155065ull, 297207984067308476ull, 6204678560425452765ull, - 13266316229798758514ull, 594415968134616952ull, 12409357120850905530ull, - 8085888385887965412ull, 1188831936269233905ull, 6371970167992259444ull, - 16171776771775930824ull, 2377663872538467810ull, 12743940335984518889ull, - 13896809469842310032ull, 4755327745076935621ull, 7041136598259486162ull, - 9346874865975068448ull, 9510655490153871242ull, 14082273196518972325ull, - 247005658240585281ull, 574566906598190869ull, 9717802319328393035ull, - 494011316481170562ull, 1149133813196381739ull, 988860564947234455ull, - 988022632962341124ull, 2298267626392763478ull, 1977721129894468910ull, - 1976045265924682248ull, 4596535252785526956ull, 3955442259788937820ull, - 3952090531849364496ull, 9193070505571053912ull, 7910884519577875640ull, - 7904181063698728992ull, 18386141011142107824ull, 15821769039155751280ull, - 15808362127397457985ull, 18325537948574664033ull, 13196794004601950944ull, - 13169980181085364355ull, 18204331823439776451ull, 7946843935494350272ull, - 7893216288461177095ull, 17961919573170001286ull, 15893687870988700544ull, - 15786432576922354191ull, 17477095072630450957ull, 13340631668267849472ull, - 13126121080135156767ull, 16507446071551350299ull, 8234519262826147328ull, - 7805498086560761919ull, 14568148069393148982ull, 16469038525652294656ull, - 15610996173121523839ull, 10689552065076746349ull, 14491332977595037697ull, - 12775248272533496063ull, 2932360056443941083ull, 10535921881480523779ull, - 7103752471357440510ull, 5864720112887882167ull, 2625099689251495942ull, - 14207504942714881020ull, 11729440225775764334ull, 5250199378502991884ull, - 9968265811720210425ull, 5012136377841977052ull, 10500398757005983769ull, - 1489787549730869234ull, 10024272755683954105ull, 2554053440302415922ull, - 2979575099461738469ull, 1601801437658356594ull, 5108106880604831844ull, - 5959150198923476938ull, 3203602875316713188ull, 10216213761209663689ull, - 11918300397846953876ull, 6407205750633426377ull, 1985683448709775762ull, - 5389856721984356136ull, 12814411501266852754ull, 3971366897419551524ull, - 10779713443968712273ull, 7182078928824153892ull, 7942733794839103049ull, - 3112682814227872930ull, 14364157857648307784ull, 15885467589678206098ull, - 6225365628455745861ull, 10281571641587063953ull, 13324191105646860580ull, - 12450731256911491723ull, 2116399209464576291ull, 8201638137584169545ull, - 6454718440113431830ull, 4232798418929152582ull, 16403276275168339090ull, - 12909436880226863660ull, 8465596837858305165ull, 14359808476627126565ull, - 7372129686744175704ull, 16931193675716610331ull, 10272872879544701515ull, - 14744259373488351409ull, 15415643277723669047ull, 2099001685379851415ull, - 11041774673267151203ull, 12384542481737786478ull, 4198003370759702830ull, - 3636805272824750791ull, 6322340889766021340ull, 8396006741519405661ull, - 7273610545649501582ull, 12644681779532042680ull, 16792013483038811323ull, - 14547221091299003165ull, 6842619485354533745ull, 15137282892368071031ull, - 10647698108888454714ull, 13685238970709067491ull, 11827821711026590446ull, - 2848652144067357813ull, 8923733867708583367ull, 5208899348343629277ull, - 5697304288134715626ull, 17847467735417166734ull, 10417798696687258554ull, - 11394608576269431253ull, 17248191397124781853ull, 2388853319664965493ull, - 4342473078829310891ull, 16049638720540012090ull, 4777706639329930986ull, - 8684946157658621783ull, 13652533367370472564ull, 9555413278659861972ull, - 17369892315317243567ull, 8858322661031393513ull, 664082483610172328ull, - 16293040556924935518ull, 17716645322062787026ull, 1328164967220344656ull, - 14139337040140319421ull, 16986546570416022436ull, 2656329934440689312ull, - 9831930006571087227ull, 15526349067122493256ull, 5312659868881378625ull, - 1217115939432622839ull, 12605954060535434896ull, 10625319737762757250ull, - 2434231878865245679ull, 6765164047361318177ull, 2803895401815962884ull, - 4868463757730491358ull, 13530328094722636354ull, 5607790803631925769ull, - 9736927515460982717ull, 8613912115735721092ull, 11215581607263851539ull, - 1027110957212413818ull, 17227824231471442185ull, 3984419140818151463ull, - 2054221914424827637ull, 16008904389233332754ull, 7968838281636302926ull, - 4108443828849655275ull, 13571064704757113892ull, 15937676563272605853ull, - 8216887657699310551ull, 8695385335804676169ull, 13428609052835660090ull, - 16433775315398621102ull, 17390770671609352339ull, 8410474031961768564ull, - 14420806557087690589ull, 16334797269509153062ull, 16820948063923537128ull, - 10394869040465829563ull, 14222850465308754509ull, 15195152054137522641ull, - 2342994007222107511ull, 9998956856907957403ull, 11943560034565493667ull, - 4685988014444215023ull, 1551169640106363191ull, 5440375995421435718ull, - 9371976028888430046ull, 3102339280212726382ull, 10880751990842871436ull, - 297207984067308476ull, 6204678560425452765ull, 3314759907976191257ull, - 594415968134616952ull, 12409357120850905530ull, 6629519815952382514ull, - 1188831936269233905ull, 6371970167992259444ull, 13259039631904765028ull, - 2377663872538467810ull, 12743940335984518889ull, 8071335190099978441ull, - 4755327745076935621ull, 7041136598259486162ull, 16142670380199956882ull, - 9510655490153871242ull, 14082273196518972325ull, 13838596686690362148ull, - 574566906598190869ull, 9717802319328393035ull, 9230449299671172680ull, - 1149133813196381739ull, 988860564947234455ull, 14154525632793744ull, - 2298267626392763478ull, 1977721129894468910ull, 28309051265587489ull, - 4596535252785526956ull, 3955442259788937820ull, 56618102531174979ull, - 9193070505571053912ull, 7910884519577875640ull, 113236205062349959ull, - 18386141011142107824ull, 15821769039155751280ull, 226472410124699918ull, - 18325537948574664033ull, 13196794004601950944ull, 452944820249399836ull, - 18204331823439776451ull, 7946843935494350272ull, 905889640498799673ull, - 17961919573170001286ull, 15893687870988700544ull, 1811779280997599347ull, - 17477095072630450957ull, 13340631668267849472ull, 3623558561995198695ull, - 16507446071551350299ull, 8234519262826147328ull, 7247117123990397391ull, - 14568148069393148982ull, 16469038525652294656ull, 14494234247980794783ull, - 10689552065076746349ull, 14491332977595037697ull, 10541724422252037951ull, - 2932360056443941083ull, 10535921881480523779ull, 2636704770794524287ull, - 5864720112887882167ull, 2625099689251495942ull, 5273409541589048574ull, - 11729440225775764334ull, 5250199378502991884ull, 10546819083178097148ull, - 5012136377841977052ull, 10500398757005983769ull, 2646894092646642680ull, - 10024272755683954105ull, 2554053440302415922ull, 5293788185293285360ull, - 1601801437658356594ull, 5108106880604831844ull, 10587576370586570721ull, - 3203602875316713188ull, 10216213761209663689ull, 2728408667463589827ull, - 6407205750633426377ull, 1985683448709775762ull, 5456817334927179655ull, - 12814411501266852754ull, 3971366897419551524ull, 10913634669854359310ull, - 7182078928824153892ull, 7942733794839103049ull, 3380525265999167005ull, - 14364157857648307784ull, 15885467589678206098ull, 6761050531998334011ull, - 10281571641587063953ull, 13324191105646860580ull, 13522101063996668023ull, - 2116399209464576291ull, 8201638137584169545ull, 8597458054283784431ull, - 4232798418929152582ull, 16403276275168339090ull, 17194916108567568862ull, - 8465596837858305165ull, 14359808476627126565ull, 15943088143425586109ull, - 16931193675716610331ull, 10272872879544701515ull, 13439432213141620602ull, - 15415643277723669047ull, 2099001685379851415ull, 8432120352573689589ull, - 12384542481737786478ull, 4198003370759702830ull, 16864240705147379179ull, - 6322340889766021340ull, 8396006741519405661ull, 15281737336585206742ull, - 12644681779532042680ull, 16792013483038811323ull, 12116730599460861868ull, - 6842619485354533745ull, 15137282892368071031ull, 5786717125212172120ull, - 13685238970709067491ull, 11827821711026590446ull, 11573434250424344241ull, - 8923733867708583367ull, 5208899348343629277ull, 4700124427139136867ull, - 17847467735417166734ull, 10417798696687258554ull, 9400248854278273735ull, - 17248191397124781853ull, 2388853319664965493ull, 353753634846995854ull, - 16049638720540012090ull, 4777706639329930986ull, 707507269693991708ull, - 13652533367370472564ull, 9555413278659861972ull, 1415014539387983417ull, - 8858322661031393513ull, 664082483610172328ull, 2830029078775966834ull, - 17716645322062787026ull, 1328164967220344656ull, 5660058157551933669ull, - 16986546570416022436ull, 2656329934440689312ull, 11320116315103867339ull, - 15526349067122493256ull, 5312659868881378625ull, 4193488556498183062ull, - 12605954060535434896ull, 10625319737762757250ull, 8386977112996366124ull, - 6765164047361318177ull, 2803895401815962884ull, 16773954225992732248ull, - 13530328094722636354ull, 5607790803631925769ull, 15101164378275912881ull, - 8613912115735721092ull, 11215581607263851539ull, 11755584682842274146ull, - 17227824231471442185ull, 3984419140818151463ull, 5064425291974996676ull, - 16008904389233332754ull, 7968838281636302926ull, 10128850583949993353ull, - 13571064704757113892ull, 15937676563272605853ull, 1810957094190435090ull, - 8695385335804676169ull, 13428609052835660090ull, 3621914188380870181ull, - 17390770671609352339ull, 8410474031961768564ull, 7243828376761740362ull, - 16334797269509153062ull, 16820948063923537128ull, 14487656753523480724ull, - 14222850465308754509ull, 15195152054137522641ull, 10528569433337409833ull, - 9998956856907957403ull, 11943560034565493667ull, 2610394792965268051ull, - 1551169640106363191ull, 5440375995421435718ull, 5220789585930536102ull, - 3102339280212726382ull, 10880751990842871436ull, 10441579171861072205ull, - 6204678560425452765ull, 3314759907976191257ull, 2436414270012592794ull, - 12409357120850905530ull, 6629519815952382514ull, 4872828540025185588ull, - 6371970167992259444ull, 13259039631904765028ull, 9745657080050371177ull, - 12743940335984518889ull, 8071335190099978441ull, 1044570086391190739ull, - 7041136598259486162ull, 16142670380199956882ull, 2089140172782381479ull, - 14082273196518972325ull, 13838596686690362148ull, 4178280345564762958ull, - 9717802319328393035ull, 9230449299671172680ull, 8356560691129525916ull, - 988860564947234455ull, 14154525632793744ull, 16713121382259051833ull, - 1977721129894468910ull, 28309051265587489ull, 14979498690808552051ull, - 3955442259788937820ull, 56618102531174979ull, 11512253307907552487ull, - 7910884519577875640ull, 113236205062349959ull, 4577762542105553359ull, - 15821769039155751280ull, 226472410124699918ull, 9155525084211106719ull, - 13196794004601950944ull, 452944820249399836ull, 18311050168422213438ull, - 7946843935494350272ull, 905889640498799673ull, 18175356263134875261ull, - 15893687870988700544ull, 1811779280997599347ull, 17903968452560198907ull, - 13340631668267849472ull, 3623558561995198695ull, 17361192831410846199ull, - 8234519262826147328ull, 7247117123990397391ull, 16275641589112140782ull, - 16469038525652294656ull, 14494234247980794783ull, 14104539104514729949ull, - 14491332977595037697ull, 10541724422252037951ull, 9762334135319908282ull, - 10535921881480523779ull, 2636704770794524287ull, 1077924196930264948ull, - 2625099689251495942ull, 5273409541589048574ull, 2155848393860529896ull, - 5250199378502991884ull, 10546819083178097148ull, 4311696787721059793ull, - 10500398757005983769ull, 2646894092646642680ull, 8623393575442119586ull, - 2554053440302415922ull, 5293788185293285360ull, 17246787150884239172ull, - 5108106880604831844ull, 10587576370586570721ull, 16046830228058926728ull, - 10216213761209663689ull, 2728408667463589827ull, 13646916382408301840ull, - 1985683448709775762ull, 5456817334927179655ull, 8847088691107052064ull, - 3971366897419551524ull, 10913634669854359310ull, 17694177382214104129ull, - 7942733794839103049ull, 3380525265999167005ull, 16941610690718656642ull, - 15885467589678206098ull, 6761050531998334011ull, 15436477307727761668ull, - 13324191105646860580ull, 13522101063996668023ull, 12426210541745971720ull, - 8201638137584169545ull, 8597458054283784431ull, 6405677009782391825ull, - 16403276275168339090ull, 17194916108567568862ull, 12811354019564783651ull, - 14359808476627126565ull, 15943088143425586109ull, 7175963965420015686ull, - 10272872879544701515ull, 13439432213141620602ull, 14351927930840031373ull, - 2099001685379851415ull, 8432120352573689589ull, 10257111787970511130ull, - 4198003370759702830ull, 16864240705147379179ull, 2067479502231470645ull, - 8396006741519405661ull, 15281737336585206742ull, 4134959004462941291ull, - 16792013483038811323ull, 12116730599460861868ull, 8269918008925882583ull, - 15137282892368071031ull, 5786717125212172120ull, 16539836017851765167ull, - 11827821711026590446ull, 11573434250424344241ull, 14632927961993978719ull, - 5208899348343629277ull, 4700124427139136867ull, 10819111850278405822ull, - 10417798696687258554ull, 9400248854278273735ull, 3191479626847260029ull, - 2388853319664965493ull, 353753634846995854ull, 6382959253694520058ull, - 4777706639329930986ull, 707507269693991708ull, 12765918507389040117ull, - 9555413278659861972ull, 1415014539387983417ull, 7085092941068528618ull, - 664082483610172328ull, 2830029078775966834ull, 14170185882137057236ull, - 1328164967220344656ull, 5660058157551933669ull, 9893627690564562857ull, - 2656329934440689312ull, 11320116315103867339ull, 1340511307419574098ull, - 5312659868881378625ull, 4193488556498183062ull, 2681022614839148197ull, - 10625319737762757250ull, 8386977112996366124ull, 5362045229678296395ull, - 2803895401815962884ull, 16773954225992732248ull, 10724090459356592791ull, - 5607790803631925769ull, 15101164378275912881ull, 3001436845003633966ull, - 11215581607263851539ull, 11755584682842274146ull, 6002873690007267933ull, - 3984419140818151463ull, 5064425291974996676ull, 12005747380014535866ull, - 7968838281636302926ull, 10128850583949993353ull, 5564750686319520117ull, - 15937676563272605853ull, 1810957094190435090ull, 11129501372639040235ull, - 13428609052835660090ull, 3621914188380870181ull, 3812258671568528855ull, - 8410474031961768564ull, 7243828376761740362ull, 7624517343137057710ull, - 16820948063923537128ull, 14487656753523480724ull, 15249034686274115421ull, - 15195152054137522641ull, 10528569433337409833ull, 12051325298838679227ull, - 11943560034565493667ull, 2610394792965268051ull, 5655906523967806838ull, - 5440375995421435718ull, 5220789585930536102ull, 11311813047935613677ull, - 10880751990842871436ull, 10441579171861072205ull, 4176882022161675738ull, - 3314759907976191257ull, 2436414270012592794ull, 8353764044323351476ull, - 6629519815952382514ull, 4872828540025185588ull, 16707528088646702952ull, - 13259039631904765028ull, 9745657080050371177ull, 14968312103583854289ull, - 8071335190099978441ull, 1044570086391190739ull, 11489880133458156962ull, - 16142670380199956882ull, 2089140172782381479ull, 4533016193206762308ull, - 13838596686690362148ull, 4178280345564762958ull, 9066032386413524617ull, - 9230449299671172680ull, 8356560691129525916ull, 18132064772827049234ull, - 14154525632793744ull, 16713121382259051833ull, 17817385471944546852ull, - 28309051265587489ull, 14979498690808552051ull, 17188026870179542088ull, - 56618102531174979ull, 11512253307907552487ull, 15929309666649532560ull, - 113236205062349959ull, 4577762542105553359ull, 13411875259589513505ull, - 226472410124699918ull, 9155525084211106719ull, 8377006445469475394ull, - 452944820249399836ull, 18311050168422213438ull, 16754012890938950788ull, - 905889640498799673ull, 18175356263134875261ull, 15061281708168349961ull, - 1811779280997599347ull, 17903968452560198907ull, 11675819342627148307ull, - 3623558561995198695ull, 17361192831410846199ull, 4904894611544744999ull, - 7247117123990397391ull, 16275641589112140782ull, 9809789223089489998ull, - 14494234247980794783ull, 14104539104514729949ull, 1172834372469428381ull, - 10541724422252037951ull, 9762334135319908282ull, 2345668744938856762ull, - 2636704770794524287ull, 1077924196930264948ull, 4691337489877713524ull, - 5273409541589048574ull, 2155848393860529896ull, 9382674979755427049ull, - 10546819083178097148ull, 4311696787721059793ull, 318605885801302483ull, - 2646894092646642680ull, 8623393575442119586ull, 637211771602604966ull, - 5293788185293285360ull, 17246787150884239172ull, 1274423543205209932ull, - 10587576370586570721ull, 16046830228058926728ull, 2548847086410419865ull, - 2728408667463589827ull, 13646916382408301840ull, 5097694172820839731ull, - 5456817334927179655ull, 8847088691107052064ull, 10195388345641679463ull, - 10913634669854359310ull, 17694177382214104129ull, 1944032617573807310ull, - 3380525265999167005ull, 16941610690718656642ull, 3888065235147614620ull, - 6761050531998334011ull, 15436477307727761668ull, 7776130470295229240ull, - 13522101063996668023ull, 12426210541745971720ull, 15552260940590458481ull, - 8597458054283784431ull, 6405677009782391825ull, 12657777807471365347ull, - 17194916108567568862ull, 12811354019564783651ull, 6868811541233179079ull, - 15943088143425586109ull, 7175963965420015686ull, 13737623082466358158ull, - 13439432213141620602ull, 14351927930840031373ull, 9028502091223164700ull, - 8432120352573689589ull, 10257111787970511130ull, 18057004182446329400ull, - 16864240705147379179ull, 2067479502231470645ull, 17667264291183107184ull, - 15281737336585206742ull, 4134959004462941291ull, 16887784508656662752ull, - 12116730599460861868ull, 8269918008925882583ull, 15328824943603773888ull, - 5786717125212172120ull, 16539836017851765167ull, 12210905813497996161ull, - 11573434250424344241ull, 14632927961993978719ull, 5975067553286440706ull, - 4700124427139136867ull, 10819111850278405822ull, 11950135106572881412ull, - 9400248854278273735ull, 3191479626847260029ull, 5453526139436211209ull, - 353753634846995854ull, 6382959253694520058ull, 10907052278872422419ull, - 707507269693991708ull, 12765918507389040117ull, 3367360484035293222ull, - 1415014539387983417ull, 7085092941068528618ull, 6734720968070586445ull, - 2830029078775966834ull, 14170185882137057236ull, 13469441936141172890ull, - 5660058157551933669ull, 9893627690564562857ull, 8492139798572794165ull, - 11320116315103867339ull, 1340511307419574098ull, 16984279597145588331ull, - 4193488556498183062ull, 2681022614839148197ull, 15521815120581625046ull, - 8386977112996366124ull, 5362045229678296395ull, 12596886167453698477ull, - 16773954225992732248ull, 10724090459356592791ull, 6747028261197845338ull, - 15101164378275912881ull, 3001436845003633966ull, 13494056522395690676ull, - 11755584682842274146ull, 6002873690007267933ull, 8541368971081829736ull, - 5064425291974996676ull, 12005747380014535866ull, 17082737942163659473ull, - 10128850583949993353ull, 5564750686319520117ull, 15718731810617767330ull, - 1810957094190435090ull, 11129501372639040235ull, 12990719547525983045ull, - 3621914188380870181ull, 3812258671568528855ull, 7534695021342414475ull, - 7243828376761740362ull, 7624517343137057710ull, 15069390042684828951ull, - 14487656753523480724ull, 15249034686274115421ull, 11692036011660106287ull, - 10528569433337409833ull, 12051325298838679227ull, 4937327949610660959ull, - 2610394792965268051ull, 5655906523967806838ull, 9874655899221321918ull, - 5220789585930536102ull, 11311813047935613677ull, 1302567724733092221ull, - 10441579171861072205ull, 4176882022161675738ull, 2605135449466184443ull, - 2436414270012592794ull, 8353764044323351476ull, 5210270898932368887ull, - 4872828540025185588ull, 16707528088646702952ull, 10420541797864737775ull, - 9745657080050371177ull, 14968312103583854289ull, 2394339522019923935ull, - 1044570086391190739ull, 11489880133458156962ull, 4788679044039847871ull, - 2089140172782381479ull, 4533016193206762308ull, 9577358088079695742ull, - 4178280345564762958ull, 9066032386413524617ull, 707972102449839868ull, - 8356560691129525916ull, 18132064772827049234ull, 1415944204899679737ull, - 16713121382259051833ull, 17817385471944546852ull, 2831888409799359474ull, - 14979498690808552051ull, 17188026870179542088ull, 5663776819598718948ull, - 11512253307907552487ull, 15929309666649532560ull, 11327553639197437896ull, - 4577762542105553359ull, 13411875259589513505ull, 4208363204685324176ull, - 9155525084211106719ull, 8377006445469475394ull, 8416726409370648352ull, - 18311050168422213438ull, 16754012890938950788ull, 16833452818741296705ull, - 18175356263134875261ull, 15061281708168349961ull, 15220161563773041794ull, - 17903968452560198907ull, 11675819342627148307ull, 11993579053836531972ull, - 17361192831410846199ull, 4904894611544744999ull, 5540414033963512329ull, - 16275641589112140782ull, 9809789223089489998ull, 11080828067927024659ull, - 14104539104514729949ull, 1172834372469428381ull, 3714912062144497703ull, - 9762334135319908282ull, 2345668744938856762ull, 7429824124288995406ull, - 1077924196930264948ull, 4691337489877713524ull, 14859648248577990812ull, - 2155848393860529896ull, 9382674979755427049ull, 11272552423446430009ull, - 4311696787721059793ull, 318605885801302483ull, 4098360773183308403ull, - 8623393575442119586ull, 637211771602604966ull, 8196721546366616806ull, - 17246787150884239172ull, 1274423543205209932ull, 16393443092733233612ull, - 16046830228058926728ull, 2548847086410419865ull, 14340142111756915609ull, - 13646916382408301840ull, 5097694172820839731ull, 10233540149804279602ull, - 8847088691107052064ull, 10195388345641679463ull, 2020336225899007588ull, - 17694177382214104129ull, 1944032617573807310ull, 4040672451798015176ull, - 16941610690718656642ull, 3888065235147614620ull, 8081344903596030353ull, - 15436477307727761668ull, 7776130470295229240ull, 16162689807192060707ull, - 12426210541745971720ull, 15552260940590458481ull, 13878635540674569799ull, - 6405677009782391825ull, 12657777807471365347ull, 9310527007639587982ull, - 12811354019564783651ull, 6868811541233179079ull, 174309941569624349ull, - 7175963965420015686ull, 13737623082466358158ull, 348619883139248698ull, - 14351927930840031373ull, 9028502091223164700ull, 697239766278497397ull, - 10257111787970511130ull, 18057004182446329400ull, 1394479532556994795ull, - 2067479502231470645ull, 17667264291183107184ull, 2788959065113989590ull, - 4134959004462941291ull, 16887784508656662752ull, 5577918130227979180ull, - 8269918008925882583ull, 15328824943603773888ull, 11155836260455958360ull, - 16539836017851765167ull, 12210905813497996161ull, 3864928447202365105ull, - 14632927961993978719ull, 5975067553286440706ull, 7729856894404730211ull, - 10819111850278405822ull, 11950135106572881412ull, 15459713788809460423ull, - 3191479626847260029ull, 5453526139436211209ull, 12472683503909369230ull, - 6382959253694520058ull, 10907052278872422419ull, 6498622934109186844ull, - 12765918507389040117ull, 3367360484035293222ull, 12997245868218373689ull, - 7085092941068528618ull, 6734720968070586445ull, 7547747662727195763ull, - 14170185882137057236ull, 13469441936141172890ull, 15095495325454391526ull, - 9893627690564562857ull, 8492139798572794165ull, 11744246577199231436ull, - 1340511307419574098ull, 16984279597145588331ull, 5041749080688911256ull, - 2681022614839148197ull, 15521815120581625046ull, 10083498161377822512ull, - 5362045229678296395ull, 12596886167453698477ull, 1720252249046093408ull, - 10724090459356592791ull, 6747028261197845338ull, 3440504498092186817ull, - 3001436845003633966ull, 13494056522395690676ull, 6881008996184373635ull, - 6002873690007267933ull, 8541368971081829736ull, 13762017992368747270ull, - 12005747380014535866ull, 17082737942163659473ull, 9077291911027942925ull, - 5564750686319520117ull, 15718731810617767330ull, 18154583822055885850ull, - 11129501372639040235ull, 12990719547525983045ull, 17862423570402220085ull, - 3812258671568528855ull, 7534695021342414475ull, 17278103067094888554ull, - 7624517343137057710ull, 15069390042684828951ull, 16109462060480225492ull, - 15249034686274115421ull, 11692036011660106287ull, 13772180047250899369ull, - 12051325298838679227ull, 4937327949610660959ull, 9097616020792247123ull, - 5655906523967806838ull, 9874655899221321918ull, 18195232041584494246ull, - 11311813047935613677ull, 1302567724733092221ull, 17943720009459436876ull, - 4176882022161675738ull, 2605135449466184443ull, 17440695945209322137ull, - 8353764044323351476ull, 5210270898932368887ull, 16434647816709092659ull, - 16707528088646702952ull, 10420541797864737775ull, 14422551559708633703ull, - 14968312103583854289ull, 2394339522019923935ull, 10398359045707715790ull, - 11489880133458156962ull, 4788679044039847871ull, 2349974017705879964ull, - 4533016193206762308ull, 9577358088079695742ull, 4699948035411759929ull, - 9066032386413524617ull, 707972102449839868ull, 9399896070823519859ull, - 18132064772827049234ull, 1415944204899679737ull, 353048067937488103ull, - 17817385471944546852ull, 2831888409799359474ull, 706096135874976207ull, - 17188026870179542088ull, 5663776819598718948ull, 1412192271749952415ull, - 15929309666649532560ull, 11327553639197437896ull, 2824384543499904830ull, - 13411875259589513505ull, 4208363204685324176ull, 5648769086999809661ull, - 8377006445469475394ull, 8416726409370648352ull, 11297538173999619322ull, - 16754012890938950788ull, 16833452818741296705ull, 4148332274289687028ull, - 15061281708168349961ull, 15220161563773041794ull, 8296664548579374057ull, - 11675819342627148307ull, 11993579053836531972ull, 16593329097158748114ull, - 4904894611544744999ull, 5540414033963512329ull, 14739914120607944612ull, - 9809789223089489998ull, 11080828067927024659ull, 11033084167506337609ull, - 1172834372469428381ull, 3714912062144497703ull, 3619424261303123603ull, - 2345668744938856762ull, 7429824124288995406ull, 7238848522606247207ull, - 4691337489877713524ull, 14859648248577990812ull, 14477697045212494414ull, - 9382674979755427049ull, 11272552423446430009ull, 10508650016715437212ull, - 318605885801302483ull, 4098360773183308403ull, 2570555959721322809ull, - 637211771602604966ull, 8196721546366616806ull, 5141111919442645618ull, - 1274423543205209932ull, 16393443092733233612ull, 10282223838885291236ull, - 2548847086410419865ull, 14340142111756915609ull, 2117703604061030856ull, - 5097694172820839731ull, 10233540149804279602ull, 4235407208122061712ull, - 10195388345641679463ull, 2020336225899007588ull, 8470814416244123425ull, - 1944032617573807310ull, 4040672451798015176ull, 16941628832488246850ull, - 3888065235147614620ull, 8081344903596030353ull, 15436513591266942084ull, - 7776130470295229240ull, 16162689807192060707ull, 12426283108824332552ull, - 15552260940590458481ull, 13878635540674569799ull, 6405822143939113489ull, - 12657777807471365347ull, 9310527007639587982ull, 12811644287878226978ull, - 6868811541233179079ull, 174309941569624349ull, 7176544502046902341ull, - 13737623082466358158ull, 348619883139248698ull, 14353089004093804683ull, - 9028502091223164700ull, 697239766278497397ull, 10259433934478057751ull, - 18057004182446329400ull, 1394479532556994795ull, 2072123795246563887ull, - 17667264291183107184ull, 2788959065113989590ull, 4144247590493127775ull, - 16887784508656662752ull, 5577918130227979180ull, 8288495180986255551ull, - 15328824943603773888ull, 11155836260455958360ull, 16576990361972511102ull, - 12210905813497996161ull, 3864928447202365105ull, 14707236650235470588ull, - 5975067553286440706ull, 7729856894404730211ull, 10967729226761389560ull, - 11950135106572881412ull, 15459713788809460423ull, 3488714379813227505ull, - 5453526139436211209ull, 12472683503909369230ull, 6977428759626455010ull, - 10907052278872422419ull, 6498622934109186844ull, 13954857519252910021ull, - 3367360484035293222ull, 12997245868218373689ull, 9462970964796268427ull, - 6734720968070586445ull, 7547747662727195763ull, 479197855882985239ull, - 13469441936141172890ull, 15095495325454391526ull, 958395711765970478ull, - 8492139798572794165ull, 11744246577199231436ull, 1916791423531940957ull, - 16984279597145588331ull, 5041749080688911256ull, 3833582847063881915ull, - 15521815120581625046ull, 10083498161377822512ull, 7667165694127763831ull, - 12596886167453698477ull, 1720252249046093408ull, 15334331388255527663ull, - 6747028261197845338ull, 3440504498092186817ull, 12221918702801503710ull, - 13494056522395690676ull, 6881008996184373635ull, 5997093331893455805ull, - 8541368971081829736ull, 13762017992368747270ull, 11994186663786911611ull, - 17082737942163659473ull, 9077291911027942925ull, 5541629253864271607ull, - 15718731810617767330ull, 18154583822055885850ull, 11083258507728543215ull, - 12990719547525983045ull, 17862423570402220085ull, 3719772941747534815ull, - 7534695021342414475ull, 17278103067094888554ull, 7439545883495069631ull, - 15069390042684828951ull, 16109462060480225492ull, 14879091766990139262ull, - 11692036011660106287ull, 13772180047250899369ull, 11311439460270726908ull, - 4937327949610660959ull, 9097616020792247123ull, 4176134846831902201ull, - 9874655899221321918ull, 18195232041584494246ull, 8352269693663804402ull, - 1302567724733092221ull, 17943720009459436876ull, 16704539387327608804ull, - 2605135449466184443ull, 17440695945209322137ull, 14962334700945665993ull, - 5210270898932368887ull, 16434647816709092659ull, 11477925328181780370ull, - 10420541797864737775ull, 14422551559708633703ull, 4509106582654009125ull, - 2394339522019923935ull, 10398359045707715790ull, 9018213165308018250ull, - 4788679044039847871ull, 2349974017705879964ull, 18036426330616036500ull, - 9577358088079695742ull, 4699948035411759929ull, 17626108587522521384ull, - 707972102449839868ull, 9399896070823519859ull, 16805473101335491152ull, - 1415944204899679737ull, 353048067937488103ull, 15164202128961430688ull, - 2831888409799359474ull, 706096135874976207ull, 11881660184213309761ull, - 5663776819598718948ull, 1412192271749952415ull, 5316576294717067907ull, - 11327553639197437896ull, 2824384543499904830ull, 10633152589434135815ull, - 4208363204685324176ull, 5648769086999809661ull, 2819561105158720014ull, - 8416726409370648352ull, 11297538173999619322ull, 5639122210317440029ull, - 16833452818741296705ull, 4148332274289687028ull, 11278244420634880059ull, - 15220161563773041794ull, 8296664548579374057ull, 4109744767560208502ull, - 11993579053836531972ull, 16593329097158748114ull, 8219489535120417004ull, - 5540414033963512329ull, 14739914120607944612ull, 16438979070240834008ull, - 11080828067927024659ull, 11033084167506337609ull, 14431214066772116401ull, - 3714912062144497703ull, 3619424261303123603ull, 10415684059834681187ull, - 7429824124288995406ull, 7238848522606247207ull, 2384624045959810759ull, - 14859648248577990812ull, 14477697045212494414ull, 4769248091919621519ull, - 11272552423446430009ull, 10508650016715437212ull, 9538496183839243039ull, - 4098360773183308403ull, 2570555959721322809ull, 630248293968934463ull, - 8196721546366616806ull, 5141111919442645618ull, 1260496587937868927ull, - 16393443092733233612ull, 10282223838885291236ull, 2520993175875737855ull, - 14340142111756915609ull, 2117703604061030856ull, 5041986351751475711ull, - 10233540149804279602ull, 4235407208122061712ull, 10083972703502951423ull, - 2020336225899007588ull, 8470814416244123425ull, 1721201333296351230ull, - 4040672451798015176ull, 16941628832488246850ull, 3442402666592702460ull, - 8081344903596030353ull, 15436513591266942084ull, 6884805333185404920ull, - 16162689807192060707ull, 12426283108824332552ull, 13769610666370809841ull, - 13878635540674569799ull, 6405822143939113489ull, 9092477259032068066ull, - 9310527007639587982ull, 12811644287878226978ull, 18184954518064136132ull, - 174309941569624349ull, 7176544502046902341ull, 17923164962418720649ull, - 348619883139248698ull, 14353089004093804683ull, 17399585851127889682ull, - 697239766278497397ull, 10259433934478057751ull, 16352427628546227749ull, - 1394479532556994795ull, 2072123795246563887ull, 14258111183382903883ull, - 2788959065113989590ull, 4144247590493127775ull, 10069478293056256151ull, - 5577918130227979180ull, 8288495180986255551ull, 1692212512402960687ull, - 11155836260455958360ull, 16576990361972511102ull, 3384425024805921375ull, - 3864928447202365105ull, 14707236650235470588ull, 6768850049611842751ull, - 7729856894404730211ull, 10967729226761389560ull, 13537700099223685503ull, - 15459713788809460423ull, 3488714379813227505ull, 8628656124737819391ull, - 12472683503909369230ull, 6977428759626455010ull, 17257312249475638783ull, - 6498622934109186844ull, 13954857519252910021ull, 16067880425241725951ull, - 12997245868218373689ull, 9462970964796268427ull, 13689016776773900287ull, - 7547747662727195763ull, 479197855882985239ull, 8931289479838248959ull, - 15095495325454391526ull, 958395711765970478ull, 17862578959676497919ull, - 11744246577199231436ull, 1916791423531940957ull, 17278413845643444222ull, - 5041749080688911256ull, 3833582847063881915ull, 16110083617577336829ull, - 10083498161377822512ull, 7667165694127763831ull, 13773423161445122043ull, - 1720252249046093408ull, 15334331388255527663ull, 9100102249180692471ull, - 3440504498092186817ull, 12221918702801503710ull, 18200204498361384943ull, - 6881008996184373635ull, 5997093331893455805ull, 17953664923013218270ull, - 13762017992368747270ull, 11994186663786911611ull, 17460585772316884924ull, - 9077291911027942925ull, 5541629253864271607ull, 16474427470924218232ull, - 18154583822055885850ull, 11083258507728543215ull, 14502110868138884848ull, - 17862423570402220085ull, 3719772941747534815ull, 10557477662568218080ull, - 17278103067094888554ull, 7439545883495069631ull, 2668211251426884544ull, - 16109462060480225492ull, 14879091766990139262ull, 5336422502853769089ull, - 13772180047250899369ull, 11311439460270726908ull, 10672845005707538178ull, - 9097616020792247123ull, 4176134846831902201ull, 2898945937705524741ull, - 18195232041584494246ull, 8352269693663804402ull, 5797891875411049483ull, - 17943720009459436876ull, 16704539387327608804ull, 11595783750822098966ull, - 17440695945209322137ull, 14962334700945665993ull, 4744823427934646316ull, - 16434647816709092659ull, 11477925328181780370ull, 9489646855869292633ull, - 14422551559708633703ull, 4509106582654009125ull, 532549638029033651ull, - 10398359045707715790ull, 9018213165308018250ull, 1065099276058067302ull, - 2349974017705879964ull, 18036426330616036500ull, 2130198552116134604ull, - 4699948035411759929ull, 17626108587522521384ull, 4260397104232269208ull, - 9399896070823519859ull, 16805473101335491152ull, 8520794208464538416ull, - 353048067937488103ull, 15164202128961430688ull, 17041588416929076832ull, - 706096135874976207ull, 11881660184213309761ull, 15636432760148602048ull, - 1412192271749952415ull, 5316576294717067907ull, 12826121446587652480ull, - 2824384543499904830ull, 10633152589434135815ull, 7205498819465753345ull, - 5648769086999809661ull, 2819561105158720014ull, 14410997638931506691ull, - 11297538173999619322ull, 5639122210317440029ull, 10375251204153461767ull, - 4148332274289687028ull, 11278244420634880059ull, 2303758334597371919ull, - 8296664548579374057ull, 4109744767560208502ull, 4607516669194743839ull, - 16593329097158748114ull, 8219489535120417004ull, 9215033338389487679ull, - 14739914120607944612ull, 16438979070240834008ull, 18430066676778975359ull, - 11033084167506337609ull, 14431214066772116401ull, 18413389279848399102ull, - 3619424261303123603ull, 10415684059834681187ull, 18380034485987246589ull, - 7238848522606247207ull, 2384624045959810759ull, 18313324898264941563ull, - 14477697045212494414ull, 4769248091919621519ull, 18179905722820331511ull, - 10508650016715437212ull, 9538496183839243039ull, 17913067371931111407ull, - 2570555959721322809ull, 630248293968934463ull, 17379390670152671198ull, - 5141111919442645618ull, 1260496587937868927ull, 16312037266595790780ull, - 10282223838885291236ull, 2520993175875737855ull, 14177330459482029945ull, - 2117703604061030856ull, 5041986351751475711ull, 9907916845254508274ull, - 4235407208122061712ull, 10083972703502951423ull, 1369089616799464933ull, - 8470814416244123425ull, 1721201333296351230ull, 2738179233598929867ull, - 16941628832488246850ull, 3442402666592702460ull, 5476358467197859735ull, - 15436513591266942084ull, 6884805333185404920ull, 10952716934395719471ull, - 12426283108824332552ull, 13769610666370809841ull, 3458689795081887326ull, - 6405822143939113489ull, 9092477259032068066ull, 6917379590163774652ull, - 12811644287878226978ull, 18184954518064136132ull, 13834759180327549304ull, - 7176544502046902341ull, 17923164962418720649ull, 9222774286945546993ull, - 14353089004093804683ull, 17399585851127889682ull, 18445548573891093986ull, - 10259433934478057751ull, 16352427628546227749ull, 18444353074072636356ull, - 2072123795246563887ull, 14258111183382903883ull, 18441962074435721096ull, - 4144247590493127775ull, 10069478293056256151ull, 18437180075161890577ull, - 8288495180986255551ull, 1692212512402960687ull, 18427616076614229539ull, - 16576990361972511102ull, 3384425024805921375ull, 18408488079518907462ull, - 14707236650235470588ull, 6768850049611842751ull, 18370232085328263308ull, - 10967729226761389560ull, 13537700099223685503ull, 18293720096946975000ull, - 3488714379813227505ull, 8628656124737819391ull, 18140696120184398385ull, - 6977428759626455010ull, 17257312249475638783ull, 17834648166659245154ull, - 13954857519252910021ull, 16067880425241725951ull, 17222552259608938693ull, - 9462970964796268427ull, 13689016776773900287ull, 15998360445508325771ull, - 479197855882985239ull, 8931289479838248959ull, 13549976817307099926ull, - 958395711765970478ull, 17862578959676497919ull, 8653209560904648237ull, - 1916791423531940957ull, 17278413845643444222ull, 17306419121809296474ull, - 3833582847063881915ull, 16110083617577336829ull, 16166094169909041333ull, - 7667165694127763831ull, 13773423161445122043ull, 13885444266108531051ull, - 15334331388255527663ull, 9100102249180692471ull, 9324144458507510486ull, - 12221918702801503710ull, 18200204498361384943ull, 201544843305469357ull, - 5997093331893455805ull, 17953664923013218270ull, 403089686610938714ull, - 11994186663786911611ull, 17460585772316884924ull, 806179373221877428ull, - 5541629253864271607ull, 16474427470924218232ull, 1612358746443754856ull, - 11083258507728543215ull, 14502110868138884848ull, 3224717492887509712ull, - 3719772941747534815ull, 10557477662568218080ull, 6449434985775019424ull, - 7439545883495069631ull, 2668211251426884544ull, 12898869971550038849ull, - 14879091766990139262ull, 5336422502853769089ull, 7350995869390526082ull, - 11311439460270726908ull, 10672845005707538178ull, 14701991738781052165ull, - 4176134846831902201ull, 2898945937705524741ull, 10957239403852552714ull, - 8352269693663804402ull, 5797891875411049483ull, 3467734733995553812ull, - 16704539387327608804ull, 11595783750822098966ull, 6935469467991107625ull, - 14962334700945665993ull, 4744823427934646316ull, 13870938935982215251ull, - 11477925328181780370ull, 9489646855869292633ull, 9295133798254878886ull, - 4509106582654009125ull, 532549638029033651ull, 143523522800206157ull, - 9018213165308018250ull, 1065099276058067302ull, 287047045600412315ull, - 18036426330616036500ull, 2130198552116134604ull, 574094091200824630ull, - 17626108587522521384ull, 4260397104232269208ull, 1148188182401649261ull, - 16805473101335491152ull, 8520794208464538416ull, 2296376364803298522ull, - 15164202128961430688ull, 17041588416929076832ull, 4592752729606597044ull, - 11881660184213309761ull, 15636432760148602048ull, 9185505459213194088ull, - 5316576294717067907ull, 12826121446587652480ull, 18371010918426388177ull, - 10633152589434135815ull, 7205498819465753345ull, 18295277763143224739ull, - 2819561105158720014ull, 14410997638931506691ull, 18143811452576897863ull, - 5639122210317440029ull, 10375251204153461767ull, 17840878831444244111ull, - 11278244420634880059ull, 2303758334597371919ull, 17235013589178936607ull, - 4109744767560208502ull, 4607516669194743839ull, 16023283104648321598ull, - 8219489535120417004ull, 9215033338389487679ull, 13599822135587091581ull, - 16438979070240834008ull, 18430066676778975359ull, 8752900197464631547ull, - 14431214066772116401ull, 18413389279848399102ull, 17505800394929263094ull, - 10415684059834681187ull, 18380034485987246589ull, 16564856716148974573ull, - 2384624045959810759ull, 18313324898264941563ull, 14682969358588397531ull, - 4769248091919621519ull, 18179905722820331511ull, 10919194643467243446ull, - 9538496183839243039ull, 17913067371931111407ull, 3391645213224935277ull, - 630248293968934463ull, 17379390670152671198ull, 6783290426449870554ull, - 1260496587937868927ull, 16312037266595790780ull, 13566580852899741108ull, - 2520993175875737855ull, 14177330459482029945ull, 8686417632089930601ull, - 5041986351751475711ull, 9907916845254508274ull, 17372835264179861203ull, - 10083972703502951423ull, 1369089616799464933ull, 16298926454650170790ull, - 1721201333296351230ull, 2738179233598929867ull, 14151108835590789965ull, - 3442402666592702460ull, 5476358467197859735ull, 9855473597472028315ull, - 6884805333185404920ull, 10952716934395719471ull, 1264203121234505014ull, - 13769610666370809841ull, 3458689795081887326ull, 2528406242469010028ull, - 9092477259032068066ull, 6917379590163774652ull, 5056812484938020057ull, - 18184954518064136132ull, 13834759180327549304ull, 10113624969876040115ull, - 17923164962418720649ull, 9222774286945546993ull, 1780505866042528615ull, - 17399585851127889682ull, 18445548573891093986ull, 3561011732085057231ull, - 16352427628546227749ull, 18444353074072636356ull, 7122023464170114463ull, - 14258111183382903883ull, 18441962074435721096ull, 14244046928340228927ull, - 10069478293056256151ull, 18437180075161890577ull, 10041349782970906238ull, - 1692212512402960687ull, 18427616076614229539ull, 1635955492232260861ull, - 3384425024805921375ull, 18408488079518907462ull, 3271910984464521723ull, - 6768850049611842751ull, 18370232085328263308ull, 6543821968929043446ull, - 13537700099223685503ull, 18293720096946975000ull, 13087643937858086892ull, - 8628656124737819391ull, 18140696120184398385ull, 7728543802006622169ull, - 17257312249475638783ull, 17834648166659245154ull, 15457087604013244339ull, - 16067880425241725951ull, 17222552259608938693ull, 12467431134316937063ull, - 13689016776773900287ull, 15998360445508325771ull, 6488118194924322511ull, - 8931289479838248959ull, 13549976817307099926ull, 12976236389848645022ull, - 17862578959676497919ull, 8653209560904648237ull, 7505728705987738428ull, - 17278413845643444222ull, 17306419121809296474ull, 15011457411975476857ull, - 16110083617577336829ull, 16166094169909041333ull, 11576170750241402098ull, - 13773423161445122043ull, 13885444266108531051ull, 4705597426773252580ull, - 9100102249180692471ull, 9324144458507510486ull, 9411194853546505161ull, - 18200204498361384943ull, 201544843305469357ull, 375645633383458707ull, - 17953664923013218270ull, 403089686610938714ull, 751291266766917415ull, - 17460585772316884924ull, 806179373221877428ull, 1502582533533834831ull, - 16474427470924218232ull, 1612358746443754856ull, 3005165067067669663ull, - 14502110868138884848ull, 3224717492887509712ull, 6010330134135339326ull, - 10557477662568218080ull, 6449434985775019424ull, 12020660268270678652ull, - 2668211251426884544ull, 12898869971550038849ull, 5594576462831805689ull, - 5336422502853769089ull, 7350995869390526082ull, 11189152925663611378ull, - 10672845005707538178ull, 14701991738781052165ull, 3931561777617671141ull, - 2898945937705524741ull, 10957239403852552714ull, 7863123555235342283ull, - 5797891875411049483ull, 3467734733995553812ull, 15726247110470684566ull, - 11595783750822098966ull, 6935469467991107625ull, 13005750147231817516ull, - 4744823427934646316ull, 13870938935982215251ull, 7564756220754083416ull, - 9489646855869292633ull, 9295133798254878886ull, 15129512441508166832ull, - 532549638029033651ull, 143523522800206157ull, 11812280809306782049ull, - 1065099276058067302ull, 287047045600412315ull, 5177817544904012482ull, - 2130198552116134604ull, 574094091200824630ull, 10355635089808024964ull, - 4260397104232269208ull, 1148188182401649261ull, 2264526105906498313ull, - 8520794208464538416ull, 2296376364803298522ull, 4529052211812996627ull, - 17041588416929076832ull, 4592752729606597044ull, 9058104423625993254ull, - 15636432760148602048ull, 9185505459213194088ull, 18116208847251986509ull, - 12826121446587652480ull, 18371010918426388177ull, 17785673620794421403ull, - 7205498819465753345ull, 18295277763143224739ull, 17124603167879291190ull, - 14410997638931506691ull, 18143811452576897863ull, 15802462262049030765ull, - 10375251204153461767ull, 17840878831444244111ull, 13158180450388509915ull, - 2303758334597371919ull, 17235013589178936607ull, 7869616827067468215ull, - 4607516669194743839ull, 16023283104648321598ull, 15739233654134936430ull, - 9215033338389487679ull, 13599822135587091581ull, 13031723234560321245ull, - 18430066676778975359ull, 8752900197464631547ull, 7616702395411090874ull, - 18413389279848399102ull, 17505800394929263094ull, 15233404790822181748ull, - 18380034485987246589ull, 16564856716148974573ull, 12020065507934811881ull, - 18313324898264941563ull, 14682969358588397531ull, 5593386942160072147ull, - 18179905722820331511ull, 10919194643467243446ull, 11186773884320144295ull, - 17913067371931111407ull, 3391645213224935277ull, 3926803694930736975ull, - 17379390670152671198ull, 6783290426449870554ull, 7853607389861473950ull, - 16312037266595790780ull, 13566580852899741108ull, 15707214779722947901ull, - 14177330459482029945ull, 8686417632089930601ull, 12967685485736344186ull, - 9907916845254508274ull, 17372835264179861203ull, 7488626897763136756ull, - 1369089616799464933ull, 16298926454650170790ull, 14977253795526273512ull, - 2738179233598929867ull, 14151108835590789965ull, 11507763517342995409ull, - 5476358467197859735ull, 9855473597472028315ull, 4568782960976439203ull, - 10952716934395719471ull, 1264203121234505014ull, 9137565921952878406ull, - 3458689795081887326ull, 2528406242469010028ull, 18275131843905756812ull, - 6917379590163774652ull, 5056812484938020057ull, 18103519614101962008ull, - 13834759180327549304ull, 10113624969876040115ull, 17760295154494372401ull, - 9222774286945546993ull, 1780505866042528615ull, 17073846235279193187ull, - 18445548573891093986ull, 3561011732085057231ull, 15700948396848834759ull, - 18444353074072636356ull, 7122023464170114463ull, 12955152719988117903ull, - 18441962074435721096ull, 14244046928340228927ull, 7463561366266684191ull, - 18437180075161890577ull, 10041349782970906238ull, 14927122732533368383ull, - 18427616076614229539ull, 1635955492232260861ull, 11407501391357185150ull, - 18408488079518907462ull, 3271910984464521723ull, 4368258709004818685ull, - 18370232085328263308ull, 6543821968929043446ull, 8736517418009637371ull, - 18293720096946975000ull, 13087643937858086892ull, 17473034836019274742ull, - 18140696120184398385ull, 7728543802006622169ull, 16499325598328997868ull, - 17834648166659245154ull, 15457087604013244339ull, 14551907122948444121ull, - 17222552259608938693ull, 12467431134316937063ull, 10657070172187336627ull, - 15998360445508325771ull, 6488118194924322511ull, 2867396270665121638ull, - 13549976817307099926ull, 12976236389848645022ull, 5734792541330243277ull, - 8653209560904648237ull, 7505728705987738428ull, 11469585082660486554ull, - 17306419121809296474ull, 15011457411975476857ull, 4492426091611421492ull, - 16166094169909041333ull, 11576170750241402098ull, 8984852183222842985ull, - 13885444266108531051ull, 4705597426773252580ull, 17969704366445685971ull, - 9324144458507510486ull, 9411194853546505161ull, 17492664659181820327ull, - 201544843305469357ull, 375645633383458707ull, 16538585244654089039ull, - 403089686610938714ull, 751291266766917415ull, 14630426415598626462ull, - 806179373221877428ull, 1502582533533834831ull, 10814108757487701308ull, - 1612358746443754856ull, 3005165067067669663ull, 3181473441265851001ull, - 3224717492887509712ull, 6010330134135339326ull, 6362946882531702002ull, - 6449434985775019424ull, 12020660268270678652ull, 12725893765063404005ull, - 12898869971550038849ull, 5594576462831805689ull, 7005043456417256395ull, - 7350995869390526082ull, 11189152925663611378ull, 14010086912834512791ull, - 14701991738781052165ull, 3931561777617671141ull, 9573429751959473967ull, - 10957239403852552714ull, 7863123555235342283ull, 700115430209396319ull, - 3467734733995553812ull, 15726247110470684566ull, 1400230860418792639ull, - 6935469467991107625ull, 13005750147231817516ull, 2800461720837585279ull, - 13870938935982215251ull, 7564756220754083416ull, 5600923441675170559ull, - 9295133798254878886ull, 15129512441508166832ull, 11201846883350341118ull, - 143523522800206157ull, 11812280809306782049ull, 3956949692991130621ull, - 287047045600412315ull, 5177817544904012482ull, 7913899385982261242ull, - 574094091200824630ull, 10355635089808024964ull, 15827798771964522485ull, - 1148188182401649261ull, 2264526105906498313ull, 13208853470219493354ull, - 2296376364803298522ull, 4529052211812996627ull, 7970962866729435092ull, - 4592752729606597044ull, 9058104423625993254ull, 15941925733458870184ull, - 9185505459213194088ull, 18116208847251986509ull, 13437107393208188753ull, - 18371010918426388177ull, 17785673620794421403ull, 8427470712706825890ull, - 18295277763143224739ull, 17124603167879291190ull, 16854941425413651781ull, - 18143811452576897863ull, 15802462262049030765ull, 15263138777117751947ull, - 17840878831444244111ull, 13158180450388509915ull, 12079533480525952278ull, - 17235013589178936607ull, 7869616827067468215ull, 5712322887342352941ull, - 16023283104648321598ull, 15739233654134936430ull, 11424645774684705882ull, - 13599822135587091581ull, 13031723234560321245ull, 4402547475659860149ull, - 8752900197464631547ull, 7616702395411090874ull, 8805094951319720299ull, - 17505800394929263094ull, 15233404790822181748ull, 17610189902639440599ull, - 16564856716148974573ull, 12020065507934811881ull, 16773635731569329582ull, - 14682969358588397531ull, 5593386942160072147ull, 15100527389429107549ull, - 10919194643467243446ull, 11186773884320144295ull, 11754310705148663482ull, - 3391645213224935277ull, 3926803694930736975ull, 5061877336587775349ull, - 6783290426449870554ull, 7853607389861473950ull, 10123754673175550698ull, - 13566580852899741108ull, 15707214779722947901ull, 1800765272641549780ull, - 8686417632089930601ull, 12967685485736344186ull, 3601530545283099561ull, - 17372835264179861203ull, 7488626897763136756ull, 7203061090566199122ull, - 16298926454650170790ull, 14977253795526273512ull, 14406122181132398244ull, - 14151108835590789965ull, 11507763517342995409ull, 10365500288555244873ull, - 9855473597472028315ull, 4568782960976439203ull, 2284256503400938131ull, - 1264203121234505014ull, 9137565921952878406ull, 4568513006801876263ull, - 2528406242469010028ull, 18275131843905756812ull, 9137026013603752527ull, - 5056812484938020057ull, 18103519614101962008ull, 18274052027207505054ull, - 10113624969876040115ull, 17760295154494372401ull, 18101359980705458493ull, - 1780505866042528615ull, 17073846235279193187ull, 17755975887701365371ull, - 3561011732085057231ull, 15700948396848834759ull, 17065207701693179127ull, - 7122023464170114463ull, 12955152719988117903ull, 15683671329676806638ull, - 14244046928340228927ull, 7463561366266684191ull, 12920598585644061661ull, - 10041349782970906238ull, 14927122732533368383ull, 7394453097578571706ull, - 1635955492232260861ull, 11407501391357185150ull, 14788906195157143413ull, - 3271910984464521723ull, 4368258709004818685ull, 11131068316604735211ull, - 6543821968929043446ull, 8736517418009637371ull, 3815392559499918806ull, - 13087643937858086892ull, 17473034836019274742ull, 7630785118999837612ull, - 7728543802006622169ull, 16499325598328997868ull, 15261570237999675224ull, - 15457087604013244339ull, 14551907122948444121ull, 12076396402289798833ull, - 12467431134316937063ull, 10657070172187336627ull, 5706048730870046051ull, - 6488118194924322511ull, 2867396270665121638ull, 11412097461740092103ull, - 12976236389848645022ull, 5734792541330243277ull, 4377450849770632591ull, - 7505728705987738428ull, 11469585082660486554ull, 8754901699541265183ull, - 15011457411975476857ull, 4492426091611421492ull, 17509803399082530367ull, - 11576170750241402098ull, 8984852183222842985ull, 16572862724455509118ull, - 4705597426773252580ull, 17969704366445685971ull, 14698981375201466621ull, - 9411194853546505161ull, 17492664659181820327ull, 10951218676693381626ull, - 375645633383458707ull, 16538585244654089039ull, 3455693279677211637ull, - 751291266766917415ull, 14630426415598626462ull, 6911386559354423275ull, - 1502582533533834831ull, 10814108757487701308ull, 13822773118708846551ull, - 3005165067067669663ull, 3181473441265851001ull, 9198802163708141487ull, - 6010330134135339326ull, 6362946882531702002ull, 18397604327416282975ull, - 12020660268270678652ull, 12725893765063404005ull, 18348464581123014334ull, - 5594576462831805689ull, 7005043456417256395ull, 18250185088536477052ull, - 11189152925663611378ull, 14010086912834512791ull, 18053626103363402489ull, - 3931561777617671141ull, 9573429751959473967ull, 17660508133017253362ull, - 7863123555235342283ull, 700115430209396319ull, 16874272192324955109ull, - 15726247110470684566ull, 1400230860418792639ull, 15301800310940358603ull, - 13005750147231817516ull, 2800461720837585279ull, 12156856548171165591ull, - 7564756220754083416ull, 5600923441675170559ull, 5866969022632779567ull, - 15129512441508166832ull, 11201846883350341118ull, 11733938045265559135ull, - 11812280809306782049ull, 3956949692991130621ull, 5021132016821566654ull, - 5177817544904012482ull, 7913899385982261242ull, 10042264033643133308ull, - 10355635089808024964ull, 15827798771964522485ull, 1637783993576715000ull, - 2264526105906498313ull, 13208853470219493354ull, 3275567987153430001ull, - 4529052211812996627ull, 7970962866729435092ull, 6551135974306860002ull, - 9058104423625993254ull, 15941925733458870184ull, 13102271948613720005ull, - 18116208847251986509ull, 13437107393208188753ull, 7757799823517888395ull, - 17785673620794421403ull, 8427470712706825890ull, 15515599647035776791ull, - 17124603167879291190ull, 16854941425413651781ull, 12584455220362001967ull, - 15802462262049030765ull, 15263138777117751947ull, 6722166367014452318ull, - 13158180450388509915ull, 12079533480525952278ull, 13444332734028904637ull, - 7869616827067468215ull, 5712322887342352941ull, 8441921394348257659ull, - 15739233654134936430ull, 11424645774684705882ull, 16883842788696515318ull, - 13031723234560321245ull, 4402547475659860149ull, 15320941503683479020ull, - 7616702395411090874ull, 8805094951319720299ull, 12195138933657406425ull, - 15233404790822181748ull, 17610189902639440599ull, 5943533793605261235ull, - 12020065507934811881ull, 16773635731569329582ull, 11887067587210522471ull, - 5593386942160072147ull, 15100527389429107549ull, 5327391100711493327ull, - 11186773884320144295ull, 11754310705148663482ull, 10654782201422986654ull, - 3926803694930736975ull, 5061877336587775349ull, 2862820329136421693ull, - 7853607389861473950ull, 10123754673175550698ull, 5725640658272843386ull, - 15707214779722947901ull, 1800765272641549780ull, 11451281316545686772ull, - 12967685485736344186ull, 3601530545283099561ull, 4455818559381821928ull, - 7488626897763136756ull, 7203061090566199122ull, 8911637118763643856ull, - 14977253795526273512ull, 14406122181132398244ull, 17823274237527287712ull, - 11507763517342995409ull, 10365500288555244873ull, 17199804401345023809ull, - 4568782960976439203ull, 2284256503400938131ull, 15952864728980496003ull, - 9137565921952878406ull, 4568513006801876263ull, 13458985384251440391ull, - 18275131843905756812ull, 9137026013603752527ull, 8471226694793329166ull, - 18103519614101962008ull, 18274052027207505054ull, 16942453389586658332ull, - 17760295154494372401ull, 18101359980705458493ull, 15438162705463765049ull, - 17073846235279193187ull, 17755975887701365371ull, 12429581337217978483ull, - 15700948396848834759ull, 17065207701693179127ull, 6412418600726405351ull, - 12955152719988117903ull, 15683671329676806638ull, 12824837201452810702ull, - 7463561366266684191ull, 12920598585644061661ull, 7202930329196069788ull, - 14927122732533368383ull, 7394453097578571706ull, 14405860658392139577ull, - 11407501391357185150ull, 14788906195157143413ull, 10364977243074727539ull, - 4368258709004818685ull, 11131068316604735211ull, 2283210412439903463ull, - 8736517418009637371ull, 3815392559499918806ull, 4566420824879806927ull, - 17473034836019274742ull, 7630785118999837612ull, 9132841649759613855ull, - 16499325598328997868ull, 15261570237999675224ull, 18265683299519227710ull, - 14551907122948444121ull, 12076396402289798833ull, 18084622525328903805ull, - 10657070172187336627ull, 5706048730870046051ull, 17722500976948255995ull, - 2867396270665121638ull, 11412097461740092103ull, 16998257880186960375ull, - 5734792541330243277ull, 4377450849770632591ull, 15549771686664369135ull, - 11469585082660486554ull, 8754901699541265183ull, 12652799299619186654ull, - 4492426091611421492ull, 17509803399082530367ull, 6858854525528821692ull, - 8984852183222842985ull, 16572862724455509118ull, 13717709051057643384ull, - 17969704366445685971ull, 14698981375201466621ull, 8988674028405735153ull, - 17492664659181820327ull, 10951218676693381626ull, 17977348056811470306ull, - 16538585244654089039ull, 3455693279677211637ull, 17507952039913388997ull, - 14630426415598626462ull, 6911386559354423275ull, 16569160006117226378ull, - 10814108757487701308ull, 13822773118708846551ull, 14691575938524901140ull, - 3181473441265851001ull, 9198802163708141487ull, 10936407803340250665ull, - 6362946882531702002ull, 18397604327416282975ull, 3426071532970949714ull, - 12725893765063404005ull, 18348464581123014334ull, 6852143065941899429ull, - 7005043456417256395ull, 18250185088536477052ull, 13704286131883798858ull, - 14010086912834512791ull, 18053626103363402489ull, 8961828190058046100ull, - 9573429751959473967ull, 17660508133017253362ull, 17923656380116092201ull, - 700115430209396319ull, 16874272192324955109ull, 17400568686522632786ull, - 1400230860418792639ull, 15301800310940358603ull, 16354393299335713957ull, - 2800461720837585279ull, 12156856548171165591ull, 14262042524961876298ull, - 5600923441675170559ull, 5866969022632779567ull, 10077340976214200980ull, - 11201846883350341118ull, 11733938045265559135ull, 1707937878718850345ull, - 3956949692991130621ull, 5021132016821566654ull, 3415875757437700690ull, - 7913899385982261242ull, 10042264033643133308ull, 6831751514875401380ull, - 15827798771964522485ull, 1637783993576715000ull, 13663503029750802761ull, - 13208853470219493354ull, 3275567987153430001ull, 8880261985792053906ull, - 7970962866729435092ull, 6551135974306860002ull, 17760523971584107813ull, - 15941925733458870184ull, 13102271948613720005ull, 17074303869458664011ull, - 13437107393208188753ull, 7757799823517888395ull, 15701863665207776407ull, - 8427470712706825890ull, 15515599647035776791ull, 12956983256706001198ull, - 16854941425413651781ull, 12584455220362001967ull, 7467222439702450781ull, - 15263138777117751947ull, 6722166367014452318ull, 14934444879404901562ull, - 12079533480525952278ull, 13444332734028904637ull, 11422145685100251509ull, - 5712322887342352941ull, 8441921394348257659ull, 4397547296490951402ull, - 11424645774684705882ull, 16883842788696515318ull, 8795094592981902804ull, - 4402547475659860149ull, 15320941503683479020ull, 17590189185963805609ull, - 8805094951319720299ull, 12195138933657406425ull, 16733634298218059603ull, - 17610189902639440599ull, 5943533793605261235ull, 15020524522726567590ull, - 16773635731569329582ull, 11887067587210522471ull, 11594304971743583565ull, - 15100527389429107549ull, 5327391100711493327ull, 4741865869777615514ull, - 11754310705148663482ull, 10654782201422986654ull, 9483731739555231029ull, - 5061877336587775349ull, 2862820329136421693ull, 520719405400910443ull, - 10123754673175550698ull, 5725640658272843386ull, 1041438810801820887ull, - 1800765272641549780ull, 11451281316545686772ull, 2082877621603641775ull, - 3601530545283099561ull, 4455818559381821928ull, 4165755243207283551ull, - 7203061090566199122ull, 8911637118763643856ull, 8331510486414567103ull, - 14406122181132398244ull, 17823274237527287712ull, 16663020972829134207ull, - 10365500288555244873ull, 17199804401345023809ull, 14879297871948716798ull, - 2284256503400938131ull, 15952864728980496003ull, 11311851670187881981ull, - 4568513006801876263ull, 13458985384251440391ull, 4176959266666212347ull, - 9137026013603752527ull, 8471226694793329166ull, 8353918533332424694ull, - 18274052027207505054ull, 16942453389586658332ull, 16707837066664849389ull, - 18101359980705458493ull, 15438162705463765049ull, 14968930059620147162ull, - 17755975887701365371ull, 12429581337217978483ull, 11491116045530742709ull, - 17065207701693179127ull, 6412418600726405351ull, 4535488017351933803ull, - 15683671329676806638ull, 12824837201452810702ull, 9070976034703867607ull, - 12920598585644061661ull, 7202930329196069788ull, 18141952069407735215ull, - 7394453097578571706ull, 14405860658392139577ull, 17837160065105918815ull, - 14788906195157143413ull, 10364977243074727539ull, 17227576056502286015ull, - 11131068316604735211ull, 2283210412439903463ull, 16008408039295020414ull, - 3815392559499918806ull, 4566420824879806927ull, 13570072004880489213ull, - 7630785118999837612ull, 9132841649759613855ull, 8693399936051426811ull, - 15261570237999675224ull, 18265683299519227710ull, 17386799872102853622ull, - 12076396402289798833ull, 18084622525328903805ull, 16326855670496155628ull, - 5706048730870046051ull, 17722500976948255995ull, 14206967267282759640ull, - 11412097461740092103ull, 16998257880186960375ull, 9967190460855967665ull, - 4377450849770632591ull, 15549771686664369135ull, 1487636848002383714ull, - 8754901699541265183ull, 12652799299619186654ull, 2975273696004767428ull, - 17509803399082530367ull, 6858854525528821692ull, 5950547392009534856ull, - 16572862724455509118ull, 13717709051057643384ull, 11901094784019069713ull, - 14698981375201466621ull, 8988674028405735153ull, 5355445494328587811ull, - 10951218676693381626ull, 17977348056811470306ull, 10710890988657175623ull, - 3455693279677211637ull, 17507952039913388997ull, 2975037903604799631ull, - 6911386559354423275ull, 16569160006117226378ull, 5950075807209599263ull, - 13822773118708846551ull, 14691575938524901140ull, 11900151614419198527ull, - 9198802163708141487ull, 10936407803340250665ull, 5353559155128845438ull, - 18397604327416282975ull, 3426071532970949714ull, 10707118310257690876ull, - 18348464581123014334ull, 6852143065941899429ull, 2967492546805830136ull, - 18250185088536477052ull, 13704286131883798858ull, 5934985093611660273ull, - 18053626103363402489ull, 8961828190058046100ull, 11869970187223320547ull, - 17660508133017253362ull, 17923656380116092201ull, 5293196300737089478ull, - 16874272192324955109ull, 17400568686522632786ull, 10586392601474178957ull, - 15301800310940358603ull, 16354393299335713957ull, 2726041129238806298ull, - 12156856548171165591ull, 14262042524961876298ull, 5452082258477612597ull, - 5866969022632779567ull, 10077340976214200980ull, 10904164516955225194ull, - 11733938045265559135ull, 1707937878718850345ull, 3361584960200898773ull, - 5021132016821566654ull, 3415875757437700690ull, 6723169920401797547ull, - 10042264033643133308ull, 6831751514875401380ull, 13446339840803595095ull, - 1637783993576715000ull, 13663503029750802761ull, 8445935607897638574ull, - 3275567987153430001ull, 8880261985792053906ull, 16891871215795277149ull, - 6551135974306860002ull, 17760523971584107813ull, 15336998357881002682ull, - 13102271948613720005ull, 17074303869458664011ull, 12227252642052453748ull, - 7757799823517888395ull, 15701863665207776407ull, 6007761210395355880ull, - 15515599647035776791ull, 12956983256706001198ull, 12015522420790711760ull, - 12584455220362001967ull, 7467222439702450781ull, 5584300767871871905ull, - 6722166367014452318ull, 14934444879404901562ull, 11168601535743743810ull, - 13444332734028904637ull, 11422145685100251509ull, 3890458997777936004ull, - 8441921394348257659ull, 4397547296490951402ull, 7780917995555872008ull, - 16883842788696515318ull, 8795094592981902804ull, 15561835991111744016ull, - 15320941503683479020ull, 17590189185963805609ull, 12676927908513936417ull, - 12195138933657406425ull, 16733634298218059603ull, 6907111743318321218ull, - 5943533793605261235ull, 15020524522726567590ull, 13814223486636642437ull, - 11887067587210522471ull, 11594304971743583565ull, 9181702899563733258ull, - 5327391100711493327ull, 4741865869777615514ull, 18363405799127466517ull, - 10654782201422986654ull, 9483731739555231029ull, 18280067524545381419ull, - 2862820329136421693ull, 520719405400910443ull, 18113390975381211222ull, - 5725640658272843386ull, 1041438810801820887ull, 17780037877052870828ull, - 11451281316545686772ull, 2082877621603641775ull, 17113331680396190040ull, -};; - -} // namespace npsr::trig::data - -#endif // NPSR_TRIG_DATA_REDUCTION_H