Remove \nonstable yet. The stability rules for Eigen3 are much simpler:

- all what's not in unsupported/ is considered stable API
    (except internal stuff e.g. expression templates).
This commit is contained in:
Benoit Jacob 2010-06-29 10:10:47 -04:00
parent 76152e9844
commit e5de9e5226
39 changed files with 51 additions and 54 deletions

View File

@ -9,7 +9,7 @@ namespace Eigen {
/** \defgroup Cholesky_Module Cholesky module /** \defgroup Cholesky_Module Cholesky module
* *
* \nonstableyet *
* *
* This module provides two variants of the Cholesky decomposition for selfadjoint (hermitian) matrices. * This module provides two variants of the Cholesky decomposition for selfadjoint (hermitian) matrices.
* Those decompositions are accessible via the following MatrixBase methods: * Those decompositions are accessible via the following MatrixBase methods:

View File

@ -14,7 +14,7 @@ namespace Eigen {
/** \defgroup Eigenvalues_Module Eigenvalues module /** \defgroup Eigenvalues_Module Eigenvalues module
* *
* \nonstableyet *
* *
* This module mainly provides various eigenvalue solvers. * This module mainly provides various eigenvalue solvers.
* This module also provides some MatrixBase methods, including: * This module also provides some MatrixBase methods, including:

View File

@ -17,7 +17,7 @@ namespace Eigen {
/** \defgroup Geometry_Module Geometry module /** \defgroup Geometry_Module Geometry module
* *
* \nonstableyet *
* *
* This module provides support for: * This module provides support for:
* - fixed-size homogeneous transformations * - fixed-size homogeneous transformations

View File

@ -13,7 +13,7 @@ namespace Eigen {
/** \defgroup QR_Module QR module /** \defgroup QR_Module QR module
* *
* \nonstableyet *
* *
* This module provides various QR decompositions * This module provides various QR decompositions
* This module also provides some MatrixBase methods, including: * This module also provides some MatrixBase methods, including:

View File

@ -11,7 +11,7 @@ namespace Eigen {
/** \defgroup SVD_Module SVD module /** \defgroup SVD_Module SVD module
* *
* \nonstableyet *
* *
* This module provides SVD decomposition for (currently) real matrices. * This module provides SVD decomposition for (currently) real matrices.
* This decomposition is accessible via the following MatrixBase method: * This decomposition is accessible via the following MatrixBase method:

View File

@ -15,7 +15,7 @@ namespace Eigen {
/** \defgroup Sparse_Module Sparse module /** \defgroup Sparse_Module Sparse module
* *
* \nonstableyet *
* *
* See the \ref TutorialSparse "Sparse tutorial" * See the \ref TutorialSparse "Sparse tutorial"
* *

View File

@ -25,7 +25,7 @@
#ifndef EIGEN_BANDMATRIX_H #ifndef EIGEN_BANDMATRIX_H
#define EIGEN_BANDMATRIX_H #define EIGEN_BANDMATRIX_H
/** \nonstableyet /**
* \class BandMatrix * \class BandMatrix
* *
* \brief Represents a rectangular matrix with a banded storage * \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; ei_variable_if_dynamic<Index, Subs> m_subs;
}; };
/** \nonstableyet /**
* \class TridiagonalMatrix * \class TridiagonalMatrix
* *
* \brief Represents a tridiagonal matrix * \brief Represents a tridiagonal matrix

View File

@ -25,7 +25,7 @@
#ifndef EIGEN_REPLICATE_H #ifndef EIGEN_REPLICATE_H
#define EIGEN_REPLICATE_H #define EIGEN_REPLICATE_H
/** \nonstableyet /**
* \class Replicate * \class Replicate
* *
* \brief Expression of the multiple replication of a matrix or vector * \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; const ei_variable_if_dynamic<Index, ColFactor> m_colFactor;
}; };
/** \nonstableyet /**
* \return an expression of the replication of \c *this * \return an expression of the replication of \c *this
* *
* Example: \include MatrixBase_replicate.cpp * Example: \include MatrixBase_replicate.cpp
@ -141,7 +141,7 @@ DenseBase<Derived>::replicate() const
return Replicate<Derived,RowFactor,ColFactor>(derived()); return Replicate<Derived,RowFactor,ColFactor>(derived());
} }
/** \nonstableyet /**
* \return an expression of the replication of \c *this * \return an expression of the replication of \c *this
* *
* Example: \include MatrixBase_replicate_int_int.cpp * 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); return Replicate<Derived,Dynamic,Dynamic>(derived(),rowFactor,colFactor);
} }
/** \nonstableyet /**
* \return an expression of the replication of each column (or row) of \c *this * \return an expression of the replication of each column (or row) of \c *this
* *
* Example: \include DirectionWise_replicate_int.cpp * Example: \include DirectionWise_replicate_int.cpp

View File

@ -26,7 +26,7 @@
#define EIGEN_SELFADJOINTMATRIX_H #define EIGEN_SELFADJOINTMATRIX_H
/** \class SelfAdjointView /** \class SelfAdjointView
* \nonstableyet *
* *
* \brief Expression of a selfadjoint matrix from a triangular part of a dense matrix * \brief Expression of a selfadjoint matrix from a triangular part of a dense matrix
* *

View File

@ -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 /** "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. * \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. * 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. /** \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. * 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 * The matrix \c *this must be triangular and invertible (i.e., all the coefficients of the

View File

@ -621,7 +621,7 @@ EIGEN_DEPRECATED TriangularView<Derived, Mode> MatrixBase<Derived>::part()
return derived(); return derived();
} }
/** \nonstableyet /**
* \returns an expression of a triangular view extracted from the current matrix * \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, * The parameter \a Mode can have the following values: \c Upper, \c StrictlyUpper, \c UnitUpper,

View File

@ -388,7 +388,7 @@ template<typename ExpressionType, int Direction> class VectorwiseOp
typedef Replicate<ExpressionType,Direction==Vertical?Dynamic:1,Direction==Horizontal?Dynamic:1> ReplicateReturnType; typedef Replicate<ExpressionType,Direction==Vertical?Dynamic:1,Direction==Horizontal?Dynamic:1> ReplicateReturnType;
const ReplicateReturnType replicate(Index factor) const; const ReplicateReturnType replicate(Index factor) const;
/** \nonstableyet /**
* \return an expression of the replication of each column (or row) of \c *this * \return an expression of the replication of each column (or row) of \c *this
* *
* Example: \include DirectionWise_replicate.cpp * Example: \include DirectionWise_replicate.cpp

View File

@ -25,7 +25,7 @@
#ifndef EIGEN_MINOR_H #ifndef EIGEN_MINOR_H
#define EIGEN_MINOR_H #define EIGEN_MINOR_H
/** \nonstableyet /**
* \class Minor * \class Minor
* *
* \brief Expression of a minor * \brief Expression of a minor
@ -96,7 +96,7 @@ template<typename MatrixType> class Minor
const Index m_row, m_col; const Index m_row, m_col;
}; };
/** \nonstableyet /**
* \return an expression of the (\a row, \a col)-minor of *this, * \return an expression of the (\a row, \a col)-minor of *this,
* i.e. an expression constructed from *this by removing the specified * i.e. an expression constructed from *this by removing the specified
* row and column. * row and column.
@ -113,7 +113,7 @@ MatrixBase<Derived>::minor(Index row, Index col)
return Minor<Derived>(derived(), row, col); return Minor<Derived>(derived(), row, col);
} }
/** \nonstableyet /**
* This is the const version of minor(). */ * This is the const version of minor(). */
template<typename Derived> template<typename Derived>
inline const Minor<Derived> inline const Minor<Derived>

View File

@ -31,7 +31,7 @@
#include "./ComplexSchur.h" #include "./ComplexSchur.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \class ComplexEigenSolver * \class ComplexEigenSolver
* *

View File

@ -33,7 +33,7 @@
template<typename MatrixType, bool IsComplex> struct ei_complex_schur_reduce_to_hessenberg; template<typename MatrixType, bool IsComplex> struct ei_complex_schur_reduce_to_hessenberg;
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \class ComplexSchur * \class ComplexSchur
* *

View File

@ -30,7 +30,7 @@
#include "./RealSchur.h" #include "./RealSchur.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \class EigenSolver * \class EigenSolver
* *

View File

@ -30,7 +30,7 @@
#include "./Tridiagonalization.h" #include "./Tridiagonalization.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \class GeneralizedSelfAdjointEigenSolver * \class GeneralizedSelfAdjointEigenSolver
* *

View File

@ -35,7 +35,7 @@ struct ei_traits<HessenbergDecompositionMatrixHReturnType<MatrixType> >
}; };
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \class HessenbergDecomposition * \class HessenbergDecomposition
* *
@ -324,7 +324,7 @@ void HessenbergDecomposition<MatrixType>::_compute(MatrixType& matA, CoeffVector
} }
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \brief Expression type for return value of HessenbergDecomposition::matrixH() * \brief Expression type for return value of HessenbergDecomposition::matrixH()
* *

