Searched refs:Transpose (Results 1 - 25 of 130) sorted by relevance

123456

/external/eigen/failtest/
H A Dconst_qualified_transpose_method_retval.cpp12 Transpose<Matrix3d> b(m.transpose());
H A Dtranspose_nonconst_ctor_on_const_xpr.cpp12 Transpose<Matrix3d> t(m);
H A Dtranspose_on_const_type_actually_const.cpp13 Transpose<CV_QUALIFIER MatrixXf>(m).coeffRef(0, 0) = 1.0f;
/external/gemmlowp/internal/
H A Ddispatch_gemm_shape.h37 TransposeType<T> Transpose(const T& t) { function in namespace:gemmlowp
82 dst.result_offset = Transpose(src.result_offset);
83 dst.result_mult_int = Transpose(src.result_mult_int);
95 dst.bias_vector = Transpose(src.bias_vector);
108 return std::make_tuple(Transpose(std::get<0>(t)));
114 return std::make_tuple(Transpose(std::get<0>(t)), Transpose(std::get<1>(t)));
120 return std::make_tuple(Transpose(std::get<0>(t)), Transpose(std::get<1>(t)),
121 Transpose(st
[all...]
/external/tensorflow/tensorflow/stream_executor/
H A Dblas.cc24 string TransposeString(Transpose t) {
26 case Transpose::kNoTranspose:
28 case Transpose::kTranspose:
29 return "Transpose";
30 case Transpose::kConjugateTranspose:
H A Dblas.h65 enum class Transpose { kNoTranspose, kTranspose, kConjugateTranspose }; class in namespace:perftools::gputools::blas
68 string TransposeString(Transpose t);
420 virtual bool DoBlasGbmv(Stream *stream, blas::Transpose trans, uint64 m,
425 virtual bool DoBlasGbmv(Stream *stream, blas::Transpose trans, uint64 m,
430 virtual bool DoBlasGbmv(Stream *stream, blas::Transpose trans, uint64 m,
437 virtual bool DoBlasGbmv(Stream *stream, blas::Transpose trans, uint64 m,
456 virtual bool DoBlasGemv(Stream *stream, blas::Transpose trans, uint64 m,
460 virtual bool DoBlasGemv(Stream *stream, blas::Transpose trans, uint64 m,
464 virtual bool DoBlasGemv(Stream *stream, blas::Transpose trans, uint64 m,
470 virtual bool DoBlasGemv(Stream *stream, blas::Transpose tran
[all...]
H A Dstream.h967 Stream &ThenBlasGbmv(blas::Transpose trans, uint64 m, uint64 n, uint64 kl,
971 Stream &ThenBlasGbmv(blas::Transpose trans, uint64 m, uint64 n, uint64 kl,
975 Stream &ThenBlasGbmv(blas::Transpose trans, uint64 m, uint64 n, uint64 kl,
981 Stream &ThenBlasGbmv(blas::Transpose trans, uint64 m, uint64 n, uint64 kl,
989 Stream &ThenBlasGemv(blas::Transpose trans, uint64 m, uint64 n, float alpha,
993 Stream &ThenBlasGemv(blas::Transpose trans, uint64 m, uint64 n, double alpha,
997 Stream &ThenBlasGemv(blas::Transpose trans, uint64 m, uint64 n,
1003 Stream &ThenBlasGemv(blas::Transpose trans, uint64 m, uint64 n,
1010 Stream &ThenBlasGemvWithProfiling(blas::Transpose trans, uint64 m, uint64 n,
1016 Stream &ThenBlasGemvWithProfiling(blas::Transpose tran
[all...]
H A Dstream.cc74 string ToVlogString(blas::Transpose t) { return blas::TransposeString(t); }
2498 Stream &Stream::ThenBlasGbmv(blas::Transpose trans, uint64 m, uint64 n,
2507 ThenBlasImpl<blas::Transpose, uint64, uint64, uint64, uint64, float,
2514 Stream &Stream::ThenBlasGbmv(blas::Transpose trans, uint64 m, uint64 n,
2523 ThenBlasImpl<blas::Transpose, uint64, uint64, uint64, uint64, double,
2530 Stream &Stream::ThenBlasGbmv(blas::Transpose trans, uint64 m, uint64 n,
2541 ThenBlasImpl<blas::Transpose, uint64, uint64, uint64, uint64,
2550 Stream &Stream::ThenBlasGbmv(blas::Transpose trans, uint64 m, uint64 n,
2561 ThenBlasImpl<blas::Transpose, uint64, uint64, uint64, uint64,
2570 Stream &Stream::ThenBlasGemv(blas::Transpose tran
[all...]
/external/skia/src/core/
H A DSk4x4f.h18 static Sk4x4f Transpose(const Sk4f&, const Sk4f&, const Sk4f&, const Sk4f&);
19 static Sk4x4f Transpose(const float[16]);
20 static Sk4x4f Transpose(const uint8_t[16]);
23 auto t = Transpose(r,g,b,a);
35 inline Sk4x4f Sk4x4f::Transpose(const Sk4f& x, const Sk4f& y, const Sk4f& z, const Sk4f& w) { function in class:__anon20643::Sk4x4f
44 inline Sk4x4f Sk4x4f::Transpose(const float fs[16]) { function in class:__anon20643::Sk4x4f
45 return Transpose(Sk4f::Load(fs+0), Sk4f::Load(fs+4), Sk4f::Load(fs+8), Sk4f::Load(fs+12));
48 inline Sk4x4f Sk4x4f::Transpose(const uint8_t bs[16]) { function in class:__anon20643::Sk4x4f
78 inline Sk4x4f Sk4x4f::Transpose(const Sk4f& x, const Sk4f& y, const Sk4f& z, const Sk4f& w) { function in class:__anon20643::Sk4x4f
86 inline Sk4x4f Sk4x4f::Transpose(cons function in class:__anon20643::Sk4x4f
91 inline Sk4x4f Sk4x4f::Transpose(const uint8_t bs[16]) { function in class:__anon20643::Sk4x4f
115 inline Sk4x4f Sk4x4f::Transpose(const Sk4f& x, const Sk4f& y, const Sk4f& z, const Sk4f& w) { function in class:__anon20643::Sk4x4f
124 inline Sk4x4f Sk4x4f::Transpose(const float fs[16]) { function in class:__anon20643::Sk4x4f
128 inline Sk4x4f Sk4x4f::Transpose(const uint8_t bs[16]) { function in class:__anon20643::Sk4x4f
[all...]
/external/skqp/src/core/
H A DSk4x4f.h18 static Sk4x4f Transpose(const Sk4f&, const Sk4f&, const Sk4f&, const Sk4f&);
19 static Sk4x4f Transpose(const float[16]);
20 static Sk4x4f Transpose(const uint8_t[16]);
23 auto t = Transpose(r,g,b,a);
35 inline Sk4x4f Sk4x4f::Transpose(const Sk4f& x, const Sk4f& y, const Sk4f& z, const Sk4f& w) { function in class:__anon21312::Sk4x4f
44 inline Sk4x4f Sk4x4f::Transpose(const float fs[16]) { function in class:__anon21312::Sk4x4f
45 return Transpose(Sk4f::Load(fs+0), Sk4f::Load(fs+4), Sk4f::Load(fs+8), Sk4f::Load(fs+12));
48 inline Sk4x4f Sk4x4f::Transpose(const uint8_t bs[16]) { function in class:__anon21312::Sk4x4f
78 inline Sk4x4f Sk4x4f::Transpose(const Sk4f& x, const Sk4f& y, const Sk4f& z, const Sk4f& w) { function in class:__anon21312::Sk4x4f
86 inline Sk4x4f Sk4x4f::Transpose(cons function in class:__anon21312::Sk4x4f
91 inline Sk4x4f Sk4x4f::Transpose(const uint8_t bs[16]) { function in class:__anon21312::Sk4x4f
115 inline Sk4x4f Sk4x4f::Transpose(const Sk4f& x, const Sk4f& y, const Sk4f& z, const Sk4f& w) { function in class:__anon21312::Sk4x4f
124 inline Sk4x4f Sk4x4f::Transpose(const float fs[16]) { function in class:__anon21312::Sk4x4f
128 inline Sk4x4f Sk4x4f::Transpose(const uint8_t bs[16]) { function in class:__anon21312::Sk4x4f
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseTranspose.h18 : public SparseMatrixBase<Transpose<MatrixType> >
23 : public SparseCompressedBase<Transpose<MatrixType> >
25 typedef SparseCompressedBase<Transpose<MatrixType> > Base;
55 struct unary_evaluator<Transpose<ArgType>, IteratorBased>
56 : public evaluator_base<Transpose<ArgType> >
60 typedef Transpose<ArgType> XprType;
/external/tensorflow/tensorflow/compiler/xla/tests/
H A Dtranspose_test.cc41 ComputationBuilder builder(client_, "Transpose");
43 auto result = builder.Transpose(lhs, {1, 0});
49 ComputationBuilder builder(client_, "Transpose");
51 auto result = builder.Transpose(lhs, {1, 0});
57 ComputationBuilder builder(client_, "Transpose");
59 auto result = builder.Transpose(lhs, {1, 0});
65 ComputationBuilder builder(client_, "Transpose");
69 auto result = builder.Transpose(lhs, {1, 0});
77 ComputationBuilder builder(client_, "Transpose");
79 auto result = builder.Transpose(operan
[all...]
/external/tensorflow/tensorflow/contrib/rnn/kernels/
H A Dblas_gemm.cc44 perftools::gputools::blas::Transpose trans[] = {
45 perftools::gputools::blas::Transpose::kNoTranspose,
46 perftools::gputools::blas::Transpose::kTranspose};
/external/tensorflow/tensorflow/stream_executor/cuda/
H A Dcuda_blas.h112 FuncT cublas_func, Stream *stream, blas::Transpose transa,
113 blas::Transpose transb, uint64 m, uint64 n, uint64 k, T alpha,
127 Stream *stream, blas::Transpose transa, blas::Transpose transb, uint64 m,
137 Stream *stream, blas::Transpose transa, blas::Transpose transb, uint64 m,
144 bool DoBlasGemvWithProfilingImpl(Stream *stream, blas::Transpose trans,
H A Dcuda_blas.cc477 cublasOperation_t CUDABlasTranspose(blas::Transpose trans) {
479 case blas::Transpose::kNoTranspose:
481 case blas::Transpose::kTranspose:
483 case blas::Transpose::kConjugateTranspose:
486 LOG(FATAL) << "Invalid value of blas::Transpose.";
1090 bool CUDABlas::DoBlasGbmv(Stream *stream, blas::Transpose trans, uint64 m,
1101 bool CUDABlas::DoBlasGbmv(Stream *stream, blas::Transpose trans, uint64 m,
1112 bool CUDABlas::DoBlasGbmv(Stream *stream, blas::Transpose trans, uint64 m,
1126 bool CUDABlas::DoBlasGbmv(Stream *stream, blas::Transpose trans, uint64 m,
1140 bool CUDABlas::DoBlasGemv(Stream *stream, blas::Transpose tran
[all...]
/external/tensorflow/tensorflow/core/kernels/
H A Dtranspose_functor.h27 // Transpose tensor 'in' into tensor 'out' according to dimension
62 struct Transpose { struct in namespace:tensorflow
179 Transpose<Device, uint8>::run(d, in, perm, out);
188 Transpose<Device, uint16>::run(d, in, perm, out);
194 Transpose<Device, uint32>::run(d, in, perm, out);
199 Transpose<Device, uint64>::run(d, in, perm, out);
210 Transpose<Device, complex64, /*conjugate=*/true>::run(d, in, perm, out);
213 Transpose<Device, uint64>::run(d, in, perm, out);
219 Transpose<Device, complex128, /*conjugate=*/true>::run(d, in, perm,
222 Transpose<Devic
[all...]
/external/eigen/Eigen/src/Core/
H A DTranspositions.h108 inline Transpose<TranspositionsBase> inverse() const
109 { return Transpose<TranspositionsBase>(derived()); }
112 inline Transpose<TranspositionsBase> transpose() const
113 { return Transpose<TranspositionsBase>(derived()); }
362 struct traits<Transpose<TranspositionsBase<Derived> > >
369 class Transpose<TranspositionsBase<TranspositionsDerived> > class in namespace:Eigen
375 explicit Transpose(const TranspositionType& t) : m_transpositions(t) {} function in class:Eigen::Transpose
384 const Product<OtherDerived, Transpose, AliasFreeProduct>
385 operator*(const MatrixBase<OtherDerived>& matrix, const Transpose& trt)
387 return Product<OtherDerived, Transpose, AliasFreeProduc
[all...]
H A DTranspose.h18 struct traits<Transpose<MatrixType> > : public traits<MatrixType>
39 /** \class Transpose
52 template<typename MatrixType> class Transpose class in namespace:Eigen
60 EIGEN_GENERIC_PUBLIC_INTERFACE(Transpose)
64 explicit inline Transpose(MatrixType& matrix) : m_matrix(matrix) {} function in class:Eigen::Transpose
66 EIGEN_INHERIT_ASSIGNMENT_OPERATORS(Transpose)
95 typedef typename dense_xpr_base<Transpose<MatrixType> >::type type;
101 typedef typename dense_xpr_base<Transpose<MatrixType> >::type type;
109 : public internal::generic_xpr_base<Transpose<XprType> >::type
112 typedef typename internal::generic_xpr_base<Transpose<XprTyp
[all...]
/external/skia/tests/
H A DSk4x4fTest.cpp18 f = Sk4x4f::Transpose(x,y,z,w);
33 f = Sk4x4f::Transpose(fs);
45 f = Sk4x4f::Transpose(bs);
/external/skqp/tests/
H A DSk4x4fTest.cpp18 f = Sk4x4f::Transpose(x,y,z,w);
33 f = Sk4x4f::Transpose(fs);
45 f = Sk4x4f::Transpose(bs);
/external/tensorflow/tensorflow/compiler/xla/service/gpu/
H A Dgemm_thunk.cc59 auto lhs_transpose = lhs_matrix.transpose ? se::blas::Transpose::kTranspose
60 : se::blas::Transpose::kNoTranspose;
61 auto rhs_transpose = rhs_matrix.transpose ? se::blas::Transpose::kTranspose
62 : se::blas::Transpose::kNoTranspose;
102 auto lhs_transpose = lhs_matrix.transpose ? se::blas::Transpose::kTranspose
103 : se::blas::Transpose::kNoTranspose;
104 auto rhs_transpose = rhs_matrix.transpose ? se::blas::Transpose::kTranspose
105 : se::blas::Transpose::kNoTranspose;
/external/tensorflow/tensorflow/contrib/lite/toco/graph_transformations/
H A Dresolve_constant_transpose.cc29 void Transpose(Model* model, const Array& input_array, function in namespace:toco::__anon26062
146 Transpose<ArrayDataType::kFloat>(model, input_array, op->perm,
150 Transpose<ArrayDataType::kUint8>(model, input_array, op->perm,
154 Transpose<ArrayDataType::kInt32>(model, input_array, op->perm,
158 Transpose<ArrayDataType::kInt64>(model, input_array, op->perm,
162 LOG(FATAL) << "Unsupported data type given to Transpose op with output \""
/external/eigen/Eigen/src/Core/products/
H A DGeneralMatrixMatrix.h281 Transpose = StorageOrder==RowMajor, enumerator in enum:Eigen::internal::gemm_blocking_space::__anon6129
282 ActualRows = Transpose ? MaxCols : MaxRows,
283 ActualCols = Transpose ? MaxRows : MaxCols
285 typedef typename conditional<Transpose,_RhsScalar,_LhsScalar>::type LhsScalar;
286 typedef typename conditional<Transpose,_LhsScalar,_RhsScalar>::type RhsScalar;
332 Transpose = StorageOrder==RowMajor enumerator in enum:Eigen::internal::gemm_blocking_space::__anon6131
334 typedef typename conditional<Transpose,_RhsScalar,_LhsScalar>::type LhsScalar;
335 typedef typename conditional<Transpose,_LhsScalar,_RhsScalar>::type RhsScalar;
345 this->m_mc = Transpose ? cols : rows;
346 this->m_nc = Transpose
[all...]
/external/dng_sdk/source/
H A Ddng_point.h179 inline dng_point Transpose (const dng_point &a) function
188 inline dng_point_real64 Transpose (const dng_point_real64 &a) function
/external/tensorflow/tensorflow/compiler/tf2xla/kernels/
H A Dmatmul_op.cc79 auto lhs = (transpose_a_) ? ctx->builder()->Transpose(a, {1, 0}) : a;
80 auto rhs = (transpose_b_) ? ctx->builder()->Transpose(b, {1, 0}) : b;

Completed in 717 milliseconds

123456