HomeSort by relevance Sort by last modified time
    Searched full:transpose (Results 151 - 175 of 693) sorted by null

1 2 3 4 5 67 8 91011>>

  /external/eigen/Eigen/src/SparseCore/
SparsePermutation.h 86 perm = m_permutation.transpose();
132 operator*(const SparseMatrixBase<SparseDerived>& matrix, const Transpose<PermutationBase<PermDerived> >& tperm)
141 operator*(const Transpose<PermutationBase<PermDerived> >& tperm, const SparseMatrixBase<SparseDerived>& matrix)
SparseSparseProductWithPruning.h 116 // let's transpose the product to get a column x column product
134 // let's transpose the product to get a column x column product
138 // res = _res.transpose();
  /external/eigen/bench/
sparse_dense_product.cpp 85 v2 = m1.transpose() * v1;
99 BENCH( { asm("#mya"); v2 = sm1.transpose() * v1; asm("#myb"); })
111 // BENCH(for (int k=0; k<REPEAT; ++k) v2 = m1.transpose() * v1;)
  /external/eigen/unsupported/test/
polynomialsolver.cpp 51 cerr << "Polynomial: " << pols.transpose() << endl;
52 cerr << "Roots found: " << roots.transpose() << endl;
53 cerr << "Abs value of the polynomial at the roots: " << evr.transpose() << endl;
  /external/jpeg/
