Home
last modified time | relevance | path

Searched refs:svd (Results 1 – 25 of 35) sorted by relevance

12

/external/eigen/Eigen/src/SVD/
DJacobiSVD.h76 void allocate(const JacobiSVD<MatrixType, FullPivHouseholderQRPreconditioner>& svd) in allocate() argument
78 if (svd.rows() != m_qr.rows() || svd.cols() != m_qr.cols()) in allocate()
81 ::new (&m_qr) QRType(svd.rows(), svd.cols()); in allocate()
83 if (svd.m_computeFullU) m_workspace.resize(svd.rows()); in allocate()
86 bool run(JacobiSVD<MatrixType, FullPivHouseholderQRPreconditioner>& svd, const MatrixType& matrix) in run() argument
91svd.m_workMatrix = m_qr.matrixQR().block(0,0,matrix.cols(),matrix.cols()).template triangularView<… in run()
92 if(svd.m_computeFullU) m_qr.matrixQ().evalTo(svd.m_matrixU, m_workspace); in run()
93 if(svd.computeV()) svd.m_matrixV = m_qr.colsPermutation(); in run()
122 void allocate(const JacobiSVD<MatrixType, FullPivHouseholderQRPreconditioner>& svd) in allocate() argument
124 if (svd.cols() != m_qr.rows() || svd.rows() != m_qr.cols()) in allocate()
[all …]
/external/eigen/test/
Dsvd_common.h24 void svd_check_full(const MatrixType& m, const SvdType& svd) in svd_check_full() argument
41 sigma.diagonal() = svd.singularValues().template cast<Scalar>(); in svd_check_full()
42 MatrixUType u = svd.matrixU(); in svd_check_full()
43 MatrixVType v = svd.matrixV(); in svd_check_full()
69 SvdType svd(m, computationOptions); in svd_compare_to_full()
71 VERIFY_IS_APPROX(svd.singularValues(), referenceSvd.singularValues()); in svd_compare_to_full()
75 VERIFY( (svd.matrixV().adjoint()*svd.matrixV()).isIdentity(prec) ); in svd_compare_to_full()
76 …VERIFY_IS_APPROX( svd.matrixV().leftCols(diagSize) * svd.singularValues().asDiagonal() * svd.matri… in svd_compare_to_full()
82 VERIFY( (svd.matrixU().adjoint()*svd.matrixU()).isIdentity(prec) ); in svd_compare_to_full()
83 …VERIFY_IS_APPROX( svd.matrixU().leftCols(diagSize) * svd.singularValues().cwiseAbs2().asDiagonal()… in svd_compare_to_full()
[all …]
Dqr_colpivoting.cpp57 JacobiSVD<MatrixType> svd(matrix, ComputeThinU | ComputeThinV); in cod() local
58 MatrixType svd_solution = svd.solve(rhs); in cod()
89 JacobiSVD<MatrixType> svd(matrix, ComputeFullU | ComputeFullV); in cod_fixedsize() local
90 Matrix<Scalar, Cols, Cols2> svd_solution = svd.solve(rhs); in cod_fixedsize()
/external/eigen/lapack/
Dsvd.cpp56 BDCSVD<PlainMatrixType> svd(mat,option);
58 make_vector(s,diag_size) = svd.singularValues().head(diag_size);
62 matrix(u,*m,*m,*ldu) = svd.matrixU();
63 matrix(vt,*n,*n,*ldvt) = svd.matrixV().adjoint();
67 matrix(u,*m,diag_size,*ldu) = svd.matrixU();
68 matrix(vt,diag_size,*n,*ldvt) = svd.matrixV().adjoint();
72 matrix(a,*m,*n,*lda) = svd.matrixU();
73 matrix(vt,*n,*n,*ldvt) = svd.matrixV().adjoint();
77 matrix(u,*m,*m,*ldu) = svd.matrixU();
78 matrix(a,diag_size,*n,*lda) = svd.matrixV().adjoint();
[all …]
DCMakeLists.txt171 add_lapack_test(ssvd.out svd.in xeigtsts)
238 add_lapack_test(dsvd.out svd.in xeigtstd)
303 add_lapack_test(csvd.out svd.in xeigtstc)
370 add_lapack_test(zsvd.out svd.in xeigtstz)
/external/eigen/doc/snippets/
DJacobiSVD_basic.cpp3 JacobiSVD<MatrixXf> svd(m, ComputeThinU | ComputeThinV); variable
4 cout << "Its singular values are:" << endl << svd.singularValues() << endl;
5 cout << "Its left singular vectors are the columns of the thin U matrix:" << endl << svd.matrixU() …
6 cout << "Its right singular vectors are the columns of the thin V matrix:" << endl << svd.matrixV()…
9 cout << "A least-squares solution of m*x = rhs is:" << endl << svd.solve(rhs) << endl;
/external/eigen/Eigen/src/Geometry/
DUmeyama.h131 JacobiSVD<MatrixType> svd(sigma, ComputeFullU | ComputeFullV);
139 if ( svd.matrixU().determinant() * svd.matrixV().determinant() < 0 )
143 Rt.block(0,0,m,m).noalias() = svd.matrixU() * S.asDiagonal() * svd.matrixV().transpose();
148 const Scalar c = Scalar(1)/src_var * svd.singularValues().dot(S);
DTransform.h1081 JacobiSVD<LinearMatrixType> svd(linear(), ComputeFullU | ComputeFullV);
1083 Scalar x = (svd.matrixU() * svd.matrixV().adjoint()).determinant(); // so x has absolute value 1
1084 VectorType sv(svd.singularValues());
1086 if(scaling) scaling->lazyAssign(svd.matrixV() * sv.asDiagonal() * svd.matrixV().adjoint());
1089 LinearMatrixType m(svd.matrixU());
1091 rotation->lazyAssign(m * svd.matrixV().adjoint());
1110 JacobiSVD<LinearMatrixType> svd(linear(), ComputeFullU | ComputeFullV);
1112 Scalar x = (svd.matrixU() * svd.matrixV().adjoint()).determinant(); // so x has absolute value 1
1113 VectorType sv(svd.singularValues());
1115 if(scaling) scaling->lazyAssign(svd.matrixU() * sv.asDiagonal() * svd.matrixU().adjoint());
[all …]
DHyperplane.h109 JacobiSVD<Matrix<Scalar,2,3> > svd(m, ComputeFullV); in Through()
110 result.normal() = svd.matrixV().col(2); in Through()
DQuaternion.h596 JacobiSVD<Matrix<Scalar,2,3> > svd(m, ComputeFullV);
597 Vector3 axis = svd.matrixV().col(2);
/external/tensorflow/tensorflow/python/kernel_tests/
Dsvd_op_test.py46 linalg_ops.svd(scalar)
50 linalg_ops.svd(vector)
60 s1, u1, v1 = linalg_ops.svd(
62 s2, u2, v2 = linalg_ops.svd(
66 s1 = linalg_ops.svd(
68 s2 = linalg_ops.svd(
150 s_tf, u_tf, v_tf = linalg_ops.svd(
158 s_tf = linalg_ops.svd(
166 u_np, s_np, v_np = np.linalg.svd(
169 s_np = np.linalg.svd(
[all …]
/external/tensorflow/tensorflow/core/kernels/
Dsvd_op_impl.h88 Eigen::BDCSVD<Matrix> svd(inputs[0], options); in ComputeMatrix()
89 outputs->at(0) = svd.singularValues().template cast<Scalar>(); in ComputeMatrix()
91 outputs->at(1) = svd.matrixU(); in ComputeMatrix()
92 outputs->at(2) = svd.matrixV(); in ComputeMatrix()
/external/tensorflow/tensorflow/python/ops/linalg/
Dlinalg_impl.py51 svd = linalg_ops.svd variable
/external/tensorflow/tensorflow/core/api_def/base_api/
Dapi_def_Svd.pbtxt58 s, u, v = svd(a)
59 s, _, _ = svd(a, compute_uv=False)
/external/tensorflow/tensorflow/tools/compatibility/testdata/
Dtest_file_v0_11.py174 tf.svd(mat, False, True).eval(),
175 tf.svd(mat, compute_uv=False, full_matrices=True).eval())
/external/eigen/doc/
DUsingBlasLapackBackends.dox104 JacobiSVD<MatrixXd> svd;
105 svd.compute(m1, ComputeThinV);
DAsciiQuickReference.txt202 x = A.svd() .solve(b)); // Stable, slowest. #include <Eigen/SVD>
207 // .svd() -> .matrixU(), .singularValues(), and .matrixV()
/external/tensorflow/tensorflow/docs_src/install/
Dmigration.md263 * `tf.svd`
264 …* arguments have been reordered to `tf.svd(tensor, full_matrices=False, compute_uv=True, name=None…
311 * should be renamed to `tf.svd`
/external/tensorflow/tensorflow/tools/api/golden/
Dtensorflow.linalg.pbtxt120 name: "svd"
/external/tensorflow/tensorflow/contrib/gan/python/eval/python/
Dsliced_wasserstein_impl.py190 sig, u = linalg_ops.svd(array_ops.concat([a, b], 0))[:2]
Dclassifier_metrics_impl.py102 s, u, v = linalg_ops.svd(mat)
/external/tensorflow/tensorflow/docs_src/api_guides/python/
Dmath_ops.md106 * @{tf.svd}
/external/tensorflow/tensorflow/python/ops/
Dlinalg_ops.py378 def svd(tensor, full_matrices=False, compute_uv=True, name=None): function
Dlinalg_grad.py283 s, u, v = linalg_ops.svd(a, compute_uv=True)
/external/tensorflow/tensorflow/contrib/kfac/python/ops/
Dutils.py217 evals, evecs, _ = linalg_ops.svd(mat)

12