HomeSort by relevance Sort by last modified time
    Searched full:schur (Results 1 - 25 of 59) sorted by null

1 2 3

  /external/eigen/doc/snippets/
ComplexSchur_compute.cpp 2 ComplexSchur<MatrixXcf> schur(4);
3 schur.compute(A);
4 cout << "The matrix T in the decomposition of A is:" << endl << schur.matrixT() << endl;
5 schur.compute(A.inverse());
6 cout << "The matrix T in the decomposition of A^(-1) is:" << endl << schur.matrixT() << endl;
RealSchur_compute.cpp 2 RealSchur<MatrixXf> schur(4);
3 schur.compute(A, /* computeU = */ false);
4 cout << "The matrix T in the decomposition of A is:" << endl << schur.matrixT() << endl;
5 schur.compute(A.inverse(), /* computeU = */ false);
6 cout << "The matrix T in the decomposition of A^(-1) is:" << endl << schur.matrixT() << endl;
RealSchur_RealSchur_MatrixType.cpp 4 RealSchur<MatrixXd> schur(A);
5 cout << "The orthogonal matrix U is:" << endl << schur.matrixU() << endl;
6 cout << "The quasi-triangular matrix T is:" << endl << schur.matrixT() << endl << endl;
8 MatrixXd U = schur.matrixU();
9 MatrixXd T = schur.matrixT();
  /external/ceres-solver/internal/ceres/
implicit_schur_complement.h 31 // An iterative solver for solving the Schur complement/reduced camera
50 // to the Schur complement without explicitly forming it.
64 // and the Schur complement system is given by
69 // is to form this Schur complement system and solve it using
73 // matrix vector product with the Schur complement
82 // auxilliary bits needed to implement a CG solver on the Schur
95 // should be computed or not as a preconditioner for the Schur
103 // Initialize the Schur complement for a linear least squares
115 // y += Sx, where S is the Schur complement.
118 // The Schur complement is a symmetric positive definite matrix
    [all...]
iterative_schur_complement_solver.h 56 // The key idea is that one can run Conjugate Gradients on the Schur
57 // Complement system without explicitly forming the Schur Complement
59 // ImplicitSchurComplement class. Not forming the Schur complement in
66 // For the curious, running CG on the Schur complement is the same as
schur_complement_solver.h 52 // Base class for Schur complement based linear least squares
84 // DenseSchurComplementSolver: For problems where the Schur complement
89 // SparseSchurComplementSolver: For problems where the Schur
92 // sparse Cholesky factorization of the Schur complement. This solver
166 // Size of the blocks in the Schur complement.
implicit_schur_complement_test.cc 139 // The i^th column of the implicit schur complement is the same as
140 // the explicit schur complement.
161 // Backsubstituted solution from the implicit schur solver using the
184 // Verify that the Schur Complement matrix implied by the
visibility_based_preconditioner.h 93 // entries in the Schur complement matrix corresponding to these
94 // camera pairs as an approximation to the full Schur complement.
147 // It has the same structural requirement as other Schur complement
212 // Number of parameter blocks in the schur complement.
216 // Sizes of the blocks in the schur complement.
222 // Non-zero camera pairs from the schur complement matrix that are
schur_eliminator.h 57 // class provides the functionality to compute the Schur complement
151 // be interested in all of the Schur Complement S. However, it is also
153 // the full Schur complement. When the eliminator is generating the
157 // is interested in constructing a preconditioner based on the Schur
177 // Compute the Schur complement system from the augmented linear
184 // the full or a submatrix of the Schur complement will be computed.
186 // Since the Schur complement is a symmetric matrix, only the upper
187 // triangular part of the Schur complement is computed.
implicit_schur_complement.cc 99 // Compute the RHS of the Schur complement system.
195 // corresponds to the Schur complement system, so we just copy those
196 // values from the solution to the Schur complement.
200 // Compute the RHS of the Schur complement system.
linear_least_squares_problems.h 54 // If using the schur eliminator then how many of the variable
iterative_schur_complement_solver.cc 75 // Initialize the solution to the Schur complement system to zero.
82 // Instantiate a conjugate gradient solver that runs on the Schur complement
partitioned_matrix_view.h 45 // structure as required by the Schur complement based solver, found
52 // the Schur complement solver it will result in unpredictable and
solver_impl.h 58 // and residuals eliminated, and in the case of automatic schur
89 // for the Schur eliminator.
visibility.cc 86 // cameras. However, to compute the sparsity structure of the Schur
144 VLOG(2) << "Schur complement graph time: " << (time(NULL) - start_time);
schur_eliminator_impl.h 177 // Add the diagonal to the schur complement.
252 // Schur complement (S += F'F).
277 // For rows with no e_blocks, the schur complement update reduces to
436 // contribution of its F blocks to the Schur complement, the
483 // Schur complement matrix, i.e
548 // which breaks schur elimination. Introducing a temporary by removing the
562 // For rows with no e_blocks, the schur complement update reduces to S
591 // A row r of A, which has no e_blocks gets added to the Schur
593 // the contribution of a single row r to the Schur complement. It is
solver_impl.cc 399 // Only Schur types require the lexicographic reordering.
541 *error = "The user requested the use of a Schur type solver. "
697 // ordering as it sees fit. For Schur type solvers, this means that
722 // If the user requested the use of a Schur type solver, and
729 // In such a case, the use of a Schur type solver is not possible,
    [all...]
  /external/eigen/test/