View File

@ -30,7 +30,7 @@
#include "./HessenbergDecomposition.h" #include "./HessenbergDecomposition.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \class RealSchur * \class RealSchur
* *

View File

@ -30,7 +30,7 @@
#include "./Tridiagonalization.h" #include "./Tridiagonalization.h"
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \class SelfAdjointEigenSolver * \class SelfAdjointEigenSolver
* *

View File

@ -27,7 +27,7 @@
#define EIGEN_TRIDIAGONALIZATION_H #define EIGEN_TRIDIAGONALIZATION_H
/** \eigenvalues_module \ingroup Eigenvalues_Module /** \eigenvalues_module \ingroup Eigenvalues_Module
* \nonstableyet *
* *
* \class Tridiagonalization * \class Tridiagonalization
* *

View File

@ -26,7 +26,7 @@
#define EIGEN_ALIGNEDBOX_H #define EIGEN_ALIGNEDBOX_H
/** \geometry_module \ingroup Geometry_Module /** \geometry_module \ingroup Geometry_Module
* \nonstableyet *
* *
* \class AlignedBox * \class AlignedBox
* *

View File

@ -26,7 +26,7 @@
#define EIGEN_EULERANGLES_H #define EIGEN_EULERANGLES_H
/** \geometry_module \ingroup Geometry_Module /** \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) * \returns the Euler-angles of the rotation matrix \c *this using the convention defined by the triplet (\a a0,\a a1,\a a2)
* *

View File

@ -26,7 +26,7 @@
#define EIGEN_HOMOGENEOUS_H #define EIGEN_HOMOGENEOUS_H
/** \geometry_module \ingroup Geometry_Module /** \geometry_module \ingroup Geometry_Module
* \nonstableyet *
* \class Homogeneous * \class Homogeneous
* *
* \brief Expression of one (or a set of) homogeneous vector(s) * \brief Expression of one (or a set of) homogeneous vector(s)
@ -132,7 +132,7 @@ template<typename MatrixType,int _Direction> class Homogeneous
}; };
/** \geometry_module /** \geometry_module
* \nonstableyet *
* \return an expression of the equivalent homogeneous vector * \return an expression of the equivalent homogeneous vector
* *
* \vectoronly * \vectoronly
@ -151,7 +151,7 @@ MatrixBase<Derived>::homogeneous() const
} }
/** \geometry_module /** \geometry_module
* \nonstableyet *
* \returns a matrix expression of homogeneous column (or row) vectors * \returns a matrix expression of homogeneous column (or row) vectors
* *
* Example: \include VectorwiseOp_homogeneous.cpp * Example: \include VectorwiseOp_homogeneous.cpp
@ -166,7 +166,7 @@ VectorwiseOp<ExpressionType,Direction>::homogeneous() const
} }
/** \geometry_module /** \geometry_module
* \nonstableyet *
* \returns an expression of the homogeneous normalized vector of \c *this * \returns an expression of the homogeneous normalized vector of \c *this
* *
* Example: \include MatrixBase_hnormalized.cpp * Example: \include MatrixBase_hnormalized.cpp
@ -184,7 +184,7 @@ MatrixBase<Derived>::hnormalized() const
} }
/** \geometry_module /** \geometry_module
* \nonstableyet *
* \returns an expression of the homogeneous normalized vector of \c *this * \returns an expression of the homogeneous normalized vector of \c *this
* *
* Example: \include DirectionWise_hnormalized.cpp * Example: \include DirectionWise_hnormalized.cpp

View File

@ -278,7 +278,7 @@ typedef Quaternion<double> Quaterniond;
***************************************************************************/ ***************************************************************************/
/** \class Map<Quaternion> /** \class Map<Quaternion>
* \nonstableyet *
* *
* \brief Expression of a quaternion from a memory buffer * \brief Expression of a quaternion from a memory buffer
* *

View File

@ -823,7 +823,7 @@ inline Transform<Scalar,Dim,Mode> Transform<Scalar,Dim,Mode>::operator*(const Ro
************************/ ************************/
/** \returns the rotation part of the transformation /** \returns the rotation part of the transformation
* \nonstableyet *
* *
* \svd_module * \svd_module
* *
@ -844,7 +844,7 @@ Transform<Scalar,Dim,Mode>::rotation() const
* *
* If either pointer is zero, the corresponding computation is skipped. * If either pointer is zero, the corresponding computation is skipped.
* *
* \nonstableyet *
* *
* \svd_module * \svd_module
* *
@ -862,7 +862,7 @@ void Transform<Scalar,Dim,Mode>::computeRotationScaling(RotationMatrixType *rota
* *
* If either pointer is zero, the corresponding computation is skipped. * If either pointer is zero, the corresponding computation is skipped.
* *
* \nonstableyet *
* *
* \svd_module * \svd_module
* *
@ -909,7 +909,7 @@ struct ei_projective_transform_inverse<TransformType, Projective>
}; };
/** \nonstableyet /**
* *
* \returns the inverse transformation according to some given knowledge * \returns the inverse transformation according to some given knowledge
* on \c *this. * on \c *this.

View File

@ -27,7 +27,6 @@
#define EIGEN_COLPIVOTINGHOUSEHOLDERQR_H #define EIGEN_COLPIVOTINGHOUSEHOLDERQR_H
/** \ingroup QR_Module /** \ingroup QR_Module
* \nonstableyet
* *
* \class ColPivHouseholderQR * \class ColPivHouseholderQR
* *

View File

@ -27,7 +27,6 @@
#define EIGEN_FULLPIVOTINGHOUSEHOLDERQR_H #define EIGEN_FULLPIVOTINGHOUSEHOLDERQR_H
/** \ingroup QR_Module /** \ingroup QR_Module
* \nonstableyet
* *
* \class FullPivHouseholderQR * \class FullPivHouseholderQR
* *

View File

@ -28,7 +28,7 @@
#define EIGEN_QR_H #define EIGEN_QR_H
/** \ingroup QR_Module /** \ingroup QR_Module
* \nonstableyet *
* *
* \class HouseholderQR * \class HouseholderQR
* *

View File

@ -43,7 +43,7 @@ template<typename MatrixType, unsigned int Options,
struct ei_svd_precondition_if_more_cols_than_rows; struct ei_svd_precondition_if_more_cols_than_rows;
/** \ingroup SVD_Module /** \ingroup SVD_Module
* \nonstableyet *
* *
* \class JacobiSVD * \class JacobiSVD
* *

View File

@ -28,7 +28,7 @@
template<typename MatrixType, typename Rhs> struct ei_svd_solve_impl; template<typename MatrixType, typename Rhs> struct ei_svd_solve_impl;
/** \ingroup SVD_Module /** \ingroup SVD_Module
* \nonstableyet *
* *
* \class SVD * \class SVD
* *

View File

@ -26,7 +26,7 @@
#define EIGEN_SPARSE_SELFADJOINTVIEW_H #define EIGEN_SPARSE_SELFADJOINTVIEW_H
/** \class SparseSelfAdjointView /** \class SparseSelfAdjointView
* \nonstableyet *
* *
* \brief Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix. * \brief Pseudo expression to manipulate a triangular sparse matrix as a selfadjoint matrix.
* *

View File

@ -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>" \ "redstar=<a href='#warningarraymodule' style='color:red;text-decoration: none;'>*</a>" \
"matrixworld=<a href='#matrixonly' style='color:green;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>" \ "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_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_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." \ "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." \

View File

@ -15,7 +15,7 @@ namespace Eigen {
/** \defgroup CholmodSupport_Module Cholmod Support module /** \defgroup CholmodSupport_Module Cholmod Support module
* *
* \nonstableyet *
* *
* *
* \code * \code

View File

@ -21,7 +21,7 @@ namespace Eigen {
/** \ingroup Unsupported_modules /** \ingroup Unsupported_modules
* \defgroup Polynomials_Module Polynomials module * \defgroup Polynomials_Module Polynomials module
* *
* \nonstableyet *
* *
* \brief This module provides a QR based polynomial solver. * \brief This module provides a QR based polynomial solver.
* *

View File

@ -16,7 +16,7 @@ namespace Eigen {
/** \ingroup Unsupported_modules /** \ingroup Unsupported_modules
* \defgroup Skyline_Module Skyline module * \defgroup Skyline_Module Skyline module
* *
* \nonstableyet *
* *
* *
*/ */

View File

@ -28,7 +28,7 @@ namespace Eigen {
/** \defgroup SuperLUSupport_Module Super LU support /** \defgroup SuperLUSupport_Module Super LU support
* *
* \nonstableyet *
* *
* \code * \code
* #include <Eigen/SuperLUSupport> * #include <Eigen/SuperLUSupport>

View File

@ -30,7 +30,7 @@ namespace Eigen {
/** \defgroup TaucsSupport_Module Taucs support module /** \defgroup TaucsSupport_Module Taucs support module
* *
* \nonstableyet *
* *
* *
* \code * \code

View File

@ -11,7 +11,7 @@ namespace Eigen {
/** \defgroup Sparse_Module Sparse module /** \defgroup Sparse_Module Sparse module
* *
* \nonstableyet *
* *
* *
* \code * \code