HomeSort by relevance Sort by last modified time
    Searched refs:cols (Results 251 - 275 of 667) sorted by null

<<11121314151617181920>>

  /external/eigen/Eigen/src/Eigenvalues/
SelfAdjointEigenSolver_MKL.h 47 eigen_assert(matrix.cols() == matrix.rows()); \
52 lapack_int n = matrix.cols(), lda, matrix_order, info; \
SelfAdjointEigenSolver.h 154 : m_eivec(matrix.rows(), matrix.cols()),
155 m_eivalues(matrix.cols()),
325 : m_eivec(matrix.rows(), matrix.cols()),
326 m_eivalues(matrix.cols()),
334 : m_eivec(matA.cols(), matA.cols()),
335 m_eivalues(matA.cols()),
336 m_subdiag(matA.cols() > 1 ? matA.cols() - 1 : 1),
388 eigen_assert(matrix.cols() == matrix.rows())
    [all...]
ComplexSchur.h 113 : m_matT(matrix.rows(),matrix.cols()),
114 m_matU(matrix.rows(),matrix.cols()),
319 eigen_assert(matrix.cols() == matrix.rows());
321 if(matrix.cols() == 1)
394 Index iu = m_matT.cols() - 1;
431 m_matT.rightCols(m_matT.cols()-il).applyOnTheLeft(il, il+1, rot.adjoint());
439 m_matT.rightCols(m_matT.cols()-i).applyOnTheLeft(i, i+1, rot.adjoint());
  /external/eigen/Eigen/src/SparseCore/
SparseView.h 45 inline Index cols() const { return m_matrix.cols(); } function in class:Eigen::SparseView
  /external/eigen/Eigen/src/misc/
Image.h 50 inline Index cols() const { return m_cols; } function in struct:Eigen::internal::image_retval_base
78 using Base::cols; \
  /external/eigen/Eigen/src/plugins/
MatrixCwiseBinaryOps.h 86 return cwiseMin(Derived::Constant(rows(), cols(), other));
110 return cwiseMax(Derived::Constant(rows(), cols(), other));
  /external/eigen/test/eigen2/
eigen2_sparse_basic.cpp 49 const int cols = ref.cols(); local
53 double density = std::max(8./(rows*cols), 0.01);
58 SparseMatrixType m(rows, cols);
59 DenseMatrix refMat = DenseMatrix::Zero(rows, cols);
87 int j = ei_random<int>(0,cols-1);
89 int w = ei_random<int>(1,cols-j-1);
111 for(int c=0; c<cols; c++)
167 DenseMatrix m1(rows,cols);
169 SparseMatrixType m2(rows,cols);
    [all...]
  /external/eigen/test/
real_qz.cpp 23 Index dim = m.cols();
33 for (Index i=0; i<A.cols(); i++)
sparse_permutations.cpp 17 const Index cols = ref.cols(); local
24 double density = (std::max)(8./(rows*cols), 0.01);
26 SparseMatrixType mat(rows, cols), up(rows,cols), lo(rows,cols);
28 DenseMatrix mat_d = DenseMatrix::Zero(rows, cols), up_sym_d, lo_sym_d, res_d;
44 randomPermutationVector(pi, cols);
zerosized.cpp 35 VERIFY(t1.cols() == 0);
42 VERIFY(t2.cols() == 0);
qr_colpivoting.cpp 18 Index rows = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE), cols = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE), cols2 = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE); local
19 Index rank = internal::random<Index>(1, (std::min)(rows, cols)-1);
24 createRandomPIMatrixOfRank(rank,rows,cols,m1);
27 VERIFY(cols - qr.rank() == qr.dimensionOfKernel());
39 MatrixType m2 = MatrixType::Random(cols,cols2);
41 m2 = MatrixType::Random(cols,cols2);
48 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
50 int rank = internal::random<int>(1, (std::min)(int(Rows), int(Cols))-1);
51 Matrix<Scalar,Rows,Cols> m1;
52 createRandomPIMatrixOfRank(rank,Rows,Cols,m1)
    [all...]
stable_norm.cpp 56 Index cols = m.cols(); local
69 MatrixType vzero = MatrixType::Zero(rows, cols),
70 vrand = MatrixType::Random(rows, cols),
71 vbig(rows, cols),
72 vsmall(rows,cols);
  /external/eigen/unsupported/Eigen/src/Skyline/
