mirror of
https://gitlab.com/libeigen/eigen.git
synced 2025-04-23 10:09:36 +08:00
Implement AVX512 vectorization of std::complex<float/double>
This commit is contained in:
parent
3fba59ea59
commit
c53eececb0
@ -154,14 +154,12 @@ using std::ptrdiff_t;
|
|||||||
#if defined EIGEN_VECTORIZE_AVX512
|
#if defined EIGEN_VECTORIZE_AVX512
|
||||||
#include "src/Core/arch/SSE/PacketMath.h"
|
#include "src/Core/arch/SSE/PacketMath.h"
|
||||||
#include "src/Core/arch/SSE/TypeCasting.h"
|
#include "src/Core/arch/SSE/TypeCasting.h"
|
||||||
// FIXME: this needs to be fixed (compilation issue if included)
|
#include "src/Core/arch/SSE/Complex.h"
|
||||||
// there is no reason to disable SSE/AVX vectorization
|
|
||||||
// of complex<> while enabling AVX512.
|
|
||||||
// #include "src/Core/arch/SSE/Complex.h"
|
|
||||||
#include "src/Core/arch/AVX/PacketMath.h"
|
#include "src/Core/arch/AVX/PacketMath.h"
|
||||||
#include "src/Core/arch/AVX/TypeCasting.h"
|
#include "src/Core/arch/AVX/TypeCasting.h"
|
||||||
// #include "src/Core/arch/AVX/Complex.h"
|
#include "src/Core/arch/AVX/Complex.h"
|
||||||
#include "src/Core/arch/AVX512/PacketMath.h"
|
#include "src/Core/arch/AVX512/PacketMath.h"
|
||||||
|
#include "src/Core/arch/AVX512/Complex.h"
|
||||||
#include "src/Core/arch/SSE/MathFunctions.h"
|
#include "src/Core/arch/SSE/MathFunctions.h"
|
||||||
#include "src/Core/arch/AVX/MathFunctions.h"
|
#include "src/Core/arch/AVX/MathFunctions.h"
|
||||||
#include "src/Core/arch/AVX512/MathFunctions.h"
|
#include "src/Core/arch/AVX512/MathFunctions.h"
|
||||||
|
@ -56,6 +56,7 @@ struct default_packet_traits
|
|||||||
HasConj = 1,
|
HasConj = 1,
|
||||||
HasSetLinear = 1,
|
HasSetLinear = 1,
|
||||||
HasBlend = 0,
|
HasBlend = 0,
|
||||||
|
HasReduxp = 1,
|
||||||
|
|
||||||
HasDiv = 0,
|
HasDiv = 0,
|
||||||
HasSqrt = 0,
|
HasSqrt = 0,
|
||||||
|
@ -22,6 +22,7 @@ struct Packet4cf
|
|||||||
__m256 v;
|
__m256 v;
|
||||||
};
|
};
|
||||||
|
|
||||||
|
#ifndef EIGEN_VECTORIZE_AVX512
|
||||||
template<> struct packet_traits<std::complex<float> > : default_packet_traits
|
template<> struct packet_traits<std::complex<float> > : default_packet_traits
|
||||||
{
|
{
|
||||||
typedef Packet4cf type;
|
typedef Packet4cf type;
|
||||||
@ -44,6 +45,7 @@ template<> struct packet_traits<std::complex<float> > : default_packet_traits
|
|||||||
HasSetLinear = 0
|
HasSetLinear = 0
|
||||||
};
|
};
|
||||||
};
|
};
|
||||||
|
#endif
|
||||||
|
|
||||||
template<> struct unpacket_traits<Packet4cf> { typedef std::complex<float> type; enum {size=4, alignment=Aligned32}; typedef Packet2cf half; };
|
template<> struct unpacket_traits<Packet4cf> { typedef std::complex<float> type; enum {size=4, alignment=Aligned32}; typedef Packet2cf half; };
|
||||||
|
|
||||||
@ -228,6 +230,7 @@ struct Packet2cd
|
|||||||
__m256d v;
|
__m256d v;
|
||||||
};
|
};
|
||||||
|
|
||||||
|
#ifndef EIGEN_VECTORIZE_AVX512
|
||||||
template<> struct packet_traits<std::complex<double> > : default_packet_traits
|
template<> struct packet_traits<std::complex<double> > : default_packet_traits
|
||||||
{
|
{
|
||||||
typedef Packet2cd type;
|
typedef Packet2cd type;
|
||||||
@ -250,6 +253,7 @@ template<> struct packet_traits<std::complex<double> > : default_packet_traits
|
|||||||
HasSetLinear = 0
|
HasSetLinear = 0
|
||||||
};
|
};
|
||||||
};
|
};
|
||||||
|
#endif
|
||||||
|
|
||||||
template<> struct unpacket_traits<Packet2cd> { typedef std::complex<double> type; enum {size=2, alignment=Aligned32}; typedef Packet1cd half; };
|
template<> struct unpacket_traits<Packet2cd> { typedef std::complex<double> type; enum {size=2, alignment=Aligned32}; typedef Packet1cd half; };
|
||||||
|
|
||||||
|
442
Eigen/src/Core/arch/AVX512/Complex.h
Normal file
442
Eigen/src/Core/arch/AVX512/Complex.h
Normal file
@ -0,0 +1,442 @@
|
|||||||
|
// This file is part of Eigen, a lightweight C++ template library
|
||||||
|
// for linear algebra.
|
||||||
|
//
|
||||||
|
// Copyright (C) 2018 Gael Guennebaud <gael.guennebaud@inria.fr>
|
||||||
|
//
|
||||||
|
// This Source Code Form is subject to the terms of the Mozilla
|
||||||
|
// Public License v. 2.0. If a copy of the MPL was not distributed
|
||||||
|
// with this file, You can obtain one at http://mozilla.org/MPL/2.0/.
|
||||||
|
|
||||||
|
#ifndef EIGEN_COMPLEX_AVX512_H
|
||||||
|
#define EIGEN_COMPLEX_AVX512_H
|
||||||
|
|
||||||
|
namespace Eigen {
|
||||||
|
|
||||||
|
namespace internal {
|
||||||
|
|
||||||
|
//---------- float ----------
|
||||||
|
struct Packet8cf
|
||||||
|
{
|
||||||
|
EIGEN_STRONG_INLINE Packet8cf() {}
|
||||||
|
EIGEN_STRONG_INLINE explicit Packet8cf(const __m512& a) : v(a) {}
|
||||||
|
__m512 v;
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct packet_traits<std::complex<float> > : default_packet_traits
|
||||||
|
{
|
||||||
|
typedef Packet8cf type;
|
||||||
|
typedef Packet4cf half;
|
||||||
|
enum {
|
||||||
|
Vectorizable = 1,
|
||||||
|
AlignedOnScalar = 1,
|
||||||
|
size = 8,
|
||||||
|
HasHalfPacket = 1,
|
||||||
|
|
||||||
|
HasAdd = 1,
|
||||||
|
HasSub = 1,
|
||||||
|
HasMul = 1,
|
||||||
|
HasDiv = 1,
|
||||||
|
HasNegate = 1,
|
||||||
|
HasAbs = 0,
|
||||||
|
HasAbs2 = 0,
|
||||||
|
HasMin = 0,
|
||||||
|
HasMax = 0,
|
||||||
|
HasSetLinear = 0,
|
||||||
|
HasReduxp = 0
|
||||||
|
};
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct unpacket_traits<Packet8cf> {
|
||||||
|
typedef std::complex<float> type;
|
||||||
|
enum {
|
||||||
|
size = 8,
|
||||||
|
alignment=unpacket_traits<Packet16f>::alignment
|
||||||
|
};
|
||||||
|
typedef Packet4cf half;
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf padd<Packet8cf>(const Packet8cf& a, const Packet8cf& b) { return Packet8cf(_mm512_add_ps(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf psub<Packet8cf>(const Packet8cf& a, const Packet8cf& b) { return Packet8cf(_mm512_sub_ps(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pnegate(const Packet8cf& a)
|
||||||
|
{
|
||||||
|
return Packet8cf(pnegate(a.v));
|
||||||
|
}
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pconj(const Packet8cf& a)
|
||||||
|
{
|
||||||
|
const __m512 mask = _mm512_castsi512_ps(_mm512_setr_epi32(
|
||||||
|
0x00000000,0x80000000,0x00000000,0x80000000,0x00000000,0x80000000,0x00000000,0x80000000,
|
||||||
|
0x00000000,0x80000000,0x00000000,0x80000000,0x00000000,0x80000000,0x00000000,0x80000000));
|
||||||
|
return Packet8cf(_mm512_xor_ps(a.v,mask));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pmul<Packet8cf>(const Packet8cf& a, const Packet8cf& b)
|
||||||
|
{
|
||||||
|
__m512 tmp2 = _mm512_mul_ps(_mm512_movehdup_ps(a.v), _mm512_permute_ps(b.v, _MM_SHUFFLE(2,3,0,1)));
|
||||||
|
return Packet8cf(_mm512_fmaddsub_ps(_mm512_moveldup_ps(a.v), b.v, tmp2));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pand <Packet8cf>(const Packet8cf& a, const Packet8cf& b) { return Packet8cf(_mm512_and_ps(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf por <Packet8cf>(const Packet8cf& a, const Packet8cf& b) { return Packet8cf(_mm512_or_ps(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pxor <Packet8cf>(const Packet8cf& a, const Packet8cf& b) { return Packet8cf(_mm512_xor_ps(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pandnot<Packet8cf>(const Packet8cf& a, const Packet8cf& b) { return Packet8cf(_mm512_andnot_ps(a.v,b.v)); }
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pload <Packet8cf>(const std::complex<float>* from) { EIGEN_DEBUG_ALIGNED_LOAD return Packet8cf(pload<Packet16f>(&numext::real_ref(*from))); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf ploadu<Packet8cf>(const std::complex<float>* from) { EIGEN_DEBUG_UNALIGNED_LOAD return Packet8cf(ploadu<Packet16f>(&numext::real_ref(*from))); }
|
||||||
|
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pset1<Packet8cf>(const std::complex<float>& from)
|
||||||
|
{
|
||||||
|
return Packet8cf(_mm512_castpd_ps(pload1<Packet8d>((const double*)(const void*)&from)));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf ploaddup<Packet8cf>(const std::complex<float>* from)
|
||||||
|
{
|
||||||
|
return Packet8cf( _mm512_castpd_ps( ploaddup<Packet8d>((const double*)(const void*)from )) );
|
||||||
|
}
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf ploadquad<Packet8cf>(const std::complex<float>* from)
|
||||||
|
{
|
||||||
|
return Packet8cf( _mm512_castpd_ps( ploadquad<Packet8d>((const double*)(const void*)from )) );
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE void pstore <std::complex<float> >(std::complex<float>* to, const Packet8cf& from) { EIGEN_DEBUG_ALIGNED_STORE pstore(&numext::real_ref(*to), from.v); }
|
||||||
|
template<> EIGEN_STRONG_INLINE void pstoreu<std::complex<float> >(std::complex<float>* to, const Packet8cf& from) { EIGEN_DEBUG_UNALIGNED_STORE pstoreu(&numext::real_ref(*to), from.v); }
|
||||||
|
|
||||||
|
template<> EIGEN_DEVICE_FUNC inline Packet8cf pgather<std::complex<float>, Packet8cf>(const std::complex<float>* from, Index stride)
|
||||||
|
{
|
||||||
|
return Packet8cf(_mm512_castpd_ps(pgather<double,Packet8d>((const double*)(const void*)from, stride)));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_DEVICE_FUNC inline void pscatter<std::complex<float>, Packet8cf>(std::complex<float>* to, const Packet8cf& from, Index stride)
|
||||||
|
{
|
||||||
|
pscatter((double*)(void*)to, _mm512_castps_pd(from.v), stride);
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE std::complex<float> pfirst<Packet8cf>(const Packet8cf& a)
|
||||||
|
{
|
||||||
|
return pfirst(Packet2cf(_mm512_castps512_ps128(a.v)));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf preverse(const Packet8cf& a) {
|
||||||
|
return Packet8cf(_mm512_castsi512_ps(
|
||||||
|
_mm512_permutexvar_epi64( _mm512_set_epi32(0, 0, 0, 1, 0, 2, 0, 3, 0, 4, 0, 5, 0, 6, 0, 7),
|
||||||
|
_mm512_castps_si512(a.v))));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE std::complex<float> predux<Packet8cf>(const Packet8cf& a)
|
||||||
|
{
|
||||||
|
return predux(padd(Packet4cf(_mm512_extractf32x8_ps(a.v,0)),
|
||||||
|
Packet4cf(_mm512_extractf32x8_ps(a.v,1))));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE std::complex<float> predux_mul<Packet8cf>(const Packet8cf& a)
|
||||||
|
{
|
||||||
|
return predux_mul(pmul(Packet4cf(_mm512_extractf32x8_ps(a.v, 0)),
|
||||||
|
Packet4cf(_mm512_extractf32x8_ps(a.v, 1))));
|
||||||
|
}
|
||||||
|
|
||||||
|
template <>
|
||||||
|
EIGEN_STRONG_INLINE Packet4cf predux_half_dowto4<Packet8cf>(const Packet8cf& a) {
|
||||||
|
__m256 lane0 = _mm512_extractf32x8_ps(a.v, 0);
|
||||||
|
__m256 lane1 = _mm512_extractf32x8_ps(a.v, 1);
|
||||||
|
__m256 res = _mm256_add_ps(lane0, lane1);
|
||||||
|
return Packet4cf(res);
|
||||||
|
}
|
||||||
|
|
||||||
|
template<int Offset>
|
||||||
|
struct palign_impl<Offset,Packet8cf>
|
||||||
|
{
|
||||||
|
static EIGEN_STRONG_INLINE void run(Packet8cf& first, const Packet8cf& second)
|
||||||
|
{
|
||||||
|
if (Offset==0) return;
|
||||||
|
palign_impl<Offset*2,Packet16f>::run(first.v, second.v);
|
||||||
|
}
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct conj_helper<Packet8cf, Packet8cf, false,true>
|
||||||
|
{
|
||||||
|
EIGEN_STRONG_INLINE Packet8cf pmadd(const Packet8cf& x, const Packet8cf& y, const Packet8cf& c) const
|
||||||
|
{ return padd(pmul(x,y),c); }
|
||||||
|
|
||||||
|
EIGEN_STRONG_INLINE Packet8cf pmul(const Packet8cf& a, const Packet8cf& b) const
|
||||||
|
{
|
||||||
|
return internal::pmul(a, pconj(b));
|
||||||
|
}
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct conj_helper<Packet8cf, Packet8cf, true,false>
|
||||||
|
{
|
||||||
|
EIGEN_STRONG_INLINE Packet8cf pmadd(const Packet8cf& x, const Packet8cf& y, const Packet8cf& c) const
|
||||||
|
{ return padd(pmul(x,y),c); }
|
||||||
|
|
||||||
|
EIGEN_STRONG_INLINE Packet8cf pmul(const Packet8cf& a, const Packet8cf& b) const
|
||||||
|
{
|
||||||
|
return internal::pmul(pconj(a), b);
|
||||||
|
}
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct conj_helper<Packet8cf, Packet8cf, true,true>
|
||||||
|
{
|
||||||
|
EIGEN_STRONG_INLINE Packet8cf pmadd(const Packet8cf& x, const Packet8cf& y, const Packet8cf& c) const
|
||||||
|
{ return padd(pmul(x,y),c); }
|
||||||
|
|
||||||
|
EIGEN_STRONG_INLINE Packet8cf pmul(const Packet8cf& a, const Packet8cf& b) const
|
||||||
|
{
|
||||||
|
return pconj(internal::pmul(a, b));
|
||||||
|
}
|
||||||
|
};
|
||||||
|
|
||||||
|
EIGEN_MAKE_CONJ_HELPER_CPLX_REAL(Packet8cf,Packet16f)
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pdiv<Packet8cf>(const Packet8cf& a, const Packet8cf& b)
|
||||||
|
{
|
||||||
|
Packet8cf num = pmul(a, pconj(b));
|
||||||
|
__m512 tmp = _mm512_mul_ps(b.v, b.v);
|
||||||
|
__m512 tmp2 = _mm512_shuffle_ps(tmp,tmp,0xB1);
|
||||||
|
__m512 denom = _mm512_add_ps(tmp, tmp2);
|
||||||
|
return Packet8cf(_mm512_div_ps(num.v, denom));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pcplxflip<Packet8cf>(const Packet8cf& x)
|
||||||
|
{
|
||||||
|
return Packet8cf(_mm512_shuffle_ps(x.v, x.v, _MM_SHUFFLE(2, 3, 0 ,1)));
|
||||||
|
}
|
||||||
|
|
||||||
|
//---------- double ----------
|
||||||
|
struct Packet4cd
|
||||||
|
{
|
||||||
|
EIGEN_STRONG_INLINE Packet4cd() {}
|
||||||
|
EIGEN_STRONG_INLINE explicit Packet4cd(const __m512d& a) : v(a) {}
|
||||||
|
__m512d v;
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct packet_traits<std::complex<double> > : default_packet_traits
|
||||||
|
{
|
||||||
|
typedef Packet4cd type;
|
||||||
|
typedef Packet2cd half;
|
||||||
|
enum {
|
||||||
|
Vectorizable = 1,
|
||||||
|
AlignedOnScalar = 0,
|
||||||
|
size = 4,
|
||||||
|
HasHalfPacket = 1,
|
||||||
|
|
||||||
|
HasAdd = 1,
|
||||||
|
HasSub = 1,
|
||||||
|
HasMul = 1,
|
||||||
|
HasDiv = 1,
|
||||||
|
HasNegate = 1,
|
||||||
|
HasAbs = 0,
|
||||||
|
HasAbs2 = 0,
|
||||||
|
HasMin = 0,
|
||||||
|
HasMax = 0,
|
||||||
|
HasSetLinear = 0,
|
||||||
|
HasReduxp = 0
|
||||||
|
};
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct unpacket_traits<Packet4cd> {
|
||||||
|
typedef std::complex<double> type;
|
||||||
|
enum {
|
||||||
|
size = 4,
|
||||||
|
alignment = unpacket_traits<Packet8d>::alignment
|
||||||
|
};
|
||||||
|
typedef Packet2cd half;
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd padd<Packet4cd>(const Packet4cd& a, const Packet4cd& b) { return Packet4cd(_mm512_add_pd(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd psub<Packet4cd>(const Packet4cd& a, const Packet4cd& b) { return Packet4cd(_mm512_sub_pd(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pnegate(const Packet4cd& a) { return Packet4cd(pnegate(a.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pconj(const Packet4cd& a)
|
||||||
|
{
|
||||||
|
const __m512d mask = _mm512_castsi512_pd(
|
||||||
|
_mm512_set_epi32(0x80000000,0x0,0x0,0x0,0x80000000,0x0,0x0,0x0,
|
||||||
|
0x80000000,0x0,0x0,0x0,0x80000000,0x0,0x0,0x0));
|
||||||
|
return Packet4cd(_mm512_xor_pd(a.v,mask));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pmul<Packet4cd>(const Packet4cd& a, const Packet4cd& b)
|
||||||
|
{
|
||||||
|
__m512d tmp1 = _mm512_shuffle_pd(a.v,a.v,0x0);
|
||||||
|
__m512d tmp2 = _mm512_shuffle_pd(a.v,a.v,0xFF);
|
||||||
|
__m512d tmp3 = _mm512_shuffle_pd(b.v,b.v,0x55);
|
||||||
|
__m512d odd = _mm512_mul_pd(tmp2, tmp3);
|
||||||
|
return Packet4cd(_mm512_fmaddsub_pd(tmp1, b.v, odd));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pand <Packet4cd>(const Packet4cd& a, const Packet4cd& b) { return Packet4cd(_mm512_and_pd(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd por <Packet4cd>(const Packet4cd& a, const Packet4cd& b) { return Packet4cd(_mm512_or_pd(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pxor <Packet4cd>(const Packet4cd& a, const Packet4cd& b) { return Packet4cd(_mm512_xor_pd(a.v,b.v)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pandnot<Packet4cd>(const Packet4cd& a, const Packet4cd& b) { return Packet4cd(_mm512_andnot_pd(a.v,b.v)); }
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pload <Packet4cd>(const std::complex<double>* from)
|
||||||
|
{ EIGEN_DEBUG_ALIGNED_LOAD return Packet4cd(pload<Packet8d>((const double*)from)); }
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd ploadu<Packet4cd>(const std::complex<double>* from)
|
||||||
|
{ EIGEN_DEBUG_UNALIGNED_LOAD return Packet4cd(ploadu<Packet8d>((const double*)from)); }
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pset1<Packet4cd>(const std::complex<double>& from)
|
||||||
|
{
|
||||||
|
#ifdef EIGEN_VECTORIZE_AVX512DQ
|
||||||
|
return Packet4cd(_mm512_broadcast_f64x2(pset1<Packet1cd>(from).v));
|
||||||
|
#else
|
||||||
|
return Packet4cd(_mm512_castps_pd(_mm512_broadcast_f32x4( _mm_castpd_ps(pset1<Packet1cd>(from).v))));
|
||||||
|
#endif
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd ploaddup<Packet4cd>(const std::complex<double>* from) {
|
||||||
|
return Packet4cd(_mm512_insertf64x4(
|
||||||
|
_mm512_castpd256_pd512(ploaddup<Packet2cd>(from).v), ploaddup<Packet2cd>(from+1).v, 1));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE void pstore <std::complex<double> >(std::complex<double> * to, const Packet4cd& from) { EIGEN_DEBUG_ALIGNED_STORE pstore((double*)to, from.v); }
|
||||||
|
template<> EIGEN_STRONG_INLINE void pstoreu<std::complex<double> >(std::complex<double> * to, const Packet4cd& from) { EIGEN_DEBUG_UNALIGNED_STORE pstoreu((double*)to, from.v); }
|
||||||
|
|
||||||
|
template<> EIGEN_DEVICE_FUNC inline Packet4cd pgather<std::complex<double>, Packet4cd>(const std::complex<double>* from, Index stride)
|
||||||
|
{
|
||||||
|
return Packet4cd(_mm512_insertf64x4(_mm512_castpd256_pd512(
|
||||||
|
_mm256_insertf128_pd(_mm256_castpd128_pd256(pload<Packet1cd>(from+0*stride).v), pload<Packet1cd>(from+1*stride).v,1)),
|
||||||
|
_mm256_insertf128_pd(_mm256_castpd128_pd256(pload<Packet1cd>(from+2*stride).v), pload<Packet1cd>(from+3*stride).v,1), 1));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_DEVICE_FUNC inline void pscatter<std::complex<double>, Packet4cd>(std::complex<double>* to, const Packet4cd& from, Index stride)
|
||||||
|
{
|
||||||
|
__m512i fromi = _mm512_castpd_si512(from.v);
|
||||||
|
double* tod = (double*)(void*)to;
|
||||||
|
_mm_store_pd(tod+0*stride, _mm_castsi128_pd(_mm512_extracti32x4_epi32(fromi,0)) );
|
||||||
|
_mm_store_pd(tod+2*stride, _mm_castsi128_pd(_mm512_extracti32x4_epi32(fromi,1)) );
|
||||||
|
_mm_store_pd(tod+4*stride, _mm_castsi128_pd(_mm512_extracti32x4_epi32(fromi,2)) );
|
||||||
|
_mm_store_pd(tod+6*stride, _mm_castsi128_pd(_mm512_extracti32x4_epi32(fromi,3)) );
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE std::complex<double> pfirst<Packet4cd>(const Packet4cd& a)
|
||||||
|
{
|
||||||
|
__m128d low = _mm512_extractf64x2_pd(a.v, 0);
|
||||||
|
EIGEN_ALIGN16 double res[2];
|
||||||
|
_mm_store_pd(res, low);
|
||||||
|
return std::complex<double>(res[0],res[1]);
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd preverse(const Packet4cd& a) {
|
||||||
|
return Packet4cd(_mm512_shuffle_f64x2(a.v, a.v, EIGEN_SSE_SHUFFLE_MASK(3,2,1,0)));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE std::complex<double> predux<Packet4cd>(const Packet4cd& a)
|
||||||
|
{
|
||||||
|
return predux(padd(Packet2cd(_mm512_extractf64x4_pd(a.v,0)),
|
||||||
|
Packet2cd(_mm512_extractf64x4_pd(a.v,1))));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE std::complex<double> predux_mul<Packet4cd>(const Packet4cd& a)
|
||||||
|
{
|
||||||
|
return predux_mul(pmul(Packet2cd(_mm512_extractf64x4_pd(a.v,0)),
|
||||||
|
Packet2cd(_mm512_extractf64x4_pd(a.v,1))));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<int Offset>
|
||||||
|
struct palign_impl<Offset,Packet4cd>
|
||||||
|
{
|
||||||
|
static EIGEN_STRONG_INLINE void run(Packet4cd& first, const Packet4cd& second)
|
||||||
|
{
|
||||||
|
if (Offset==0) return;
|
||||||
|
palign_impl<Offset*2,Packet8d>::run(first.v, second.v);
|
||||||
|
}
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct conj_helper<Packet4cd, Packet4cd, false,true>
|
||||||
|
{
|
||||||
|
EIGEN_STRONG_INLINE Packet4cd pmadd(const Packet4cd& x, const Packet4cd& y, const Packet4cd& c) const
|
||||||
|
{ return padd(pmul(x,y),c); }
|
||||||
|
|
||||||
|
EIGEN_STRONG_INLINE Packet4cd pmul(const Packet4cd& a, const Packet4cd& b) const
|
||||||
|
{
|
||||||
|
return internal::pmul(a, pconj(b));
|
||||||
|
}
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct conj_helper<Packet4cd, Packet4cd, true,false>
|
||||||
|
{
|
||||||
|
EIGEN_STRONG_INLINE Packet4cd pmadd(const Packet4cd& x, const Packet4cd& y, const Packet4cd& c) const
|
||||||
|
{ return padd(pmul(x,y),c); }
|
||||||
|
|
||||||
|
EIGEN_STRONG_INLINE Packet4cd pmul(const Packet4cd& a, const Packet4cd& b) const
|
||||||
|
{
|
||||||
|
return internal::pmul(pconj(a), b);
|
||||||
|
}
|
||||||
|
};
|
||||||
|
|
||||||
|
template<> struct conj_helper<Packet4cd, Packet4cd, true,true>
|
||||||
|
{
|
||||||
|
EIGEN_STRONG_INLINE Packet4cd pmadd(const Packet4cd& x, const Packet4cd& y, const Packet4cd& c) const
|
||||||
|
{ return padd(pmul(x,y),c); }
|
||||||
|
|
||||||
|
EIGEN_STRONG_INLINE Packet4cd pmul(const Packet4cd& a, const Packet4cd& b) const
|
||||||
|
{
|
||||||
|
return pconj(internal::pmul(a, b));
|
||||||
|
}
|
||||||
|
};
|
||||||
|
|
||||||
|
EIGEN_MAKE_CONJ_HELPER_CPLX_REAL(Packet4cd,Packet8d)
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pdiv<Packet4cd>(const Packet4cd& a, const Packet4cd& b)
|
||||||
|
{
|
||||||
|
Packet4cd num = pmul(a, pconj(b));
|
||||||
|
__m512d tmp = _mm512_mul_pd(b.v, b.v);
|
||||||
|
__m512d denom = padd(_mm512_permute_pd(tmp,0x55), tmp);
|
||||||
|
return Packet4cd(_mm512_div_pd(num.v, denom));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pcplxflip<Packet4cd>(const Packet4cd& x)
|
||||||
|
{
|
||||||
|
return Packet4cd(_mm512_permute_pd(x.v,0x55));
|
||||||
|
}
|
||||||
|
|
||||||
|
EIGEN_DEVICE_FUNC inline void
|
||||||
|
ptranspose(PacketBlock<Packet8cf,4>& kernel) {
|
||||||
|
ptranspose(reinterpret_cast<PacketBlock<Packet8d,4>&>(kernel));
|
||||||
|
}
|
||||||
|
|
||||||
|
EIGEN_DEVICE_FUNC inline void
|
||||||
|
ptranspose(PacketBlock<Packet8cf,8>& kernel) {
|
||||||
|
ptranspose(reinterpret_cast<PacketBlock<Packet8d,8>&>(kernel));
|
||||||
|
}
|
||||||
|
|
||||||
|
EIGEN_DEVICE_FUNC inline void
|
||||||
|
ptranspose(PacketBlock<Packet4cd,4>& kernel) {
|
||||||
|
__m512d T0 = _mm512_shuffle_f64x2(kernel.packet[0].v, kernel.packet[1].v, EIGEN_SSE_SHUFFLE_MASK(0,1,0,1)); // [a0 a1 b0 b1]
|
||||||
|
__m512d T1 = _mm512_shuffle_f64x2(kernel.packet[0].v, kernel.packet[1].v, EIGEN_SSE_SHUFFLE_MASK(2,3,2,3)); // [a2 a3 b2 b3]
|
||||||
|
__m512d T2 = _mm512_shuffle_f64x2(kernel.packet[2].v, kernel.packet[3].v, EIGEN_SSE_SHUFFLE_MASK(0,1,0,1)); // [c0 c1 d0 d1]
|
||||||
|
__m512d T3 = _mm512_shuffle_f64x2(kernel.packet[2].v, kernel.packet[3].v, EIGEN_SSE_SHUFFLE_MASK(2,3,2,3)); // [c2 c3 d2 d3]
|
||||||
|
|
||||||
|
kernel.packet[3] = Packet4cd(_mm512_shuffle_f64x2(T1, T3, EIGEN_SSE_SHUFFLE_MASK(1,3,1,3))); // [a3 b3 c3 d3]
|
||||||
|
kernel.packet[2] = Packet4cd(_mm512_shuffle_f64x2(T1, T3, EIGEN_SSE_SHUFFLE_MASK(0,2,0,2))); // [a2 b2 c2 d2]
|
||||||
|
kernel.packet[1] = Packet4cd(_mm512_shuffle_f64x2(T0, T2, EIGEN_SSE_SHUFFLE_MASK(1,3,1,3))); // [a1 b1 c1 d1]
|
||||||
|
kernel.packet[0] = Packet4cd(_mm512_shuffle_f64x2(T0, T2, EIGEN_SSE_SHUFFLE_MASK(0,2,0,2))); // [a0 b0 c0 d0]
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pinsertfirst(const Packet8cf& a, std::complex<float> b)
|
||||||
|
{
|
||||||
|
Packet2cf tmp = Packet2cf(_mm512_extractf32x4_ps(a.v,0));
|
||||||
|
tmp = pinsertfirst(tmp, b);
|
||||||
|
return Packet8cf( _mm512_insertf32x4(a.v, tmp.v, 0) );
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pinsertfirst(const Packet4cd& a, std::complex<double> b)
|
||||||
|
{
|
||||||
|
return Packet4cd(_mm512_castsi512_pd( _mm512_inserti32x4(_mm512_castpd_si512(a.v), _mm_castpd_si128(pset1<Packet1cd>(b).v), 0) ));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet8cf pinsertlast(const Packet8cf& a, std::complex<float> b)
|
||||||
|
{
|
||||||
|
Packet2cf tmp = Packet2cf(_mm512_extractf32x4_ps(a.v,3) );
|
||||||
|
tmp = pinsertlast(tmp, b);
|
||||||
|
return Packet8cf( _mm512_insertf32x4(a.v, tmp.v, 3) );
|
||||||
|
}
|
||||||
|
|
||||||
|
template<> EIGEN_STRONG_INLINE Packet4cd pinsertlast(const Packet4cd& a, std::complex<double> b)
|
||||||
|
{
|
||||||
|
return Packet4cd(_mm512_castsi512_pd( _mm512_inserti32x4(_mm512_castpd_si512(a.v), _mm_castpd_si128(pset1<Packet1cd>(b).v), 3) ));
|
||||||
|
}
|
||||||
|
|
||||||
|
} // end namespace internal
|
||||||
|
|
||||||
|
} // end namespace Eigen
|
||||||
|
|
||||||
|
#endif // EIGEN_COMPLEX_AVX512_H
|
@ -417,6 +417,7 @@ EIGEN_STRONG_INLINE Packet16f ploaddup<Packet16f>(const float* from) {
|
|||||||
}
|
}
|
||||||
|
|
||||||
#ifdef EIGEN_VECTORIZE_AVX512DQ
|
#ifdef EIGEN_VECTORIZE_AVX512DQ
|
||||||
|
// FIXME: this does not look optimal, better load a Packet4d and shuffle...
|
||||||
// Loads 4 doubles from memory a returns the packet {a0, a0 a1, a1, a2, a2, a3,
|
// Loads 4 doubles from memory a returns the packet {a0, a0 a1, a1, a2, a2, a3,
|
||||||
// a3}
|
// a3}
|
||||||
template <>
|
template <>
|
||||||
|
@ -61,20 +61,22 @@ template<> struct is_arithmetic<__m128> { enum { value = true }; };
|
|||||||
template<> struct is_arithmetic<__m128i> { enum { value = true }; };
|
template<> struct is_arithmetic<__m128i> { enum { value = true }; };
|
||||||
template<> struct is_arithmetic<__m128d> { enum { value = true }; };
|
template<> struct is_arithmetic<__m128d> { enum { value = true }; };
|
||||||
|
|
||||||
|
#define EIGEN_SSE_SHUFFLE_MASK(p,q,r,s) ((s)<<6|(r)<<4|(q)<<2|(p))
|
||||||
|
|
||||||
#define vec4f_swizzle1(v,p,q,r,s) \
|
#define vec4f_swizzle1(v,p,q,r,s) \
|
||||||
(_mm_castsi128_ps(_mm_shuffle_epi32( _mm_castps_si128(v), ((s)<<6|(r)<<4|(q)<<2|(p)))))
|
(_mm_castsi128_ps(_mm_shuffle_epi32( _mm_castps_si128(v), EIGEN_SSE_SHUFFLE_MASK(p,q,r,s))))
|
||||||
|
|
||||||
#define vec4i_swizzle1(v,p,q,r,s) \
|
#define vec4i_swizzle1(v,p,q,r,s) \
|
||||||
(_mm_shuffle_epi32( v, ((s)<<6|(r)<<4|(q)<<2|(p))))
|
(_mm_shuffle_epi32( v, EIGEN_SSE_SHUFFLE_MASK(p,q,r,s)))
|
||||||
|
|
||||||
#define vec2d_swizzle1(v,p,q) \
|
#define vec2d_swizzle1(v,p,q) \
|
||||||
(_mm_castsi128_pd(_mm_shuffle_epi32( _mm_castpd_si128(v), ((q*2+1)<<6|(q*2)<<4|(p*2+1)<<2|(p*2)))))
|
(_mm_castsi128_pd(_mm_shuffle_epi32( _mm_castpd_si128(v), EIGEN_SSE_SHUFFLE_MASK(2*p,2*p+1,2*q,2*q+1))))
|
||||||
|
|
||||||
#define vec4f_swizzle2(a,b,p,q,r,s) \
|
#define vec4f_swizzle2(a,b,p,q,r,s) \
|
||||||
(_mm_shuffle_ps( (a), (b), ((s)<<6|(r)<<4|(q)<<2|(p))))
|
(_mm_shuffle_ps( (a), (b), EIGEN_SSE_SHUFFLE_MASK(p,q,r,s)))
|
||||||
|
|
||||||
#define vec4i_swizzle2(a,b,p,q,r,s) \
|
#define vec4i_swizzle2(a,b,p,q,r,s) \
|
||||||
(_mm_castps_si128( (_mm_shuffle_ps( _mm_castsi128_ps(a), _mm_castsi128_ps(b), ((s)<<6|(r)<<4|(q)<<2|(p))))))
|
(_mm_castps_si128( (_mm_shuffle_ps( _mm_castsi128_ps(a), _mm_castsi128_ps(b), EIGEN_SSE_SHUFFLE_MASK(p,q,r,s)))))
|
||||||
|
|
||||||
#define _EIGEN_DECLARE_CONST_Packet4f(NAME,X) \
|
#define _EIGEN_DECLARE_CONST_Packet4f(NAME,X) \
|
||||||
const Packet4f p4f_##NAME = pset1<Packet4f>(X)
|
const Packet4f p4f_##NAME = pset1<Packet4f>(X)
|
||||||
|
@ -506,13 +506,28 @@ public:
|
|||||||
p = pset1<ResPacket>(ResScalar(0));
|
p = pset1<ResPacket>(ResScalar(0));
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void loadRhs(const RhsScalar* b, RhsPacket& dest) const
|
template<typename RhsPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void loadRhs(const RhsScalar* b, RhsPacketType& dest) const
|
||||||
{
|
{
|
||||||
dest = pset1<RhsPacket>(*b);
|
dest = pset1<RhsPacketType>(*b);
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void loadRhsQuad(const RhsScalar* b, RhsPacket& dest) const
|
EIGEN_STRONG_INLINE void loadRhsQuad(const RhsScalar* b, RhsPacket& dest) const
|
||||||
{
|
{
|
||||||
|
loadRhsQuad_impl(b,dest, typename conditional<RhsPacketSize==16,true_type,false_type>::type());
|
||||||
|
}
|
||||||
|
|
||||||
|
EIGEN_STRONG_INLINE void loadRhsQuad_impl(const RhsScalar* b, RhsPacket& dest, const true_type&) const
|
||||||
|
{
|
||||||
|
// FIXME we can do better!
|
||||||
|
// what we want here is a ploadheight
|
||||||
|
RhsScalar tmp[4] = {b[0],b[0],b[1],b[1]};
|
||||||
|
dest = ploadquad<RhsPacket>(tmp);
|
||||||
|
}
|
||||||
|
|
||||||
|
EIGEN_STRONG_INLINE void loadRhsQuad_impl(const RhsScalar* b, RhsPacket& dest, const false_type&) const
|
||||||
|
{
|
||||||
|
eigen_internal_assert(RhsPacketSize<=8);
|
||||||
dest = pset1<RhsPacket>(*b);
|
dest = pset1<RhsPacket>(*b);
|
||||||
}
|
}
|
||||||
|
|
||||||
@ -521,9 +536,10 @@ public:
|
|||||||
dest = pload<LhsPacket>(a);
|
dest = pload<LhsPacket>(a);
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void loadLhsUnaligned(const LhsScalar* a, LhsPacket& dest) const
|
template<typename LhsPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void loadLhsUnaligned(const LhsScalar* a, LhsPacketType& dest) const
|
||||||
{
|
{
|
||||||
dest = ploadu<LhsPacket>(a);
|
dest = ploadu<LhsPacketType>(a);
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void broadcastRhs(const RhsScalar* b, RhsPacket& b0, RhsPacket& b1, RhsPacket& b2, RhsPacket& b3)
|
EIGEN_STRONG_INLINE void broadcastRhs(const RhsScalar* b, RhsPacket& b0, RhsPacket& b1, RhsPacket& b2, RhsPacket& b3)
|
||||||
@ -536,12 +552,14 @@ public:
|
|||||||
// pbroadcast2(b, b0, b1);
|
// pbroadcast2(b, b0, b1);
|
||||||
// }
|
// }
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void madd(const LhsPacket& a, const RhsPacket& b, AccPacket& c, RhsPacket& tmp) const
|
template <typename LhsPacketType, typename RhsPacketType, typename AccPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void madd(const LhsPacketType& a, const RhsPacketType& b, AccPacketType& c, RhsPacketType& tmp) const
|
||||||
{
|
{
|
||||||
madd_impl(a, b, c, tmp, typename conditional<Vectorizable,true_type,false_type>::type());
|
madd_impl(a, b, c, tmp, typename conditional<Vectorizable,true_type,false_type>::type());
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void madd_impl(const LhsPacket& a, const RhsPacket& b, AccPacket& c, RhsPacket& tmp, const true_type&) const
|
template <typename LhsPacketType, typename RhsPacketType, typename AccPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void madd_impl(const LhsPacketType& a, const RhsPacketType& b, AccPacketType& c, RhsPacketType& tmp, const true_type&) const
|
||||||
{
|
{
|
||||||
#ifdef EIGEN_HAS_SINGLE_INSTRUCTION_MADD
|
#ifdef EIGEN_HAS_SINGLE_INSTRUCTION_MADD
|
||||||
EIGEN_UNUSED_VARIABLE(tmp);
|
EIGEN_UNUSED_VARIABLE(tmp);
|
||||||
@ -556,13 +574,14 @@ public:
|
|||||||
c += a * b;
|
c += a * b;
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void acc(const AccPacket& c, const ResPacket& alpha, ResPacket& r) const
|
template <typename ResPacketType, typename AccPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void acc(const AccPacketType& c, const ResPacketType& alpha, ResPacketType& r) const
|
||||||
{
|
{
|
||||||
|
const conj_helper<ResPacketType,ResPacketType,ConjLhs,false> cj;
|
||||||
r = cj.pmadd(c,alpha,r);
|
r = cj.pmadd(c,alpha,r);
|
||||||
}
|
}
|
||||||
|
|
||||||
protected:
|
protected:
|
||||||
conj_helper<ResPacket,ResPacket,ConjLhs,false> cj;
|
|
||||||
};
|
};
|
||||||
|
|
||||||
template<typename Packet>
|
template<typename Packet>
|
||||||
@ -581,13 +600,57 @@ DoublePacket<Packet> padd(const DoublePacket<Packet> &a, const DoublePacket<Pack
|
|||||||
return res;
|
return res;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
// note that for DoublePacket<RealPacket> the "4" in "downto4"
|
||||||
|
// corresponds to the number of complexes, so it means "8"
|
||||||
|
// it terms of real coefficients.
|
||||||
|
|
||||||
template<typename Packet>
|
template<typename Packet>
|
||||||
const DoublePacket<Packet>& predux_half_dowto4(const DoublePacket<Packet> &a)
|
const DoublePacket<Packet>&
|
||||||
|
predux_half_dowto4(const DoublePacket<Packet> &a,
|
||||||
|
typename enable_if<unpacket_traits<Packet>::size<=8>::type* = 0)
|
||||||
{
|
{
|
||||||
return a;
|
return a;
|
||||||
}
|
}
|
||||||
|
|
||||||
template<typename Packet> struct unpacket_traits<DoublePacket<Packet> > { typedef DoublePacket<Packet> half; };
|
template<typename Packet>
|
||||||
|
DoublePacket<typename unpacket_traits<Packet>::half>
|
||||||
|
predux_half_dowto4(const DoublePacket<Packet> &a,
|
||||||
|
typename enable_if<unpacket_traits<Packet>::size==16>::type* = 0)
|
||||||
|
{
|
||||||
|
// yes, that's pretty hackish :(
|
||||||
|
DoublePacket<typename unpacket_traits<Packet>::half> res;
|
||||||
|
typedef std::complex<typename unpacket_traits<Packet>::type> Cplx;
|
||||||
|
typedef typename packet_traits<Cplx>::type CplxPacket;
|
||||||
|
res.first = predux_half_dowto4(CplxPacket(a.first)).v;
|
||||||
|
res.second = predux_half_dowto4(CplxPacket(a.second)).v;
|
||||||
|
return res;
|
||||||
|
}
|
||||||
|
|
||||||
|
// same here, "quad" actually means "8" in terms of real coefficients
|
||||||
|
template<typename Scalar, typename RealPacket>
|
||||||
|
void loadQuadToDoublePacket(const Scalar* b, DoublePacket<RealPacket>& dest,
|
||||||
|
typename enable_if<unpacket_traits<RealPacket>::size<=8>::type* = 0)
|
||||||
|
{
|
||||||
|
dest.first = pset1<RealPacket>(real(*b));
|
||||||
|
dest.second = pset1<RealPacket>(imag(*b));
|
||||||
|
}
|
||||||
|
|
||||||
|
template<typename Scalar, typename RealPacket>
|
||||||
|
void loadQuadToDoublePacket(const Scalar* b, DoublePacket<RealPacket>& dest,
|
||||||
|
typename enable_if<unpacket_traits<RealPacket>::size==16>::type* = 0)
|
||||||
|
{
|
||||||
|
// yes, that's pretty hackish too :(
|
||||||
|
typedef typename NumTraits<Scalar>::Real RealScalar;
|
||||||
|
RealScalar r[4] = {real(b[0]), real(b[0]), real(b[1]), real(b[1])};
|
||||||
|
RealScalar i[4] = {imag(b[0]), imag(b[0]), imag(b[1]), imag(b[1])};
|
||||||
|
dest.first = ploadquad<RealPacket>(r);
|
||||||
|
dest.second = ploadquad<RealPacket>(i);
|
||||||
|
}
|
||||||
|
|
||||||
|
|
||||||
|
template<typename Packet> struct unpacket_traits<DoublePacket<Packet> > {
|
||||||
|
typedef DoublePacket<typename unpacket_traits<Packet>::half> half;
|
||||||
|
};
|
||||||
// template<typename Packet>
|
// template<typename Packet>
|
||||||
// DoublePacket<Packet> pmadd(const DoublePacket<Packet> &a, const DoublePacket<Packet> &b)
|
// DoublePacket<Packet> pmadd(const DoublePacket<Packet> &a, const DoublePacket<Packet> &b)
|
||||||
// {
|
// {
|
||||||
@ -611,10 +674,10 @@ public:
|
|||||||
ConjRhs = _ConjRhs,
|
ConjRhs = _ConjRhs,
|
||||||
Vectorizable = packet_traits<RealScalar>::Vectorizable
|
Vectorizable = packet_traits<RealScalar>::Vectorizable
|
||||||
&& packet_traits<Scalar>::Vectorizable,
|
&& packet_traits<Scalar>::Vectorizable,
|
||||||
RealPacketSize = Vectorizable ? packet_traits<RealScalar>::size : 1,
|
|
||||||
ResPacketSize = Vectorizable ? packet_traits<ResScalar>::size : 1,
|
ResPacketSize = Vectorizable ? packet_traits<ResScalar>::size : 1,
|
||||||
LhsPacketSize = Vectorizable ? packet_traits<LhsScalar>::size : 1,
|
LhsPacketSize = Vectorizable ? packet_traits<LhsScalar>::size : 1,
|
||||||
RhsPacketSize = Vectorizable ? packet_traits<RhsScalar>::size : 1,
|
RhsPacketSize = Vectorizable ? packet_traits<RhsScalar>::size : 1,
|
||||||
|
RealPacketSize = Vectorizable ? packet_traits<RealScalar>::size : 1,
|
||||||
|
|
||||||
// FIXME: should depend on NumberOfRegisters
|
// FIXME: should depend on NumberOfRegisters
|
||||||
nr = 4,
|
nr = 4,
|
||||||
@ -643,16 +706,17 @@ public:
|
|||||||
}
|
}
|
||||||
|
|
||||||
// Scalar path
|
// Scalar path
|
||||||
EIGEN_STRONG_INLINE void loadRhs(const RhsScalar* b, ResPacket& dest) const
|
EIGEN_STRONG_INLINE void loadRhs(const RhsScalar* b, ScalarPacket& dest) const
|
||||||
{
|
{
|
||||||
dest = pset1<ResPacket>(*b);
|
dest = pset1<ScalarPacket>(*b);
|
||||||
}
|
}
|
||||||
|
|
||||||
// Vectorized path
|
// Vectorized path
|
||||||
EIGEN_STRONG_INLINE void loadRhs(const RhsScalar* b, DoublePacketType& dest) const
|
template<typename RealPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void loadRhs(const RhsScalar* b, DoublePacket<RealPacketType>& dest) const
|
||||||
{
|
{
|
||||||
dest.first = pset1<RealPacket>(real(*b));
|
dest.first = pset1<RealPacketType>(real(*b));
|
||||||
dest.second = pset1<RealPacket>(imag(*b));
|
dest.second = pset1<RealPacketType>(imag(*b));
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void loadRhsQuad(const RhsScalar* b, ResPacket& dest) const
|
EIGEN_STRONG_INLINE void loadRhsQuad(const RhsScalar* b, ResPacket& dest) const
|
||||||
@ -661,8 +725,7 @@ public:
|
|||||||
}
|
}
|
||||||
EIGEN_STRONG_INLINE void loadRhsQuad(const RhsScalar* b, DoublePacketType& dest) const
|
EIGEN_STRONG_INLINE void loadRhsQuad(const RhsScalar* b, DoublePacketType& dest) const
|
||||||
{
|
{
|
||||||
eigen_internal_assert(unpacket_traits<ScalarPacket>::size<=4);
|
loadQuadToDoublePacket(b,dest);
|
||||||
loadRhs(b,dest);
|
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void broadcastRhs(const RhsScalar* b, RhsPacket& b0, RhsPacket& b1, RhsPacket& b2, RhsPacket& b3)
|
EIGEN_STRONG_INLINE void broadcastRhs(const RhsScalar* b, RhsPacket& b0, RhsPacket& b1, RhsPacket& b2, RhsPacket& b3)
|
||||||
@ -696,12 +759,14 @@ public:
|
|||||||
dest = pload<LhsPacket>((const typename unpacket_traits<LhsPacket>::type*)(a));
|
dest = pload<LhsPacket>((const typename unpacket_traits<LhsPacket>::type*)(a));
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void loadLhsUnaligned(const LhsScalar* a, LhsPacket& dest) const
|
template<typename LhsPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void loadLhsUnaligned(const LhsScalar* a, LhsPacketType& dest) const
|
||||||
{
|
{
|
||||||
dest = ploadu<LhsPacket>((const typename unpacket_traits<LhsPacket>::type*)(a));
|
dest = ploadu<LhsPacketType>((const typename unpacket_traits<LhsPacketType>::type*)(a));
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void madd(const LhsPacket& a, const RhsPacket& b, DoublePacketType& c, RhsPacket& /*tmp*/) const
|
template<typename LhsPacketType, typename RhsPacketType, typename ResPacketType, typename TmpType>
|
||||||
|
EIGEN_STRONG_INLINE void madd(const LhsPacketType& a, const RhsPacketType& b, DoublePacket<ResPacketType>& c, TmpType& /*tmp*/) const
|
||||||
{
|
{
|
||||||
c.first = padd(pmul(a,b.first), c.first);
|
c.first = padd(pmul(a,b.first), c.first);
|
||||||
c.second = padd(pmul(a,b.second),c.second);
|
c.second = padd(pmul(a,b.second),c.second);
|
||||||
@ -714,29 +779,30 @@ public:
|
|||||||
|
|
||||||
EIGEN_STRONG_INLINE void acc(const Scalar& c, const Scalar& alpha, Scalar& r) const { r += alpha * c; }
|
EIGEN_STRONG_INLINE void acc(const Scalar& c, const Scalar& alpha, Scalar& r) const { r += alpha * c; }
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void acc(const DoublePacketType& c, const ResPacket& alpha, ResPacket& r) const
|
template<typename RealPacketType, typename ResPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void acc(const DoublePacket<RealPacketType>& c, const ResPacketType& alpha, ResPacketType& r) const
|
||||||
{
|
{
|
||||||
// assemble c
|
// assemble c
|
||||||
ResPacket tmp;
|
ResPacketType tmp;
|
||||||
if((!ConjLhs)&&(!ConjRhs))
|
if((!ConjLhs)&&(!ConjRhs))
|
||||||
{
|
{
|
||||||
tmp = pcplxflip(pconj(ResPacket(c.second)));
|
tmp = pcplxflip(pconj(ResPacketType(c.second)));
|
||||||
tmp = padd(ResPacket(c.first),tmp);
|
tmp = padd(ResPacketType(c.first),tmp);
|
||||||
}
|
}
|
||||||
else if((!ConjLhs)&&(ConjRhs))
|
else if((!ConjLhs)&&(ConjRhs))
|
||||||
{
|
{
|
||||||
tmp = pconj(pcplxflip(ResPacket(c.second)));
|
tmp = pconj(pcplxflip(ResPacketType(c.second)));
|
||||||
tmp = padd(ResPacket(c.first),tmp);
|
tmp = padd(ResPacketType(c.first),tmp);
|
||||||
}
|
}
|
||||||
else if((ConjLhs)&&(!ConjRhs))
|
else if((ConjLhs)&&(!ConjRhs))
|
||||||
{
|
{
|
||||||
tmp = pcplxflip(ResPacket(c.second));
|
tmp = pcplxflip(ResPacketType(c.second));
|
||||||
tmp = padd(pconj(ResPacket(c.first)),tmp);
|
tmp = padd(pconj(ResPacketType(c.first)),tmp);
|
||||||
}
|
}
|
||||||
else if((ConjLhs)&&(ConjRhs))
|
else if((ConjLhs)&&(ConjRhs))
|
||||||
{
|
{
|
||||||
tmp = pcplxflip(ResPacket(c.second));
|
tmp = pcplxflip(ResPacketType(c.second));
|
||||||
tmp = psub(pconj(ResPacket(c.first)),tmp);
|
tmp = psub(pconj(ResPacketType(c.first)),tmp);
|
||||||
}
|
}
|
||||||
|
|
||||||
r = pmadd(tmp,alpha,r);
|
r = pmadd(tmp,alpha,r);
|
||||||
@ -789,9 +855,10 @@ public:
|
|||||||
p = pset1<ResPacket>(ResScalar(0));
|
p = pset1<ResPacket>(ResScalar(0));
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void loadRhs(const RhsScalar* b, RhsPacket& dest) const
|
template<typename RhsPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void loadRhs(const RhsScalar* b, RhsPacketType& dest) const
|
||||||
{
|
{
|
||||||
dest = pset1<RhsPacket>(*b);
|
dest = pset1<RhsPacketType>(*b);
|
||||||
}
|
}
|
||||||
|
|
||||||
void broadcastRhs(const RhsScalar* b, RhsPacket& b0, RhsPacket& b1, RhsPacket& b2, RhsPacket& b3)
|
void broadcastRhs(const RhsScalar* b, RhsPacket& b0, RhsPacket& b1, RhsPacket& b2, RhsPacket& b3)
|
||||||
@ -813,21 +880,23 @@ public:
|
|||||||
|
|
||||||
EIGEN_STRONG_INLINE void loadRhsQuad(const RhsScalar* b, RhsPacket& dest) const
|
EIGEN_STRONG_INLINE void loadRhsQuad(const RhsScalar* b, RhsPacket& dest) const
|
||||||
{
|
{
|
||||||
eigen_internal_assert(unpacket_traits<RhsPacket>::size<=4);
|
dest = ploadquad<RhsPacket>(b);
|
||||||
loadRhs(b,dest);
|
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void loadLhsUnaligned(const LhsScalar* a, LhsPacket& dest) const
|
template<typename LhsPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void loadLhsUnaligned(const LhsScalar* a, LhsPacketType& dest) const
|
||||||
{
|
{
|
||||||
dest = ploaddup<LhsPacket>(a);
|
dest = ploaddup<LhsPacketType>(a);
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void madd(const LhsPacket& a, const RhsPacket& b, AccPacket& c, RhsPacket& tmp) const
|
template <typename LhsPacketType, typename RhsPacketType, typename AccPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void madd(const LhsPacketType& a, const RhsPacketType& b, AccPacketType& c, RhsPacketType& tmp) const
|
||||||
{
|
{
|
||||||
madd_impl(a, b, c, tmp, typename conditional<Vectorizable,true_type,false_type>::type());
|
madd_impl(a, b, c, tmp, typename conditional<Vectorizable,true_type,false_type>::type());
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void madd_impl(const LhsPacket& a, const RhsPacket& b, AccPacket& c, RhsPacket& tmp, const true_type&) const
|
template <typename LhsPacketType, typename RhsPacketType, typename AccPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void madd_impl(const LhsPacketType& a, const RhsPacketType& b, AccPacketType& c, RhsPacketType& tmp, const true_type&) const
|
||||||
{
|
{
|
||||||
#ifdef EIGEN_HAS_SINGLE_INSTRUCTION_MADD
|
#ifdef EIGEN_HAS_SINGLE_INSTRUCTION_MADD
|
||||||
EIGEN_UNUSED_VARIABLE(tmp);
|
EIGEN_UNUSED_VARIABLE(tmp);
|
||||||
@ -843,13 +912,15 @@ public:
|
|||||||
c += a * b;
|
c += a * b;
|
||||||
}
|
}
|
||||||
|
|
||||||
EIGEN_STRONG_INLINE void acc(const AccPacket& c, const ResPacket& alpha, ResPacket& r) const
|
template <typename ResPacketType, typename AccPacketType>
|
||||||
|
EIGEN_STRONG_INLINE void acc(const AccPacketType& c, const ResPacketType& alpha, ResPacketType& r) const
|
||||||
{
|
{
|
||||||
|
const conj_helper<ResPacketType,ResPacketType,false,ConjRhs> cj;
|
||||||
r = cj.pmadd(alpha,c,r);
|
r = cj.pmadd(alpha,c,r);
|
||||||
}
|
}
|
||||||
|
|
||||||
protected:
|
protected:
|
||||||
conj_helper<ResPacket,ResPacket,false,ConjRhs> cj;
|
|
||||||
};
|
};
|
||||||
|
|
||||||
|
|
||||||
@ -1704,7 +1775,7 @@ void gebp_kernel<LhsScalar,RhsScalar,Index,DataMapper,mr,nr,ConjugateLhs,Conjuga
|
|||||||
// Special case where we have to first reduce the accumulation register C0
|
// Special case where we have to first reduce the accumulation register C0
|
||||||
typedef typename conditional<SwappedTraits::LhsProgress>=8,typename unpacket_traits<SResPacket>::half,SResPacket>::type SResPacketHalf;
|
typedef typename conditional<SwappedTraits::LhsProgress>=8,typename unpacket_traits<SResPacket>::half,SResPacket>::type SResPacketHalf;
|
||||||
typedef typename conditional<SwappedTraits::LhsProgress>=8,typename unpacket_traits<SLhsPacket>::half,SLhsPacket>::type SLhsPacketHalf;
|
typedef typename conditional<SwappedTraits::LhsProgress>=8,typename unpacket_traits<SLhsPacket>::half,SLhsPacket>::type SLhsPacketHalf;
|
||||||
typedef typename conditional<SwappedTraits::LhsProgress>=8,typename unpacket_traits<SLhsPacket>::half,SRhsPacket>::type SRhsPacketHalf;
|
typedef typename conditional<SwappedTraits::LhsProgress>=8,typename unpacket_traits<SRhsPacket>::half,SRhsPacket>::type SRhsPacketHalf;
|
||||||
typedef typename conditional<SwappedTraits::LhsProgress>=8,typename unpacket_traits<SAccPacket>::half,SAccPacket>::type SAccPacketHalf;
|
typedef typename conditional<SwappedTraits::LhsProgress>=8,typename unpacket_traits<SAccPacket>::half,SAccPacket>::type SAccPacketHalf;
|
||||||
|
|
||||||
SResPacketHalf R = res.template gatherPacket<SResPacketHalf>(i, j2);
|
SResPacketHalf R = res.template gatherPacket<SResPacketHalf>(i, j2);
|
||||||
|
@ -314,6 +314,8 @@ template<typename Scalar,typename Packet> void packetmath()
|
|||||||
ref[0] *= data1[i];
|
ref[0] *= data1[i];
|
||||||
VERIFY(internal::isApprox(ref[0], internal::predux_mul(internal::pload<Packet>(data1))) && "internal::predux_mul");
|
VERIFY(internal::isApprox(ref[0], internal::predux_mul(internal::pload<Packet>(data1))) && "internal::predux_mul");
|
||||||
|
|
||||||
|
if (PacketTraits::HasReduxp)
|
||||||
|
{
|
||||||
for (int j=0; j<PacketSize; ++j)
|
for (int j=0; j<PacketSize; ++j)
|
||||||
{
|
{
|
||||||
ref[j] = Scalar(0);
|
ref[j] = Scalar(0);
|
||||||
@ -323,6 +325,7 @@ template<typename Scalar,typename Packet> void packetmath()
|
|||||||
}
|
}
|
||||||
internal::pstore(data2, internal::preduxp(packets));
|
internal::pstore(data2, internal::preduxp(packets));
|
||||||
VERIFY(areApproxAbs(ref, data2, PacketSize, refvalue) && "internal::preduxp");
|
VERIFY(areApproxAbs(ref, data2, PacketSize, refvalue) && "internal::preduxp");
|
||||||
|
}
|
||||||
|
|
||||||
for (int i=0; i<PacketSize; ++i)
|
for (int i=0; i<PacketSize; ++i)
|
||||||
ref[i] = data1[PacketSize-i-1];
|
ref[i] = data1[PacketSize-i-1];
|
||||||
|
Loading…
x
Reference in New Issue
Block a user