schur_complex.cpp 14 template<typename MatrixType> void schur(int size = MatrixType::ColsAtCompileTime) function
67 CALL_SUBTEST_1(( schur<Matrix4cd>() ));
68 CALL_SUBTEST_2(( schur<MatrixXcf>(internal::random<int>(1,EIGEN_TEST_MAX_SIZE/4)) ));
69 CALL_SUBTEST_3(( schur<Matrix<std::complex<float>, 1, 1> >() ));
70 CALL_SUBTEST_4(( schur<Matrix<float, 3, 3, Eigen::RowMajor> >() ));
schur_real.cpp 40 template<typename MatrixType> void schur(int size = MatrixType::ColsAtCompileTime) function
86 CALL_SUBTEST_1(( schur<Matrix4f>() ));
87 CALL_SUBTEST_2(( schur<MatrixXd>(internal::random<int>(1,EIGEN_TEST_MAX_SIZE/4)) ));
88 CALL_SUBTEST_3(( schur<Matrix<float, 1, 1> >() ));
89 CALL_SUBTEST_4(( schur<Matrix<double, 3, 3, Eigen::RowMajor> >() ));
  /external/eigen/Eigen/src/Eigenvalues/
ComplexSchur.h 28 * \brief Performs a complex Schur decomposition of a real or complex square matrix
31 * computing the Schur decomposition; this is expected to be an
35 * Schur decomposition: \f$ A = U T U^*\f$ where U is a unitary
40 * Call the function compute() to compute the Schur decomposition of
43 * the Schur decomposition at construction time. Once the
76 /** \brief Type for the matrices in the Schur decomposition.
85 * \param [in] size Positive integer, size of the matrix whose Schur decomposition will be computed.
102 /** \brief Constructor; computes Schur decomposition of given matrix.
104 * \param[in] matrix Square matrix whose Schur decomposition is to be computed.
107 * This constructor calls compute() to compute the Schur decomposition
    [all...]
RealSchur.h 23 * \brief Performs a real Schur decomposition of a square matrix
26 * real Schur decomposition; this is expected to be an instantiation of the
29 * Given a real square matrix A, this class computes the real Schur
36 * A, and thus the real Schur decomposition is used in EigenSolver to compute
39 * Call the function compute() to compute the real Schur decomposition of a
41 * constructor which computes the real Schur decomposition at construction
74 * \param [in] size Positive integer, size of the matrix whose Schur decomposition will be computed.
92 /** \brief Constructor; computes real Schur decomposition of given matrix.
94 * \param[in] matrix Square matrix whose Schur decomposition is to be computed.
97 * This constructor calls compute() to compute the Schur decomposition
    [all...]
ComplexEigenSolver.h 200 * The matrix is first reduced to Schur form using the
201 * ComplexSchur class. The Schur decomposition is then used to
205 * Schur decomposition, which is \f$ O(n^3) \f$ where \f$ n \f$
243 // Do a complex Schur decomposition, A = U T U^*
  /external/webrtc/src/common_audio/signal_processing/
auto_corr_to_refl_coef.c 83 // Last iteration; don't do Schur recursion.
87 // Schur recursion.
  /external/ceres-solver/docs/
changes.tex 10 options.ordering_type = ceres::SCHUR
65 \item Change LOG(ERROR) to LOG(WARNING) in \texttt{schur\_complement\_solver.cc}.
71 \item Schur ordering was operating on the wrong object (Ricardo Martin)
142 Schur eliminator.
147 \item Fix how static structure detection for the Schur eliminator logs
244 \item Fixed a strict weak ordering bug in the schur ordering.
  /external/eigen/unsupported/Eigen/
MatrixFunctions 183 This function computes the matrix logarithm using the Schur-Parlett
244 "A Schur-Parlett algorithm for computing matrix functions",
332 quasi-triangular form with the real Schur decomposition. The square
334 cost is approximately \f$ 25 n^3 \f$ real flops for the real Schur
354 complex Schur decomposition is used to reduce the matrix to a
356 &Aring;ke Bj&ouml;rck and Sven Hammarling, "A Schur method for the

Completed in 303 milliseconds

1 2 3