transupp.h 44 JXFORM_TRANSPOSE, /* transpose across UL-to-LR axis */
45 JXFORM_TRANSVERSE, /* transpose across UR-to-LL axis */
64 * Transpose is the only transformation that can handle partial iMCUs at the
jpegtran.c 70 fprintf(stderr, " -transpose Transpose image\n");
71 fprintf(stderr, " -transverse Transverse transpose image\n");
292 } else if (keymatch(arg, "transpose", 1)) {
293 /* Transpose (across UL-to-LR axis). */
297 /* Transverse transpose (across UR-to-LL axis). */
  /external/qemu/distrib/jpeg-6b/
transupp.h 44 JXFORM_TRANSPOSE, /* transpose across UL-to-LR axis */
45 JXFORM_TRANSVERSE, /* transpose across UR-to-LL axis */
64 * Transpose is the only transformation that can handle partial iMCUs at the
jpegtran.c 70 fprintf(stderr, " -transpose Transpose image\n");
71 fprintf(stderr, " -transverse Transverse transpose image\n");
292 } else if (keymatch(arg, "transpose", 1)) {
293 /* Transpose (across UL-to-LR axis). */
297 /* Transverse transpose (across UR-to-LL axis). */
  /external/skia/src/gpu/gl/
GrGLNoOpInterface.h 242 GrGLboolean transpose,
247 GrGLboolean transpose,
252 GrGLboolean transpose,
  /frameworks/av/media/libstagefright/codecs/on2/h264dec/omxdl/arm_neon/vc/m4p10/src/
omxVCM4P10_TransformDequantLumaDCFromPair_s.s 120 ;// Transpose the 4x4 matrix *
122 ;// Transpose the 4x4 result matrix *
151 ;// Transpose the resultant matrix
  /external/ceres-solver/internal/ceres/
compressed_row_sparse_matrix_test.cc 275 TEST(CompressedRowSparseMatrix, Transpose) {
318 scoped_ptr<CompressedRowSparseMatrix> transpose(matrix.Transpose());
324 transpose->ToDenseMatrix(&dense_transpose);
325 EXPECT_NEAR((dense_matrix - dense_transpose.transpose()).norm(), 0.0, 1e-14);
small_blas.h 230 block CERES_MAYBE_NOALIAS += Aref.transpose() * Bref;
232 block CERES_MAYBE_NOALIAS -= Aref.transpose() * Bref;
234 block CERES_MAYBE_NOALIAS = Aref.transpose() * Bref;
363 cref += Aref.transpose().lazyProduct(bref);
365 cref -= Aref.transpose().lazyProduct(bref);
367 cref = Aref.transpose().lazyProduct(bref);
incomplete_lq_factorization_test.cc 108 Matrix expected_l_matrix = (mref * mref.transpose()).llt().matrixL();
112 EXPECT_NEAR((expected_l_matrix * expected_l_matrix.transpose() -
113 actual_l_matrix * actual_l_matrix.transpose()).norm(),
  /external/eigen/Eigen/src/Core/
SolveTriangular.h 125 rhs.coeffRef(I) -= lhs.row(I).template segment<Index>(S).transpose()
150 Transpose<const Lhs> trLhs(lhs);
151 Transpose<Rhs> trRhs(rhs);
153 triangular_solver_unroller<Transpose<const Lhs>,Transpose<Rhs>,
PermutationMatrix.h 201 inline Transpose<PermutationBase> inverse() const
207 inline Transpose<PermutationBase> transpose() const function in class:Eigen::PermutationBase
243 inline PlainPermutationType operator*(const Transpose<PermutationBase<Other> >& other) const
251 inline PlainPermutationType operator*(const Transpose<PermutationBase<Other> >& other, const PermutationBase& perm)
367 PermutationMatrix(const Transpose<PermutationBase<Other> >& other)
606 struct traits<Transpose<PermutationBase<Derived> > >
613 class Transpose<PermutationBase<Derived> >
614 : public EigenBase<Transpose<PermutationBase<Derived> > >
635 Transpose(const PermutationType& p) : m_permutation(p) {
    [all...]
  /external/eigen/Eigen/src/Core/util/
BlasUtil.h 216 // pop/push transpose
218 struct blas_traits<Transpose<NestedXpr> >
223 typedef Transpose<NestedXpr> XprType;
224 typedef Transpose<const typename Base::_ExtractType> ExtractType; // const to get rid of a compile error; anyway blas traits are only used on the RHS
225 typedef Transpose<const typename Base::_ExtractType> _ExtractType;
  /external/eigen/blas/
level3_impl.h 276 matA.triangularView<Lower>() = matrix(a,size,size,*lda).transpose();
281 matA.triangularView<Upper>() = matrix(a,size,size,*lda).transpose();
358 matrix(c, *n, *n, *ldc).triangularView<Upper>() += alpha * matrix(a,*n,*k,*lda) * matrix(a,*n,*k,*lda).transpose();
360 matrix(c, *n, *n, *ldc).triangularView<Upper>() += alpha * matrix(a,*k,*n,*lda).transpose() * matrix(a,*k,*n,*lda);
365 matrix(c, *n, *n, *ldc).triangularView<Lower>() += alpha * matrix(a,*n,*k,*lda) * matrix(a,*n,*k,*lda).transpose();
367 matrix(c, *n, *n, *ldc).triangularView<Lower>() += alpha * matrix(a,*k,*n,*lda).transpose() * matrix(a,*k,*n,*lda);
416 += alpha *matrix(a, *n, *k, *lda)*matrix(b, *n, *k, *ldb).transpose()
417 + alpha*matrix(b, *n, *k, *ldb)*matrix(a, *n, *k, *lda).transpose();
421 += alpha*matrix(a, *n, *k, *lda)*matrix(b, *n, *k, *ldb).transpose()
422 + alpha*matrix(b, *n, *k, *ldb)*matrix(a, *n, *k, *lda).transpose();
    [all...]
  /external/chromium_org/third_party/skia/src/effects/
SkBlurMask.cpp 21 * "transpose" parameter is true, it will transpose the pixels on write,
65 bool transpose)
72 int dst_x_stride = transpose ? height : 1;
73 int dst_y_stride = transpose ? 1 : new_width;
271 bool transpose, uint8_t outer_weight)
287 int dst_x_stride = transpose ? height : 1;
288 int dst_y_stride = transpose ? 1 : new_width;
540 // Do three X blurs, with a transpose on the final one.
544 // Do three Y blurs, with a transpose on the final one
    [all...]
  /external/skia/src/effects/
SkBlurMask.cpp 21 * "transpose" parameter is true, it will transpose the pixels on write,
65 bool transpose)
72 int dst_x_stride = transpose ? height : 1;
73 int dst_y_stride = transpose ? 1 : new_width;
271 bool transpose, uint8_t outer_weight)
287 int dst_x_stride = transpose ? height : 1;
288 int dst_y_stride = transpose ? 1 : new_width;
540 // Do three X blurs, with a transpose on the final one.
544 // Do three Y blurs, with a transpose on the final one
    [all...]
  /external/sonivox/jet_tools/JetCreator/
