aboutsummaryrefslogtreecommitdiffhomepage
diff options
context:
space:
mode:
-rw-r--r--Eigen/Cholesky2
-rw-r--r--Eigen/Eigenvalues2
-rw-r--r--Eigen/Geometry2
-rw-r--r--Eigen/QR2
-rw-r--r--Eigen/SVD2
-rw-r--r--Eigen/Sparse2
-rw-r--r--Eigen/src/Core/BandMatrix.h4
-rw-r--r--Eigen/src/Core/Replicate.h8
-rw-r--r--Eigen/src/Core/SelfAdjointView.h2
-rw-r--r--Eigen/src/Core/SolveTriangular.h4
-rw-r--r--Eigen/src/Core/TriangularMatrix.h2
-rw-r--r--Eigen/src/Core/VectorwiseOp.h2
-rw-r--r--Eigen/src/Eigen2Support/Minor.h6
-rw-r--r--Eigen/src/Eigenvalues/ComplexEigenSolver.h2
-rw-r--r--Eigen/src/Eigenvalues/ComplexSchur.h2
-rw-r--r--Eigen/src/Eigenvalues/EigenSolver.h2
-rw-r--r--Eigen/src/Eigenvalues/GeneralizedSelfAdjointEigenSolver.h2
-rw-r--r--Eigen/src/Eigenvalues/HessenbergDecomposition.h4
-rw-r--r--Eigen/src/Eigenvalues/RealSchur.h2
-rw-r--r--Eigen/src/Eigenvalues/SelfAdjointEigenSolver.h2
-rw-r--r--Eigen/src/Eigenvalues/Tridiagonalization.h2
-rw-r--r--Eigen/src/Geometry/AlignedBox.h2
-rw-r--r--Eigen/src/Geometry/EulerAngles.h2
-rw-r--r--Eigen/src/Geometry/Homogeneous.h10
-rw-r--r--Eigen/src/Geometry/Quaternion.h2
-rw-r--r--Eigen/src/Geometry/Transform.h8
-rw-r--r--Eigen/src/QR/ColPivHouseholderQR.h1
-rw-r--r--Eigen/src/QR/FullPivHouseholderQR.h1
-rw-r--r--Eigen/src/QR/HouseholderQR.h2
-rw-r--r--Eigen/src/SVD/JacobiSVD.h2
-rw-r--r--Eigen/src/SVD/SVD.h2
-rw-r--r--Eigen/src/Sparse/SparseSelfAdjointView.h2
-rw-r--r--doc/Doxyfile.in1
-rw-r--r--unsupported/Eigen/CholmodSupport2
-rw-r--r--unsupported/Eigen/Polynomials2
-rw-r--r--unsupported/Eigen/Skyline2
-rw-r--r--unsupported/Eigen/SuperLUSupport2
-rw-r--r--unsupported/Eigen/TaucsSupport2
-rw-r--r--unsupported/Eigen/UmfPackSupport2
39 files changed, 51 insertions, 54 deletions
diff --git a/Eigen/Cholesky b/Eigen/Cholesky
index 0a75159a1..b6c83e0ef 100644
--- a/Eigen/Cholesky
+++ b/Eigen/Cholesky
@@ -9,7 +9,7 @@ namespace Eigen {
/** \defgroup Cholesky_Module Cholesky module
*
- * \nonstableyet
+ *
*
* This module provides two variants of the Cholesky decomposition for selfadjoint (hermitian) matrices.
* Those decompositions are accessible via the following MatrixBase methods:
diff --git a/Eigen/Eigenvalues b/Eigen/Eigenvalues
index 381802cb5..de85fc5b9 100644
--- a/Eigen/Eigenvalues
+++ b/Eigen/Eigenvalues
@@ -14,7 +14,7 @@ namespace Eigen {
/** \defgroup Eigenvalues_Module Eigenvalues module
*
- * \nonstableyet
+ *
*
* This module mainly provides various eigenvalue solvers.
* This module also provides some MatrixBase methods, including:
diff --git a/Eigen/Geometry b/Eigen/Geometry
index 8c06fcd19..76e64aad0 100644
--- a/Eigen/Geometry
+++ b/Eigen/Geometry
@@ -17,7 +17,7 @@ namespace Eigen {
/** \defgroup Geometry_Module Geometry module
*
- * \nonstableyet
+ *
*
* This module provides support for:
* - fixed-size homogeneous transformations
diff --git a/Eigen/QR b/Eigen/QR
index d64f96002..fc3937114 100644
--- a/Eigen/QR
+++ b/Eigen/QR
@@ -13,7 +13,7 @@ namespace Eigen {
/** \defgroup QR_Module QR module
*
- * \nonstableyet
+ *
*
* This module provides various QR decompositions
* This module also provides some MatrixBase methods, including:
diff --git a/Eigen/SVD b/Eigen/SVD
index 0152b1e7e..4efc29e1f 100644
--- a/Eigen/SVD
+++ b/Eigen/SVD
@@ -11,7 +11,7 @@ namespace Eigen {
/** \defgroup SVD_Module SVD module
*
- * \nonstableyet
+ *
*
* This module provides SVD decomposition for (currently) real matrices.
* This decomposition is accessible via the following MatrixBase method:
diff --git a/Eigen/Sparse b/Eigen/Sparse
index 1167ce78f..ce6ef2f3c 100644
--- a/Eigen/Sparse
+++ b/Eigen/Sparse
@@ -15,7 +15,7 @@ namespace Eigen {
/** \defgroup Sparse_Module Sparse module
*
- * \nonstableyet
+ *
*
* See the \ref TutorialSparse "Sparse tutorial"
*
diff --git a/Eigen/src/Core/BandMatrix.h b/Eigen/src/Core/BandMatrix.h
index 5ced1f5f4..51b38aa7f 100644
--- a/Eigen/src/Core/BandMatrix.h
+++ b/Eigen/src/Core/BandMatrix.h
@@ -25,7 +25,7 @@
#ifndef EIGEN_BANDMATRIX_H
#define EIGEN_BANDMATRIX_H
-/** \nonstableyet
+/**
* \class BandMatrix
*
* \brief Represents a rectangular matrix with a banded storage
@@ -203,7 +203,7 @@ class BandMatrix : public EigenBase<BandMatrix<_Scalar,Rows,Cols,Supers,Subs,Opt
ei_variable_if_dynamic<Index, Subs> m_subs;
};
-/** \nonstableyet
+/**
* \class TridiagonalMatrix
*
* \brief Represents a tridiagonal matrix
diff --git a/Eigen/src/Core/Replicate.h b/Eigen/src/Core/Replicate.h
index 2f9355d33..23f02c2d9 100644
--- a/Eigen/src/Core/Replicate.h
+++ b/Eigen/src/Core/Replicate.h
@@ -25,7 +25,7 @@
#ifndef EIGEN_REPLICATE_H
#define EIGEN_REPLICATE_H
-/** \nonstableyet
+/**
* \class Replicate
*
* \brief Expression of the multiple replication of a matrix or vector
@@ -125,7 +125,7 @@ template<typename MatrixType,int RowFactor,int ColFactor> class Replicate
const ei_variable_if_dynamic<Index, ColFactor> m_colFactor;
};
-/** \nonstableyet
+/**
* \return an expression of the replication of \c *this
*
* Example: \include MatrixBase_replicate.cpp
@@ -141,7 +141,7 @@ DenseBase<Derived>::replicate() const
return Replicate<Derived,RowFactor,ColFactor>(derived());
}
-/** \nonstableyet
+/**
* \return an expression of the replication of \c *this
*
* Example: \include MatrixBase_replicate_int_int.cpp
@@ -156,7 +156,7 @@ DenseBase<Derived>::replicate(Index rowFactor,Index colFactor) const
return Replicate<Derived,Dynamic,Dynamic>(derived(),rowFactor,colFactor);
}
-/** \nonstableyet
+/**
* \return an expression of the replication of each column (or row) of \c *this
*
* Example: \include DirectionWise_replicate_int.cpp
diff --git a/Eigen/src/Core/SelfAdjointView.h b/Eigen/src/Core/SelfAdjointView.h
index e83e0be47..dadea9c09 100644
--- a/Eigen/src/Core/SelfAdjointView.h
+++ b/Eigen/src/Core/SelfAdjointView.h
@@ -26,7 +26,7 @@
#define EIGEN_SELFADJOINTMATRIX_H
/** \class SelfAdjointView
- * \nonstableyet
+ *
*
* \brief Expression of a selfadjoint matrix from a triangular part of a dense matrix
*
diff --git a/Eigen/src/Core/SolveTriangular.h b/Eigen/src/Core/SolveTriangular.h
index 362305303..310e262d8 100644
--- a/Eigen/src/Core/SolveTriangular.h
+++ b/Eigen/src/Core/SolveTriangular.h
@@ -234,7 +234,7 @@ struct ei_triangular_solver_selector<Lhs,Rhs,OnTheLeft,Mode,CompleteUnrolling,St
/** "in-place" version of TriangularView::solve() where the result is written in \a other
*
- * \nonstableyet
+ *
*
* \warning The parameter is only marked 'const' to make the C++ compiler accept a temporary expression here.
* This function will const_cast it, so constness isn't honored here.
@@ -265,7 +265,7 @@ void TriangularView<MatrixType,Mode>::solveInPlace(const MatrixBase<OtherDerived
/** \returns the product of the inverse of \c *this with \a other, \a *this being triangular.
*
- * \nonstableyet
+ *
*
* This function computes the inverse-matrix matrix product inverse(\c *this) * \a other.
* The matrix \c *this must be triangular and invertible (i.e., all the coefficients of the
diff --git a/Eigen/src/Core/TriangularMatrix.h b/Eigen/src/Core/TriangularMatrix.h
index 0953823be..a4d210cad 100644
--- a/Eigen/src/Core/TriangularMatrix.h
+++ b/Eigen/src/Core/TriangularMatrix.h
@@ -621,7 +621,7 @@ EIGEN_DEPRECATED TriangularView<Derived, Mode> MatrixBase<Derived>::part()
return derived();
}
-/** \nonstableyet
+/**
* \returns an expression of a triangular view extracted from the current matrix
*
* The parameter \a Mode can have the following values: \c Upper, \c StrictlyUpper, \c UnitUpper,
diff --git a/Eigen/src/Core/VectorwiseOp.h b/Eigen/src/Core/VectorwiseOp.h
index 757b610b0..93373b49b 100644
--- a/Eigen/src/Core/VectorwiseOp.h
+++ b/Eigen/src/Core/VectorwiseOp.h
@@ -388,7 +388,7 @@ template<typename ExpressionType, int Direction> class VectorwiseOp
typedef Replicate<ExpressionType,Direction==Vertical?Dynamic:1,Direction==Horizontal?Dynamic:1> ReplicateReturnType;
const ReplicateReturnType replicate(Index factor) const;
- /** \nonstableyet
+ /**
* \return an expression of the replication of each column (or row) of \c *this
*
* Example: \include DirectionWise_replicate.cpp
diff --git a/Eigen/src/Eigen2Support/Minor.h b/Eigen/src/Eigen2Support/Minor.h
index 3bf913b44..555d1d7f5 100644
--- a/Eigen/src/Eigen2Support/Minor.h
+++ b/Eigen/src/Eigen2Support/Minor.h
@@ -25,7 +25,7 @@
#ifndef EIGEN_MINOR_H
#define EIGEN_MINOR_H
-/** \nonstableyet
+/**
* \class Minor
*
* \brief Expression of a minor
@@ -96,7 +96,7 @@ template<typename MatrixType> class Minor
const Index m_row, m_col;
};
-/** \nonstableyet
+/**
* \return an expression of the (\a row, \a col)-minor of *this,
* i.e. an expression constructed from *this by removing the specified
* row and column.
@@ -113,7 +113,7 @@ MatrixBase<Derived>::minor(Index row, Index col)
return Minor<Derived>(derived(), row, col);
}
-/** \nonstableyet
+/**
* This is the const version of minor(). */
template<typename Derived>
inline const Minor<Derived>
diff --git a/Eigen/src/Eigenvalues/ComplexEigenSolver.h b/Eigen/src/Eigenvalues/ComplexEigenSolver.h
index 87b39ad64..08276c5c0 100644
--- a/Eigen/src/Eigenvalues/ComplexEigenSolver.h
+++ b/Eigen/src/Eigenvalues/ComplexEigenSolver.h
@@ -31,7 +31,7 @@
#include "./ComplexSchur.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \class ComplexEigenSolver
*
diff --git a/Eigen/src/Eigenvalues/ComplexSchur.h b/Eigen/src/Eigenvalues/ComplexSchur.h
index e5bf98098..edda4211b 100644
--- a/Eigen/src/Eigenvalues/ComplexSchur.h
+++ b/Eigen/src/Eigenvalues/ComplexSchur.h
@@ -33,7 +33,7 @@
template<typename MatrixType, bool IsComplex> struct ei_complex_schur_reduce_to_hessenberg;
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \class ComplexSchur
*
diff --git a/Eigen/src/Eigenvalues/EigenSolver.h b/Eigen/src/Eigenvalues/EigenSolver.h
index c3a88b220..0a5faec52 100644
--- a/Eigen/src/Eigenvalues/EigenSolver.h
+++ b/Eigen/src/Eigenvalues/EigenSolver.h
@@ -30,7 +30,7 @@
#include "./RealSchur.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \class EigenSolver
*
diff --git a/Eigen/src/Eigenvalues/GeneralizedSelfAdjointEigenSolver.h b/Eigen/src/Eigenvalues/GeneralizedSelfAdjointEigenSolver.h
index 229c3c28d..a47a3dc2e 100644
--- a/Eigen/src/Eigenvalues/GeneralizedSelfAdjointEigenSolver.h
+++ b/Eigen/src/Eigenvalues/GeneralizedSelfAdjointEigenSolver.h
@@ -30,7 +30,7 @@
#include "./Tridiagonalization.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \class GeneralizedSelfAdjointEigenSolver
*
diff --git a/Eigen/src/Eigenvalues/HessenbergDecomposition.h b/Eigen/src/Eigenvalues/HessenbergDecomposition.h
index 09b242356..0f2b78e27 100644
--- a/Eigen/src/Eigenvalues/HessenbergDecomposition.h
+++ b/Eigen/src/Eigenvalues/HessenbergDecomposition.h
@@ -35,7 +35,7 @@ struct ei_traits<HessenbergDecompositionMatrixHReturnType<MatrixType> >
};
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \class HessenbergDecomposition
*
@@ -324,7 +324,7 @@ void HessenbergDecomposition<MatrixType>::_compute(MatrixType& matA, CoeffVector
}
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \brief Expression type for return value of HessenbergDecomposition::matrixH()
*
diff --git a/Eigen/src/Eigenvalues/RealSchur.h b/Eigen/src/Eigenvalues/RealSchur.h
index 35864ec38..eb713339b 100644
--- a/Eigen/src/Eigenvalues/RealSchur.h
+++ b/Eigen/src/Eigenvalues/RealSchur.h
@@ -30,7 +30,7 @@
#include "./HessenbergDecomposition.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \class RealSchur
*
diff --git a/Eigen/src/Eigenvalues/SelfAdjointEigenSolver.h b/Eigen/src/Eigenvalues/SelfAdjointEigenSolver.h
index 872eb981c..f14baa333 100644
--- a/Eigen/src/Eigenvalues/SelfAdjointEigenSolver.h
+++ b/Eigen/src/Eigenvalues/SelfAdjointEigenSolver.h
@@ -30,7 +30,7 @@
#include "./Tridiagonalization.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \class SelfAdjointEigenSolver
*
diff --git a/Eigen/src/Eigenvalues/Tridiagonalization.h b/Eigen/src/Eigenvalues/Tridiagonalization.h
index 15490ad06..611b89730 100644
--- a/Eigen/src/Eigenvalues/Tridiagonalization.h
+++ b/Eigen/src/Eigenvalues/Tridiagonalization.h
@@ -27,7 +27,7 @@
#define EIGEN_TRIDIAGONALIZATION_H
/** \eigenvalues_module \ingroup Eigenvalues_Module
- * \nonstableyet
+ *
*
* \class Tridiagonalization
*
diff --git a/Eigen/src/Geometry/AlignedBox.h b/Eigen/src/Geometry/AlignedBox.h
index 1480690f7..196a4fc72 100644
--- a/Eigen/src/Geometry/AlignedBox.h
+++ b/Eigen/src/Geometry/AlignedBox.h
@@ -26,7 +26,7 @@
#define EIGEN_ALIGNEDBOX_H
/** \geometry_module \ingroup Geometry_Module
- * \nonstableyet
+ *
*
* \class AlignedBox
*
diff --git a/Eigen/src/Geometry/EulerAngles.h b/Eigen/src/Geometry/EulerAngles.h
index 15e8eac19..f2b3f129e 100644
--- a/Eigen/src/Geometry/EulerAngles.h
+++ b/Eigen/src/Geometry/EulerAngles.h
@@ -26,7 +26,7 @@
#define EIGEN_EULERANGLES_H
/** \geometry_module \ingroup Geometry_Module
- * \nonstableyet
+ *
*
* \returns the Euler-angles of the rotation matrix \c *this using the convention defined by the triplet (\a a0,\a a1,\a a2)
*
diff --git a/Eigen/src/Geometry/Homogeneous.h b/Eigen/src/Geometry/Homogeneous.h
index 7e15dda61..73266320e 100644
--- a/Eigen/src/Geometry/Homogeneous.h
+++ b/Eigen/src/Geometry/Homogeneous.h
@@ -26,7 +26,7 @@
#define EIGEN_HOMOGENEOUS_H
/** \geometry_module \ingroup Geometry_Module
- * \nonstableyet
+ *
* \class Homogeneous
*
* \brief Expression of one (or a set of) homogeneous vector(s)
@@ -132,7 +132,7 @@ template<typename MatrixType,int _Direction> class Homogeneous
};
/** \geometry_module
- * \nonstableyet
+ *
* \return an expression of the equivalent homogeneous vector
*
* \vectoronly
@@ -151,7 +151,7 @@ MatrixBase<Derived>::homogeneous() const
}
/** \geometry_module
- * \nonstableyet
+ *
* \returns a matrix expression of homogeneous column (or row) vectors
*
* Example: \include VectorwiseOp_homogeneous.cpp
@@ -166,7 +166,7 @@ VectorwiseOp<ExpressionType,Direction>::homogeneous() const
}
/** \geometry_module
- * \nonstableyet
+ *
* \returns an expression of the homogeneous normalized vector of \c *this
*
* Example: \include MatrixBase_hnormalized.cpp
@@ -184,7 +184,7 @@ MatrixBase<Derived>::hnormalized() const
}
/** \geometry_module
- * \nonstableyet
+ *
* \returns an expression of the homogeneous normalized vector of \c *this
*
* Example: \include DirectionWise_hnormalized.cpp
diff --git a/Eigen/src/Geometry/Quaternion.h b/Eigen/src/Geometry/Quaternion.h
index e0308a02e..355b12ce8 100644
--- a/Eigen/src/Geometry/Quaternion.h
+++ b/Eigen/src/Geometry/Quaternion.h
@@ -278,7 +278,7 @@ typedef Quaternion<double> Quaterniond;
***************************************************************************/
/** \class Map<Quaternion>
- * \nonstableyet
+ *
*
* \brief Expression of a quaternion from a memory buffer
*
diff --git a/Eigen/src/Geometry/Transform.h b/Eigen/src/Geometry/Transform.h
index da1e0b377..bc9ccb3e6 100644
--- a/Eigen/src/Geometry/Transform.h
+++ b/Eigen/src/Geometry/Transform.h
@@ -823,7 +823,7 @@ inline Transform<Scalar,Dim,Mode> Transform<Scalar,Dim,Mode>::operator*(const Ro
************************/
/** \returns the rotation part of the transformation
- * \nonstableyet
+ *
*
* \svd_module
*
@@ -844,7 +844,7 @@ Transform<Scalar,Dim,Mode>::rotation() const
*
* If either pointer is zero, the corresponding computation is skipped.
*
- * \nonstableyet
+ *
*
* \svd_module
*
@@ -862,7 +862,7 @@ void Transform<Scalar,Dim,Mode>::computeRotationScaling(RotationMatrixType *rota
*
* If either pointer is zero, the corresponding computation is skipped.
*
- * \nonstableyet
+ *
*
* \svd_module
*
@@ -909,7 +909,7 @@ struct ei_projective_transform_inverse<TransformType, Projective>
};
-/** \nonstableyet
+/**
*
* \returns the inverse transformation according to some given knowledge
* on \c *this.
diff --git a/Eigen/src/QR/ColPivHouseholderQR.h b/Eigen/src/QR/ColPivHouseholderQR.h
index df6dea206..cab13ff0d 100644
--- a/Eigen/src/QR/ColPivHouseholderQR.h
+++ b/Eigen/src/QR/ColPivHouseholderQR.h
@@ -27,7 +27,6 @@
#define EIGEN_COLPIVOTINGHOUSEHOLDERQR_H
/** \ingroup QR_Module
- * \nonstableyet
*
* \class ColPivHouseholderQR
*
diff --git a/Eigen/src/QR/FullPivHouseholderQR.h b/Eigen/src/QR/FullPivHouseholderQR.h
index 98a6ae650..201d63128 100644
--- a/Eigen/src/QR/FullPivHouseholderQR.h
+++ b/Eigen/src/QR/FullPivHouseholderQR.h
@@ -27,7 +27,6 @@
#define EIGEN_FULLPIVOTINGHOUSEHOLDERQR_H
/** \ingroup QR_Module
- * \nonstableyet
*
* \class FullPivHouseholderQR
*
diff --git a/Eigen/src/QR/HouseholderQR.h b/Eigen/src/QR/HouseholderQR.h
index 408d5ee79..fe316d2ee 100644
--- a/Eigen/src/QR/HouseholderQR.h
+++ b/Eigen/src/QR/HouseholderQR.h
@@ -28,7 +28,7 @@
#define EIGEN_QR_H
/** \ingroup QR_Module
- * \nonstableyet
+ *
*
* \class HouseholderQR
*
diff --git a/Eigen/src/SVD/JacobiSVD.h b/Eigen/src/SVD/JacobiSVD.h
index 672fcbff9..8ee0269b1 100644
--- a/Eigen/src/SVD/JacobiSVD.h
+++ b/Eigen/src/SVD/JacobiSVD.h
@@ -43,7 +43,7 @@ template<typename MatrixType, unsigned int Options,
struct ei_svd_precondition_if_more_cols_than_rows;
/** \ingroup SVD_Module
- * \nonstableyet
+ *
*
* \class JacobiSVD
*
diff --git a/Eigen/src/SVD/SVD.h b/Eigen/src/SVD/SVD.h
index 967659d29..76c1995b8 100644
--- a/Eigen/src/SVD/SVD.h
+++ b/Eigen/src/SVD/SVD.h
@@ -28,7 +28,7 @@
template<typename MatrixType, typename Rhs> struct ei_svd_solve_impl;
/** \ingroup SVD_Module
- * \nonstableyet
+ *
*
* \class SVD
*
diff --git a/Eigen/src/Sparse/SparseSelfAdjointView.h b/Eigen/src/Sparse/SparseSelfAdjointView.h
index fb95ec1ca..dd4d925e1 100644
--- a/Eigen/src/Sparse/SparseSelfAdjointView.h
+++ b/Eigen/src/Sparse/SparseSelfAdjointView.h
@@ -26,7 +26,7 @@
#define EIGEN_SPARSE_SELFADJOINTVIEW_H
/** \class SparseSelfAdjointView
- * \nonstableyet
+ *
*
* \brief Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix.
*
diff --git a/doc/Doxyfile.in b/doc/Doxyfile.in
index c44cfabe9..855130485 100644
--- a/doc/Doxyfile.in
+++ b/doc/Doxyfile.in
@@ -209,7 +209,6 @@ ALIASES = "only_for_vectors=This is only for vectors (either row-
"redstar=<a href='#warningarraymodule' style='color:red;text-decoration: none;'>*</a>" \
"matrixworld=<a href='#matrixonly' style='color:green;text-decoration: none;'>*</a>" \
"arrayworld=<a href='#arrayonly' style='color:blue;text-decoration: none;'>*</a>" \
- "nonstableyet=\warning This is not considered to be part of the stable public API yet. Changes may happen in future releases. See \ref Experimental \"Experimental parts of Eigen\"" \
"note_about_arbitrary_choice_of_solution=If there exists more than one solution, this method will arbitrarily choose one." \
"note_about_using_kernel_to_study_multiple_solutions=If you need a complete analysis of the space of solutions, take the one solution obtained by this method and add to it elements of the kernel, as determined by kernel()." \
"note_about_checking_solutions=This method just tries to find as good a solution as possible. If you want to check whether a solution exists or if it is accurate, just call this function to get a result and then compute the error of this result, or use MatrixBase::isApprox() directly, for instance like this: \code bool a_solution_exists = (A*result).isApprox(b, precision); \endcode This method avoids dividing by zero, so that the non-existence of a solution doesn't by itself mean that you'll get \c inf or \c nan values." \
diff --git a/unsupported/Eigen/CholmodSupport b/unsupported/Eigen/CholmodSupport
index e1c50e536..92cd3cfae 100644
--- a/unsupported/Eigen/CholmodSupport
+++ b/unsupported/Eigen/CholmodSupport
@@ -15,7 +15,7 @@ namespace Eigen {
/** \defgroup CholmodSupport_Module Cholmod Support module
*
- * \nonstableyet
+ *
*
*
* \code
diff --git a/unsupported/Eigen/Polynomials b/unsupported/Eigen/Polynomials
index d69abb1be..e64377481 100644
--- a/unsupported/Eigen/Polynomials
+++ b/unsupported/Eigen/Polynomials
@@ -21,7 +21,7 @@ namespace Eigen {
/** \ingroup Unsupported_modules
* \defgroup Polynomials_Module Polynomials module
*
- * \nonstableyet
+ *
*
* \brief This module provides a QR based polynomial solver.
*
diff --git a/unsupported/Eigen/Skyline b/unsupported/Eigen/Skyline
index c904c9cf7..5e080330c 100644
--- a/unsupported/Eigen/Skyline
+++ b/unsupported/Eigen/Skyline
@@ -16,7 +16,7 @@ namespace Eigen {
/** \ingroup Unsupported_modules
* \defgroup Skyline_Module Skyline module
*
- * \nonstableyet
+ *
*
*
*/
diff --git a/unsupported/Eigen/SuperLUSupport b/unsupported/Eigen/SuperLUSupport
index 6a2a3b15a..011532635 100644
--- a/unsupported/Eigen/SuperLUSupport
+++ b/unsupported/Eigen/SuperLUSupport
@@ -28,7 +28,7 @@ namespace Eigen {
/** \defgroup SuperLUSupport_Module Super LU support
*
- * \nonstableyet
+ *
*
* \code
* #include <Eigen/SuperLUSupport>
diff --git a/unsupported/Eigen/TaucsSupport b/unsupported/Eigen/TaucsSupport
index 93e4bd7aa..5867ab96b 100644
--- a/unsupported/Eigen/TaucsSupport
+++ b/unsupported/Eigen/TaucsSupport
@@ -30,7 +30,7 @@ namespace Eigen {
/** \defgroup TaucsSupport_Module Taucs support module
*
- * \nonstableyet
+ *
*
*
* \code
diff --git a/unsupported/Eigen/UmfPackSupport b/unsupported/Eigen/UmfPackSupport
index 6fcf40ec0..df25a080c 100644
--- a/unsupported/Eigen/UmfPackSupport
+++ b/unsupported/Eigen/UmfPackSupport
@@ -11,7 +11,7 @@ namespace Eigen {
/** \defgroup Sparse_Module Sparse module
*
- * \nonstableyet
+ *
*
*
* \code