SkylineInplaceLU.h 37 : /*m_matrix(matrix.rows(), matrix.cols()),*/ m_flags(flags), m_status(0), m_lu(matrix) {
122 const size_t cols = m_lu.cols(); local
124 eigen_assert(rows == cols && "We do not (yet) support rectangular LU.");
186 const size_t cols = m_lu.cols(); local
188 eigen_assert(rows == cols && "We do not (yet) support rectangular LU.");
309 const size_t cols = m_lu.cols(); local
  /external/libvpx/libvpx/vpx/
vp8cx.h 229 unsigned int cols; /**< Number of columns. */ member in struct:vpx_roi_map
249 unsigned int cols; /**< number of cols */ member in struct:vpx_active_map
  /external/libvterm/include/
vterm.h 115 VTerm *vterm_new(int rows, int cols);
116 VTerm *vterm_new_with_allocator(int rows, int cols, VTermAllocatorFunctions *funcs, void *allocdata);
120 void vterm_set_size(VTerm *vt, int rows, int cols);
167 int (*resize)(int rows, int cols, void *user);
189 int (*resize)(int rows, int cols, VTermPos *delta, void *user);
231 int (*resize)(int rows, int cols, void *user);
232 int (*sb_pushline)(int cols, const VTermScreenCell *cells, void *user);
233 int (*sb_popline)(int cols, VTermScreenCell *cells, void *user);
  /external/ceres-solver/internal/ceres/
schur_eliminator_test.cc 72 num_eliminate_cols += bs->cols[i].size;
88 const int schur_size = J.cols() - num_eliminate_cols;
96 sol_expected.resize(J.cols());
111 const int block_size = bs->cols[i].size;
131 const int num_col_blocks = bs->cols.size();
134 blocks[i - num_eliminate_blocks] = bs->cols[i].size;
schur_eliminator_impl.h 88 const int num_col_blocks = bs->cols.size();
102 lhs_num_rows += bs->cols[i].size;
122 const int e_block_size = bs->cols[chunk_block_id].size;
138 buffer_size += e_block_size * bs->cols[cell.block_id].size;
184 const int num_col_blocks = bs->cols.size();
196 const int block_size = bs->cols[i].size;
198 diag(D + bs->cols[i].position, block_size);
232 const int e_block_size = bs->cols[e_block_id].size;
241 diag(D + bs->cols[e_block_id].position, e_block_size);
314 const int e_block_size = bs->cols[e_block_id].size
    [all...]
  /external/eigen/Eigen/src/Eigen2Support/
CwiseOperators.h 216 typename ExpressionType::ConstantReturnType(_expression().rows(), _expression().cols(), s));
225 typename ExpressionType::ConstantReturnType(_expression().rows(), _expression().cols(), s));
234 typename ExpressionType::ConstantReturnType(_expression().rows(), _expression().cols(), s));
243 typename ExpressionType::ConstantReturnType(_expression().rows(), _expression().cols(), s));
252 typename ExpressionType::ConstantReturnType(_expression().rows(), _expression().cols(), s));
261 typename ExpressionType::ConstantReturnType(_expression().rows(), _expression().cols(), s));
  /external/eigen/unsupported/test/
kronecker_product.cpp 19 void check_dimension(const MatrixType& ab, const int rows, const int cols)
22 VERIFY_IS_EQUAL(ab.cols(), cols);
30 VERIFY_IS_EQUAL(ab.cols(), 6);
75 VERIFY_IS_EQUAL(ab.cols(), 10);
116 for(int j=0;j<DM_fix_ab.cols();++j)
matrix_exponential.cpp 104 typename MatrixType::Index cols = m.cols(); local
105 MatrixType m1(rows, cols), m2(rows, cols), identity = MatrixType::Identity(rows, cols);
110 m1 = MatrixType::Random(rows, cols);
  /external/opencv/ml/src/
_ml.h 76 if( MIN( (mat).rows, (mat).cols ) != 1 ) \
82 (num) = (mat).cols; \
98 (n) = (mat).cols; \
105 (m) = (mat).cols; \
110 (mat)->cols > 0 && (mat)->rows > 0)
229 int dims = (matrice)->cols; \
  /external/chromium_org/content/common/gpu/media/
rendering_helper.cc 578 size_t cols = sqrt(videos_.size() - 1) + 1; local
579 size_t rows = (videos_.size() + cols - 1) / cols;
582 std::vector<int> widths(cols);
584 std::vector<int> offset_x(cols);
589 widths[i % cols] = std::max(widths[i % cols], size.width());
590 heights[i / cols] = std::max(heights[i / cols], size.height());
600 std::min(static_cast<float>(widths[i % cols]) / size.width()
    [all...]
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixPower.h 32 Index cols() const { return m_pow.cols(); } function in class:Eigen::MatrixPowerRetval
74 { eigen_assert(T.rows() == T.cols()); }
100 res = (MatrixType::Identity(IminusT.rows(), IminusT.cols()) + res).template triangularView<Upper>()
103 res += MatrixType::Identity(IminusT.rows(), IminusT.cols());
116 for (Index i=1; i < m_A.cols(); ++i) {
155 for (Index i=0; i < m_A.cols(); ++i)
159 IminusT = MatrixType::Identity(m_A.rows(), m_A.cols()) - T;
298 { eigen_assert(A.rows() == A.cols()); }
321 Index cols() const { return m_A.cols(); function in class:Eigen::MatrixPower
483 Index cols() const { return m_A.cols(); } function in class:Eigen::MatrixPowerReturnValue
    [all...]
  /external/opencv/cv/src/
cvcalibration.cpp 295 CV_ASSERT( A->cols == B->rows );
298 L = A->cols;
299 N = B->cols;
305 dABdA->rows == A->rows*B->cols && dABdA->cols == A->rows*A->cols );
311 dABdB->rows == A->rows*B->cols && dABdB->cols == B->rows*B->cols );
401 CV_ASSERT( _rvec1->rows == 3 && _rvec1->cols == 1 && CV_ARE_SIZES_EQ(_rvec1, _rvec2) )
    [all...]
  /external/chromium_org/third_party/WebKit/Source/core/rendering/
RenderFrameSet.cpp 137 size_t cols = m_cols.m_sizes.size(); local
143 for (size_t c = 0; c < cols; c++) {
415 size_t cols = m_cols.m_sizes.size(); local
417 for (size_t c = 0; c < cols; ++c) {
436 int cols = frameSet()->totalCols(); local
437 if (rows && cols) {
440 result.setPreventResize(RightFrameEdge, m_cols.m_preventResize[cols]);
441 result.setAllowBorder(RightFrameEdge, m_cols.m_allowBorder[cols]);
460 unsigned cols = frameSet()->totalCols(); local
463 if (m_rows.m_sizes.size() != rows || m_cols.m_sizes.size() != cols) {
500 int cols = frameSet()->totalCols(); local
    [all...]

Completed in 312 milliseconds

<<11121314151617181920>>