JetFile.py 79 SEGMENT_TRANSPOSE = 'transpose'
94 def __init__ (self, segname, filename, start=None, end=None, length=None, output=None, quantize=None, jetevents=[], dlsfile=None, dump_file=None, transpose=0, repeat=0, mute_flags=0):
106 self.transpose = transpose
314 transpose = repeat = mute_flags = 0
336 transpose = config.get(segment_name, SEGMENT_TRANSPOSE)
360 segments.append(JetSegment(segname, filename, start, end, length, output, quantize, jetevents, dlsfile, dump_file, int(transpose), int(repeat), int(mute_flags)))
615 def AddSegment(self, segname, filename, start, end, length, output, quantize, jetevents, dlsfile, dump_file, transpose, repeat, mute_flags):
621 self.segments.append(JetSegment(segname, filename, start, end, length, output, quantize, jetevents, dlsfile, dump_file, transpose, repeat, mute_flags))
623 def UpdateSegment(self, orgsegname, segname, filename, start, end, length, output, quantize, jetevents, dlsfile, dump_file, transpose, repeat, mute_flags):
    [all...]
  /external/chromium_org/ui/gl/
gl_bindings_skia_in_process.cc 519 GLboolean transpose, const GLfloat* value) {
520 glUniformMatrix2fv(location, count, transpose, value);
524 GLboolean transpose, const GLfloat* value) {
525 glUniformMatrix3fv(location, count, transpose, value);
529 GLboolean transpose, const GLfloat* value) {
530 glUniformMatrix4fv(location, count, transpose, value);
  /external/eigen/Eigen/src/Core/products/
TriangularMatrixVector.h 120 res.coeffRef(i) += alpha * (cjLhs.row(i).segment(s,r).cwiseProduct(cjRhs.segment(s,r).transpose())).sum();
194 typedef TriangularProduct<(Mode & (UnitDiag|ZeroDiag)) | ((Mode & Lower) ? Upper : Lower),true,Transpose<const Rhs>,false,Transpose<const Lhs>,true> TriangularProductTranspose;
195 Transpose<Dest> dstT(dst);
197 TriangularProductTranspose(m_rhs.transpose(),m_lhs.transpose()), dstT, alpha);
  /frameworks/av/media/libstagefright/codecs/on2/h264dec/omxdl/arm11/vc/m4p10/src/
omxVCM4P10_TransformDequantLumaDCFromPair_s.s 62 ;// Transpose for Row operations (Rows to cols)
89 ;// Transpose for colulmn operations
152 ;// Transpose the 4x4 matrix *
154 ;// Transpose the 4x4 result matrix *
165 ;// Transpose the matrix inorder to perform row ops as coloumn ops
247 ;// Transpose the resultant matrix
  /frameworks/native/opengl/libs/GLES2/
gl2_api.in 382 void API_ENTRY(glUniformMatrix2fv)(GLint location, GLsizei count, GLboolean transpose, const GLfloat* value) {
383 CALL_GL_API(glUniformMatrix2fv, location, count, transpose, value);
385 void API_ENTRY(glUniformMatrix3fv)(GLint location, GLsizei count, GLboolean transpose, const GLfloat* value) {
386 CALL_GL_API(glUniformMatrix3fv, location, count, transpose, value);
388 void API_ENTRY(glUniformMatrix4fv)(GLint location, GLsizei count, GLboolean transpose, const GLfloat* value) {
389 CALL_GL_API(glUniformMatrix4fv, location, count, transpose, value);
gl2ext_api.in 235 void API_ENTRY(glProgramUniformMatrix2fvEXT)(GLuint program, GLint location, GLsizei count, GLboolean transpose, const GLfloat *value) {
236 CALL_GL_API(glProgramUniformMatrix2fvEXT, program, location, count, transpose, value);
238 void API_ENTRY(glProgramUniformMatrix3fvEXT)(GLuint program, GLint location, GLsizei count, GLboolean transpose, const GLfloat *value) {
239 CALL_GL_API(glProgramUniformMatrix3fvEXT, program, location, count, transpose, value);
241 void API_ENTRY(glProgramUniformMatrix4fvEXT)(GLuint program, GLint location, GLsizei count, GLboolean transpose, const GLfloat *value) {
242 CALL_GL_API(glProgramUniformMatrix4fvEXT, program, location, count, transpose, value);

Completed in 497 milliseconds

1 2 3 4 5 67 8 91011>>