Home
last modified time | relevance | path

Searched refs:num_cols (Results 1 – 25 of 104) sorted by relevance

12345

/external/ceres-solver/internal/ceres/
Dnormal_prior_test.cc59 for (int num_cols = 1; num_cols < 5; ++num_cols) { in TEST() local
60 Vector b(num_cols); in TEST()
63 Matrix A(num_rows, num_cols); in TEST()
66 double * x = new double[num_cols]; in TEST()
67 for (int i = 0; i < num_cols; ++i) in TEST()
70 double * jacobian = new double[num_rows * num_cols]; in TEST()
78 (residuals - A * (VectorRef(x, num_cols) - b)).squaredNorm(); in TEST()
82 MatrixRef J(jacobian, num_rows, num_cols); in TEST()
96 for (int num_cols = 1; num_cols < 5; ++num_cols) { in TEST() local
97 Vector b(num_cols); in TEST()
[all …]
Ddense_sparse_matrix_test.cc50 EXPECT_EQ(a->num_cols(), b->num_cols()); in CompareMatrices()
53 int num_cols = a->num_cols(); in CompareMatrices() local
55 for (int i = 0; i < num_cols; ++i) { in CompareMatrices()
56 Vector x = Vector::Zero(num_cols); in CompareMatrices()
81 num_cols = tsm->num_cols(); in SetUp()
85 int num_cols; member in ceres::internal::DenseSparseMatrixTest
96 Vector a(num_cols); in TEST_F()
97 for (int i = 0; i < num_cols; i++) { in TEST_F()
114 Vector b1 = Vector::Zero(num_cols); in TEST_F()
115 Vector b2 = Vector::Zero(num_cols); in TEST_F()
[all …]
Ddynamic_compressed_row_sparse_matrix_test.cc49 num_cols = 4; in SetUp()
56 expected_num_nonzeros = num_rows * num_cols - min(num_rows, num_cols); in SetUp()
62 num_cols, in SetUp()
71 dense.resize(num_rows, num_cols); in InitialiseDenseReference()
74 for (int i = 0; i < (num_rows * num_cols); ++i) { in InitialiseDenseReference()
75 const int r = i / num_cols, c = i % num_cols; in InitialiseDenseReference()
87 for (int i = 0; i < (num_rows * num_cols); ++i) { in InitialiseSparseMatrixReferences()
88 const int r = i / num_cols, c = i % num_cols; in InitialiseSparseMatrixReferences()
98 num_cols, in InitialiseSparseMatrixReferences()
117 for (int c = 0; c < num_cols; ++c) { in InsertNonZeroEntriesFromDenseReference()
[all …]
Ddense_normal_cholesky_solver.cc72 const int num_cols = A->num_cols(); in SolveUsingEigen() local
75 Matrix lhs(num_cols, num_cols); in SolveUsingEigen()
91 ConstVectorRef D(per_solve_options.D, num_cols); in SolveUsingEigen()
110 VectorRef(x, num_cols) = llt.solve(rhs); in SolveUsingEigen()
128 const int num_cols = A->num_cols(); in SolveUsingLAPACK() local
129 Matrix lhs(num_cols, num_cols); in SolveUsingLAPACK()
137 num_cols, in SolveUsingLAPACK()
151 VectorRef(x, num_cols) = in SolveUsingLAPACK()
158 LAPACK::SolveInPlaceUsingCholesky(num_cols, in SolveUsingLAPACK()
Ddense_sparse_matrix.cc42 DenseSparseMatrix::DenseSparseMatrix(int num_rows, int num_cols) in DenseSparseMatrix() argument
45 m_.resize(num_rows, num_cols); in DenseSparseMatrix()
50 int num_cols, in DenseSparseMatrix() argument
56 m_.resize(num_rows + num_cols, num_cols); in DenseSparseMatrix()
58 m_.resize(num_rows, num_cols); in DenseSparseMatrix()
64 : m_(Eigen::MatrixXd::Zero(m.num_rows(), m.num_cols())), in DenseSparseMatrix()
88 VectorRef(y, num_rows()) += matrix() * ConstVectorRef(x, num_cols()); in RightMultiply()
92 VectorRef(y, num_cols()) += in LeftMultiply()
97 VectorRef(x, num_cols()) = m_.colwise().squaredNorm(); in SquaredColumnNorm()
101 m_ *= ConstVectorRef(scale, num_cols()).asDiagonal(); in ScaleColumns()
[all …]
Dlinear_least_squares_problems.cc182 int num_cols = 5; in LinearLeastSquaresProblem1() local
186 num_cols, in LinearLeastSquaresProblem1()
187 num_rows * num_cols); in LinearLeastSquaresProblem1()
189 problem->D.reset(new double[num_cols]); in LinearLeastSquaresProblem1()
273 for (int i = 0; i < num_cols; ++i) { in LinearLeastSquaresProblem1()
287 int num_cols = 5; in LinearLeastSquaresProblem2() local
292 problem->D.reset(new double[num_cols]); in LinearLeastSquaresProblem2()
296 scoped_array<double> values(new double[num_rows * num_cols]); in LinearLeastSquaresProblem2()
298 for (int c = 0; c < num_cols; ++c) { in LinearLeastSquaresProblem2()
389 for (int i = 0; i < num_cols; ++i) { in LinearLeastSquaresProblem2()
[all …]
Dcompressed_col_sparse_matrix_utils.h70 void SolveUpperTriangularInPlace(IntegerType num_cols, in SolveUpperTriangularInPlace() argument
75 for (IntegerType c = num_cols - 1; c >= 0; --c) { in SolveUpperTriangularInPlace()
91 void SolveUpperTriangularTransposeInPlace(IntegerType num_cols, in SolveUpperTriangularTransposeInPlace() argument
96 for (IntegerType c = 0; c < num_cols; ++c) { in SolveUpperTriangularTransposeInPlace()
117 void SolveRTRWithSparseRHS(IntegerType num_cols, in SolveRTRWithSparseRHS() argument
123 fill(solution, solution + num_cols, 0.0); in SolveRTRWithSparseRHS()
126 for (IntegerType c = rhs_nonzero_index + 1; c < num_cols; ++c) { in SolveRTRWithSparseRHS()
136 SolveUpperTriangularInPlace(num_cols, rows, cols, values, solution); in SolveRTRWithSparseRHS()
Dblock_random_access_diagonal_matrix.cc52 int num_cols = 0; in BlockRandomAccessDiagonalMatrix() local
56 col_layout.push_back(num_cols); in BlockRandomAccessDiagonalMatrix()
57 num_cols += blocks_[i]; in BlockRandomAccessDiagonalMatrix()
61 VLOG(1) << "Matrix Size [" << num_cols in BlockRandomAccessDiagonalMatrix()
62 << "," << num_cols in BlockRandomAccessDiagonalMatrix()
65 tsm_.reset(new TripletSparseMatrix(num_cols, num_cols, num_nonzeros)); in BlockRandomAccessDiagonalMatrix()
Dcompressed_row_sparse_matrix_test.cc50 EXPECT_EQ(a->num_cols(), b->num_cols()); in CompareMatrices()
53 int num_cols = a->num_cols(); in CompareMatrices() local
55 for (int i = 0; i < num_cols; ++i) { in CompareMatrices()
56 Vector x = Vector::Zero(num_cols); in CompareMatrices()
81 num_cols = tsm->num_cols(); in SetUp()
88 col_blocks->resize(num_cols); in SetUp()
93 int num_cols; member in ceres::internal::CompressedRowSparseMatrixTest
108 Vector b1 = Vector::Zero(num_cols); in TEST_F()
109 Vector b2 = Vector::Zero(num_cols); in TEST_F()
119 Vector b1 = Vector::Zero(num_cols); in TEST_F()
[all …]
Dblock_sparse_matrix_test.cc58 CHECK_EQ(A_->num_cols(), B_->num_cols()); in SetUp()
74 for (int i = 0; i < A_->num_cols(); ++i) { in TEST_F()
75 Vector x = Vector::Zero(A_->num_cols()); in TEST_F()
84 Vector y_a = Vector::Zero(A_->num_cols()); in TEST_F()
85 Vector y_b = Vector::Zero(A_->num_cols()); in TEST_F()
96 Vector y_a = Vector::Zero(A_->num_cols()); in TEST_F()
97 Vector y_b = Vector::Zero(A_->num_cols()); in TEST_F()
Ddense_qr_solver.cc72 const int num_cols = A->num_cols(); in SolveUsingLAPACK() local
115 VectorRef(x, num_cols) = rhs_.head(num_cols); in SolveUsingLAPACK()
130 const int num_cols = A->num_cols(); in SolveUsingEigen() local
140 num_rows + ((per_solve_options.D != NULL) ? num_cols : 0); in SolveUsingEigen()
149 VectorRef(x, num_cols) = A->matrix().householderQr().solve(rhs_); in SolveUsingEigen()
Dcorrector.cc119 const int num_cols, in CorrectJacobian() argument
127 VectorRef(jacobian, num_rows * num_cols) *= sqrt_rho1_; in CorrectJacobian()
143 for (int c = 0; c < num_cols; ++c) { in CorrectJacobian()
146 r_transpose_j += jacobian[r * num_cols + c] * residuals[r]; in CorrectJacobian()
150 jacobian[r * num_cols + c] = sqrt_rho1_ * in CorrectJacobian()
151 (jacobian[r * num_cols + c] - in CorrectJacobian()
Dschur_eliminator_test.cc139 const int num_cols = A->num_cols(); in EliminateSolveAndCompare() local
159 MatrixRef lhs_ref(lhs.mutable_values(), lhs.num_rows(), lhs.num_cols()); in EliminateSolveAndCompare()
167 Vector sol(num_cols); in EliminateSolveAndCompare()
198 Vector zero(A->num_cols()); in TEST_F()
201 ComputeReferenceSolution(VectorRef(zero.data(), A->num_cols())); in TEST_F()
202 EliminateSolveAndCompare(VectorRef(zero.data(), A->num_cols()), true, 1e-14); in TEST_F()
203 EliminateSolveAndCompare(VectorRef(zero.data(), A->num_cols()), false, 1e-14); in TEST_F()
205 ComputeReferenceSolution(VectorRef(D.get(), A->num_cols())); in TEST_F()
206 EliminateSolveAndCompare(VectorRef(D.get(), A->num_cols()), true, 1e-14); in TEST_F()
207 EliminateSolveAndCompare(VectorRef(D.get(), A->num_cols()), false, 1e-14); in TEST_F()
Dconjugate_gradients_solver.cc74 CHECK_EQ(A->num_rows(), A->num_cols()); in Solve()
81 const int num_cols = A->num_cols(); in Solve() local
82 VectorRef xref(x, num_cols); in Solve()
83 ConstVectorRef bref(b, num_cols); in Solve()
93 Vector r(num_cols); in Solve()
94 Vector p(num_cols); in Solve()
95 Vector z(num_cols); in Solve()
96 Vector tmp(num_cols); in Solve()
Dschur_complement_solver_test.cc58 num_cols = A->num_cols(); in SetUpFromProblemId()
62 x.reset(new double[num_cols]); in SetUpFromProblemId()
63 sol.reset(new double[num_cols]); in SetUpFromProblemId()
64 sol_d.reset(new double[num_cols]); in SetUpFromProblemId()
72 A->num_cols(), in SetUpFromProblemId()
116 for (int i = 0; i < num_cols; ++i) { in ComputeAndCompareSolutions()
120 for (int i = 0; i < num_cols; ++i) { in ComputeAndCompareSolutions()
127 int num_cols; member in ceres::internal::SchurComplementSolverTest
Dcovariance_impl.cc417 const int num_cols = jacobian.num_cols; in ComputeCovarianceValuesUsingSuiteSparseQR() local
420 vector<SuiteSparse_long> transpose_rows(num_cols + 1, 0); in ComputeCovarianceValuesUsingSuiteSparseQR()
449 cholmod_jacobian.ncol = num_cols; in ComputeCovarianceValuesUsingSuiteSparseQR()
504 vector<int> inverse_permutation(num_cols); in ComputeCovarianceValuesUsingSuiteSparseQR()
505 for (SuiteSparse_long i = 0; i < num_cols; ++i) { in ComputeCovarianceValuesUsingSuiteSparseQR()
523 scoped_array<double> workspace(new double[num_threads * num_cols]); in ComputeCovarianceValuesUsingSuiteSparseQR()
526 for (int r = 0; r < num_cols; ++r) { in ComputeCovarianceValuesUsingSuiteSparseQR()
539 double* solution = workspace.get() + thread_id * num_cols; in ComputeCovarianceValuesUsingSuiteSparseQR()
541 num_cols, in ComputeCovarianceValuesUsingSuiteSparseQR()
578 Matrix dense_jacobian(jacobian.num_rows, jacobian.num_cols); in ComputeCovarianceValuesUsingDenseSVD()
[all …]
Dpartitioned_matrix_view_test.cc58 num_cols_ = A_->num_cols(); in SetUp()
80 EXPECT_EQ(pmv_->num_cols(), A_->num_cols()); in TEST_F()
86 Vector x2(pmv_->num_cols()); in TEST_F()
106 Vector x2 = Vector::Zero(pmv_->num_cols()); in TEST_F()
130 Vector y = Vector::Zero(pmv_->num_cols()); in TEST_F()
138 for (int i = 0; i < pmv_->num_cols(); ++i) { in TEST_F()
151 EXPECT_EQ(block_diagonal_ee->num_cols(), 2); in TEST_F()
165 EXPECT_EQ(block_diagonal_ff->num_cols(), 3); in TEST_F()
Dblock_random_access_sparse_matrix.cc56 int num_cols = 0; in BlockRandomAccessSparseMatrix() local
59 col_layout.push_back(num_cols); in BlockRandomAccessSparseMatrix()
60 num_cols += blocks_[i]; in BlockRandomAccessSparseMatrix()
75 VLOG(1) << "Matrix Size [" << num_cols in BlockRandomAccessSparseMatrix()
76 << "," << num_cols in BlockRandomAccessSparseMatrix()
79 tsm_.reset(new TripletSparseMatrix(num_cols, num_cols, num_nonzeros)); in BlockRandomAccessSparseMatrix()
Dsparse_normal_cholesky_solver.cc84 const int num_cols = A->num_cols(); in SolveImpl() local
85 VectorRef(x, num_cols).setZero(); in SolveImpl()
97 per_solve_options.D, num_cols)); in SolveImpl()
119 A->DeleteRows(num_cols); in SolveImpl()
327 const int num_cols = A->num_cols(); in SolveImplUsingSuiteSparse()
362 cholmod_dense* rhs = ss_.CreateDenseVector(rhs_and_solution, num_cols, num_cols); in SolveImplUsingSuiteSparse()
368 memcpy(rhs_and_solution, solution->x, num_cols * sizeof(*rhs_and_solution)); in SolveImplUsingSuiteSparse()
/external/libjpeg-turbo/
Djdcol565.c28 JDIMENSION num_cols = cinfo->output_width; in LOCAL() local
57 num_cols--; in LOCAL()
59 for (col = 0; col < (num_cols >> 1); col++) { in LOCAL()
81 if (num_cols & 1) { in LOCAL()
107 JDIMENSION num_cols = cinfo->output_width; in LOCAL() local
138 num_cols--; in LOCAL()
140 for (col = 0; col < (num_cols >> 1); col++) { in LOCAL()
166 if (num_cols & 1) { in LOCAL()
191 JDIMENSION num_cols = cinfo->output_width; in LOCAL() local
210 num_cols--; in LOCAL()
[all …]
/external/libhevc/decoder/
Dihevcd_fmt_conv.c391 WORD32 num_rows, num_cols, src_strd, dst_strd; in ihevcd_fmt_conv_420sp_to_420sp() local
399 num_cols = wd; in ihevcd_fmt_conv_420sp_to_420sp()
406 memcpy(pu1_dst, pu1_src, num_cols); in ihevcd_fmt_conv_420sp_to_420sp()
416 num_cols = wd; in ihevcd_fmt_conv_420sp_to_420sp()
423 memcpy(pu1_dst, pu1_src, num_cols); in ihevcd_fmt_conv_420sp_to_420sp()
490 WORD32 num_rows, num_cols, src_strd, dst_strd; in ihevcd_fmt_conv_420sp_to_420sp_swap_uv() local
498 num_cols = wd; in ihevcd_fmt_conv_420sp_to_420sp_swap_uv()
505 memcpy(pu1_dst, pu1_src, num_cols); in ihevcd_fmt_conv_420sp_to_420sp_swap_uv()
515 num_cols = wd; in ihevcd_fmt_conv_420sp_to_420sp_swap_uv()
523 for(j = 0; j < num_cols; j += 2) in ihevcd_fmt_conv_420sp_to_420sp_swap_uv()
[all …]
/external/opencv3/3rdparty/libjpeg/
Djdcolor.c150 JDIMENSION num_cols = cinfo->output_width; in ycc_rgb_convert() local
165 for (col = 0; col < num_cols; col++) { in ycc_rgb_convert()
223 JDIMENSION num_cols = cinfo->output_width; in rgb_gray_convert() local
231 for (col = 0; col < num_cols; col++) { in rgb_gray_convert()
258 JDIMENSION num_cols = cinfo->output_width; in rgb1_rgb_convert() local
266 for (col = 0; col < num_cols; col++) { in rgb1_rgb_convert()
298 JDIMENSION num_cols = cinfo->output_width; in rgb1_gray_convert() local
306 for (col = 0; col < num_cols; col++) { in rgb1_gray_convert()
337 JDIMENSION num_cols = cinfo->output_width; in rgb_convert() local
345 for (col = 0; col < num_cols; col++) { in rgb_convert()
[all …]
Djccolor.c141 JDIMENSION num_cols = cinfo->image_width; in rgb_ycc_convert() local
149 for (col = 0; col < num_cols; col++) { in rgb_ycc_convert()
197 JDIMENSION num_cols = cinfo->image_width; in rgb_gray_convert() local
202 for (col = 0; col < num_cols; col++) { in rgb_gray_convert()
235 JDIMENSION num_cols = cinfo->image_width; in cmyk_ycck_convert() local
244 for (col = 0; col < num_cols; col++) { in cmyk_ycck_convert()
288 JDIMENSION num_cols = cinfo->image_width; in rgb_rgb1_convert() local
296 for (col = 0; col < num_cols; col++) { in rgb_rgb1_convert()
327 JDIMENSION num_cols = cinfo->image_width; in grayscale_convert() local
332 for (col = 0; col < num_cols; col++) { in grayscale_convert()
[all …]
/external/libhevc/decoder/x86/
Dihevcd_fmt_conv_ssse3_intr.c63 WORD32 num_rows, num_cols, src_strd, dst_strd, cols, rows; in ihevcd_fmt_conv_420sp_to_420p_ssse3() local
76 num_cols = wd; in ihevcd_fmt_conv_420sp_to_420p_ssse3()
82 memcpy(pu1_dst, pu1_src, num_cols); in ihevcd_fmt_conv_420sp_to_420p_ssse3()
119 num_cols = wd >> 1; in ihevcd_fmt_conv_420sp_to_420p_ssse3()
126 if(num_cols > 15) in ihevcd_fmt_conv_420sp_to_420p_ssse3()
128 cols = num_cols >> 4; in ihevcd_fmt_conv_420sp_to_420p_ssse3()
246 num_cols &= 0x0F; in ihevcd_fmt_conv_420sp_to_420p_ssse3()
248 if(num_cols) in ihevcd_fmt_conv_420sp_to_420p_ssse3()
256 for(j = 0; j < num_cols; j++) in ihevcd_fmt_conv_420sp_to_420p_ssse3()
/external/libavc/decoder/
Dih264d_format_conv.c385 WORD32 num_rows, num_cols, src_strd, dst_strd; in ih264d_fmt_conv_420sp_to_420sp() local
393 num_cols = wd; in ih264d_fmt_conv_420sp_to_420sp()
400 memcpy(pu1_dst, pu1_src, num_cols); in ih264d_fmt_conv_420sp_to_420sp()
410 num_cols = wd; in ih264d_fmt_conv_420sp_to_420sp()
417 memcpy(pu1_dst, pu1_src, num_cols); in ih264d_fmt_conv_420sp_to_420sp()
482 WORD32 num_rows, num_cols, src_strd, dst_strd; in ih264d_fmt_conv_420sp_to_420sp_swap_uv() local
490 num_cols = wd; in ih264d_fmt_conv_420sp_to_420sp_swap_uv()
497 memcpy(pu1_dst, pu1_src, num_cols); in ih264d_fmt_conv_420sp_to_420sp_swap_uv()
507 num_cols = wd; in ih264d_fmt_conv_420sp_to_420sp_swap_uv()
515 for(j = 0; j < num_cols; j += 2) in ih264d_fmt_conv_420sp_to_420sp_swap_uv()
[all …]

12345