aboutsummaryrefslogtreecommitdiffhomepage
path: root/unsupported
diff options
context:
space:
mode:
authorGravatar Jitse Niesen <jitse@maths.leeds.ac.uk>2012-04-15 11:06:28 +0100
committerGravatar Jitse Niesen <jitse@maths.leeds.ac.uk>2012-04-15 11:06:28 +0100
commit3c412183b2d4a131239275f440d15677cc5649b0 (patch)
tree42784a65d3ad0cc4fb912032ecdf9059aad5eb7a /unsupported
parent84c93b048ecab7c22291503e68c47b6e3264fbb0 (diff)
Get rid of include directives inside namespace blocks (bug #339).
Diffstat (limited to 'unsupported')
-rw-r--r--unsupported/Eigen/BVH5
-rw-r--r--unsupported/Eigen/FFT6
-rw-r--r--unsupported/Eigen/IterativeSolvers4
-rw-r--r--unsupported/Eigen/KroneckerProduct4
-rw-r--r--unsupported/Eigen/MatrixFunctions4
-rw-r--r--unsupported/Eigen/MoreVectorization4
-rw-r--r--unsupported/Eigen/NonLinearOptimization5
-rw-r--r--unsupported/Eigen/NumericalDiff3
-rw-r--r--unsupported/Eigen/Polynomials4
-rw-r--r--unsupported/Eigen/Skyline18
-rw-r--r--unsupported/Eigen/SparseExtra3
-rw-r--r--unsupported/Eigen/Splines6
-rw-r--r--unsupported/Eigen/src/BVH/BVAlgorithms.h4
-rw-r--r--unsupported/Eigen/src/BVH/KdBVH.h4
-rw-r--r--unsupported/Eigen/src/FFT/ei_fftw_impl.h4
-rw-r--r--unsupported/Eigen/src/FFT/ei_kissfft_impl.h5
-rw-r--r--unsupported/Eigen/src/IterativeSolvers/ConstrainedConjGrad.h4
-rw-r--r--unsupported/Eigen/src/IterativeSolvers/GMRES.h6
-rw-r--r--unsupported/Eigen/src/IterativeSolvers/IncompleteLU.h6
-rw-r--r--unsupported/Eigen/src/IterativeSolvers/IterationController.h4
-rw-r--r--unsupported/Eigen/src/KroneckerProduct/KroneckerTensorProduct.h4
-rw-r--r--unsupported/Eigen/src/MatrixFunctions/MatrixExponential.h4
-rw-r--r--unsupported/Eigen/src/MatrixFunctions/MatrixFunction.h4
-rw-r--r--unsupported/Eigen/src/MatrixFunctions/MatrixFunctionAtomic.h4
-rw-r--r--unsupported/Eigen/src/MatrixFunctions/MatrixLogarithm.h4
-rw-r--r--unsupported/Eigen/src/MatrixFunctions/MatrixSquareRoot.h4
-rw-r--r--unsupported/Eigen/src/MatrixFunctions/StemFunction.h4
-rw-r--r--unsupported/Eigen/src/MoreVectorization/MathFunctions.h6
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/HybridNonLinearSolver.h6
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/LevenbergMarquardt.h5
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/chkder.h3
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/covar.h4
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/dogleg.h4
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/fdjac1.h4
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/lmpar.h4
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/qrsolv.h4
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/r1mpyq.h4
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/r1updt.h4
-rw-r--r--unsupported/Eigen/src/NonLinearOptimization/rwupdt.h3
-rw-r--r--unsupported/Eigen/src/NumericalDiff/NumericalDiff.h4
-rw-r--r--unsupported/Eigen/src/Polynomials/Companion.h6
-rw-r--r--unsupported/Eigen/src/Polynomials/PolynomialSolver.h4
-rw-r--r--unsupported/Eigen/src/Polynomials/PolynomialUtils.h3
-rw-r--r--unsupported/Eigen/src/Skyline/SkylineInplaceLU.h4
-rw-r--r--unsupported/Eigen/src/Skyline/SkylineMatrix.h4
-rw-r--r--unsupported/Eigen/src/Skyline/SkylineMatrixBase.h4
-rw-r--r--unsupported/Eigen/src/Skyline/SkylineProduct.h4
-rw-r--r--unsupported/Eigen/src/Skyline/SkylineStorage.h4
-rw-r--r--unsupported/Eigen/src/Skyline/SkylineUtil.h3
-rw-r--r--unsupported/Eigen/src/SparseExtra/BlockOfDynamicSparseMatrix.h2
-rw-r--r--unsupported/Eigen/src/SparseExtra/DynamicSparseMatrix.h4
-rw-r--r--unsupported/Eigen/src/SparseExtra/MarketIO.h6
-rw-r--r--unsupported/Eigen/src/SparseExtra/RandomSetter.h4
-rw-r--r--unsupported/doc/Doxyfile.in6
54 files changed, 186 insertions, 58 deletions
diff --git a/unsupported/Eigen/BVH b/unsupported/Eigen/BVH
index f307da2f7..d50b2bdab 100644
--- a/unsupported/Eigen/BVH
+++ b/unsupported/Eigen/BVH
@@ -97,8 +97,9 @@ namespace Eigen {
* The following is a simple but complete example for how to use the BVH to accelerate the search for a closest red-blue point pair:
* \include BVH_Example.cpp
* Output: \verbinclude BVH_Example.out
-
*/
+}
+
//@{
#include "src/BVH/BVAlgorithms.h"
@@ -106,6 +107,4 @@ namespace Eigen {
//@}
-}
-
#endif // EIGEN_BVH_MODULE_H
diff --git a/unsupported/Eigen/FFT b/unsupported/Eigen/FFT
index c56bd63d6..e2ec71307 100644
--- a/unsupported/Eigen/FFT
+++ b/unsupported/Eigen/FFT
@@ -86,23 +86,23 @@
#ifdef EIGEN_FFTW_DEFAULT
// FFTW: faster, GPL -- incompatible with Eigen in LGPL form, bigger code size
# include <fftw3.h>
+# include "src/FFT/ei_fftw_impl.h"
namespace Eigen {
-# include "src/FFT/ei_fftw_impl.h"
//template <typename T> typedef struct internal::fftw_impl default_fft_impl; this does not work
template <typename T> struct default_fft_impl : public internal::fftw_impl<T> {};
}
#elif defined EIGEN_MKL_DEFAULT
// TODO
// intel Math Kernel Library: fastest, commercial -- may be incompatible with Eigen in GPL form
+# include "src/FFT/ei_imklfft_impl.h"
namespace Eigen {
-# include "src/FFT/ei_imklfft_impl.h"
template <typename T> struct default_fft_impl : public internal::imklfft_impl {};
}
#else
// internal::kissfft_impl: small, free, reasonably efficient default, derived from kissfft
//
+# include "src/FFT/ei_kissfft_impl.h"
namespace Eigen {
-# include "src/FFT/ei_kissfft_impl.h"
template <typename T>
struct default_fft_impl : public internal::kissfft_impl<T> {};
}
diff --git a/unsupported/Eigen/IterativeSolvers b/unsupported/Eigen/IterativeSolvers
index c8ec099b1..4645153aa 100644
--- a/unsupported/Eigen/IterativeSolvers
+++ b/unsupported/Eigen/IterativeSolvers
@@ -27,8 +27,6 @@
#include <Eigen/Sparse>
-namespace Eigen {
-
/** \ingroup Unsupported_modules
* \defgroup IterativeSolvers_Module Iterative solvers module
* This module aims to provide various iterative linear and non linear solver algorithms.
@@ -54,6 +52,4 @@ namespace Eigen {
//@}
-}
-
#endif // EIGEN_ITERATIVE_SOLVERS_MODULE_H
diff --git a/unsupported/Eigen/KroneckerProduct b/unsupported/Eigen/KroneckerProduct
index 291c7fabc..796e386ad 100644
--- a/unsupported/Eigen/KroneckerProduct
+++ b/unsupported/Eigen/KroneckerProduct
@@ -17,10 +17,10 @@ namespace Eigen {
* \endcode
*/
-#include "src/KroneckerProduct/KroneckerTensorProduct.h"
-
} // namespace Eigen
+#include "src/KroneckerProduct/KroneckerTensorProduct.h"
+
#include "../../Eigen/src/Core/util/ReenableStupidWarnings.h"
#endif // EIGEN_KRONECKER_PRODUCT_MODULE_H
diff --git a/unsupported/Eigen/MatrixFunctions b/unsupported/Eigen/MatrixFunctions
index ac58eec29..13eda8fc8 100644
--- a/unsupported/Eigen/MatrixFunctions
+++ b/unsupported/Eigen/MatrixFunctions
@@ -34,8 +34,6 @@
#include <Eigen/LU>
#include <Eigen/Eigenvalues>
-namespace Eigen {
-
/** \ingroup Unsupported_modules
* \defgroup MatrixFunctions_Module Matrix functions module
* \brief This module aims to provide various methods for the computation of
@@ -393,7 +391,5 @@ Output: \verbinclude MatrixSquareRoot.out
*/
-}
-
#endif // EIGEN_MATRIX_FUNCTIONS
diff --git a/unsupported/Eigen/MoreVectorization b/unsupported/Eigen/MoreVectorization
index 26a01cd29..9f0a39f75 100644
--- a/unsupported/Eigen/MoreVectorization
+++ b/unsupported/Eigen/MoreVectorization
@@ -9,8 +9,8 @@ namespace Eigen {
* \defgroup MoreVectorization More vectorization module
*/
-#include "src/MoreVectorization/MathFunctions.h"
-
}
+#include "src/MoreVectorization/MathFunctions.h"
+
#endif // EIGEN_MOREVECTORIZATION_MODULE_H
diff --git a/unsupported/Eigen/NonLinearOptimization b/unsupported/Eigen/NonLinearOptimization
index e19db33cc..0a384d649 100644
--- a/unsupported/Eigen/NonLinearOptimization
+++ b/unsupported/Eigen/NonLinearOptimization
@@ -32,8 +32,6 @@
#include <Eigen/QR>
#include <unsupported/Eigen/NumericalDiff>
-namespace Eigen {
-
/** \ingroup Unsupported_modules
* \defgroup NonLinearOptimization_Module Non linear optimization module
*
@@ -147,8 +145,5 @@ namespace Eigen {
#include "src/NonLinearOptimization/HybridNonLinearSolver.h"
#include "src/NonLinearOptimization/LevenbergMarquardt.h"
-}
-
-
#endif // EIGEN_NONLINEAROPTIMIZATION_MODULE
diff --git a/unsupported/Eigen/NumericalDiff b/unsupported/Eigen/NumericalDiff
index 2a59c14d5..eebee076d 100644
--- a/unsupported/Eigen/NumericalDiff
+++ b/unsupported/Eigen/NumericalDiff
@@ -59,12 +59,13 @@ namespace Eigen {
* package.
*
*/
+}
+
//@{
#include "src/NumericalDiff/NumericalDiff.h"
//@}
-}
#endif // EIGEN_NUMERICALDIFF_MODULE
diff --git a/unsupported/Eigen/Polynomials b/unsupported/Eigen/Polynomials
index 2c2f3e100..fa58b006d 100644
--- a/unsupported/Eigen/Polynomials
+++ b/unsupported/Eigen/Polynomials
@@ -16,8 +16,6 @@
#undef EIGEN_HIDE_HEAVY_CODE
#endif
-namespace Eigen {
-
/** \ingroup Unsupported_modules
* \defgroup Polynomials_Module Polynomials module
*
@@ -129,8 +127,6 @@ namespace Eigen {
Output: \verbinclude PolynomialSolver1.out
*/
-} // namespace Eigen
-
#include <Eigen/src/Core/util/ReenableStupidWarnings.h>
#endif // EIGEN_POLYNOMIALS_MODULE_H
diff --git a/unsupported/Eigen/Skyline b/unsupported/Eigen/Skyline
index 5247b2eab..c9823f358 100644
--- a/unsupported/Eigen/Skyline
+++ b/unsupported/Eigen/Skyline
@@ -11,15 +11,13 @@
#include <cstring>
#include <algorithm>
-namespace Eigen {
-
- /** \ingroup Unsupported_modules
- * \defgroup Skyline_Module Skyline module
- *
- *
- *
- *
- */
+/** \ingroup Unsupported_modules
+ * \defgroup Skyline_Module Skyline module
+ *
+ *
+ *
+ *
+ */
#include "src/Skyline/SkylineUtil.h"
#include "src/Skyline/SkylineMatrixBase.h"
@@ -28,8 +26,6 @@ namespace Eigen {
#include "src/Skyline/SkylineInplaceLU.h"
#include "src/Skyline/SkylineProduct.h"
-} // namespace Eigen
-
#include "Eigen/src/Core/util/ReenableStupidWarnings.h"
#endif // EIGEN_SKYLINE_MODULE_H
diff --git a/unsupported/Eigen/SparseExtra b/unsupported/Eigen/SparseExtra
index cc7c37324..2cc14bbe1 100644
--- a/unsupported/Eigen/SparseExtra
+++ b/unsupported/Eigen/SparseExtra
@@ -17,8 +17,6 @@
#include <google/dense_hash_map>
#endif
-namespace Eigen {
-
/** \ingroup Unsupported_modules
* \defgroup SparseExtra_Module SparseExtra module
*
@@ -38,7 +36,6 @@ namespace Eigen {
#include "src/SparseExtra/RandomSetter.h"
#include "src/SparseExtra/MarketIO.h"
-} // namespace Eigen
#if !defined(_WIN32)
#include <dirent.h>
diff --git a/unsupported/Eigen/Splines b/unsupported/Eigen/Splines
index 362274157..33769b0e4 100644
--- a/unsupported/Eigen/Splines
+++ b/unsupported/Eigen/Splines
@@ -37,16 +37,10 @@ namespace Eigen
* #include <unsupported/Eigen/Splines>
* \endcode
*/
-//@{
}
#include "src/Splines/SplineFwd.h"
#include "src/Splines/Spline.h"
#include "src/Splines/SplineFitting.h"
-namespace Eigen
-{
-//@}
-}
-
#endif // EIGEN_SPLINES_MODULE_H
diff --git a/unsupported/Eigen/src/BVH/BVAlgorithms.h b/unsupported/Eigen/src/BVH/BVAlgorithms.h
index d65a97740..6cba656ff 100644
--- a/unsupported/Eigen/src/BVH/BVAlgorithms.h
+++ b/unsupported/Eigen/src/BVH/BVAlgorithms.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_BVALGORITHMS_H
#define EIGEN_BVALGORITHMS_H
+namespace Eigen {
+
namespace internal {
#ifndef EIGEN_PARSED_BY_DOXYGEN
@@ -301,4 +303,6 @@ typename Minimizer::Scalar BVMinimize(const BVH1 &tree1, const BVH2 &tree2, Mini
return minimum;
}
+} // end namespace Eigen
+
#endif // EIGEN_BVALGORITHMS_H
diff --git a/unsupported/Eigen/src/BVH/KdBVH.h b/unsupported/Eigen/src/BVH/KdBVH.h
index 028b4811e..a0f666090 100644
--- a/unsupported/Eigen/src/BVH/KdBVH.h
+++ b/unsupported/Eigen/src/BVH/KdBVH.h
@@ -25,6 +25,8 @@
#ifndef KDBVH_H_INCLUDED
#define KDBVH_H_INCLUDED
+namespace Eigen {
+
namespace internal {
//internal pair class for the BVH--used instead of std::pair because of alignment
@@ -230,4 +232,6 @@ private:
ObjectList objects;
};
+} // end namespace Eigen
+
#endif //KDBVH_H_INCLUDED
diff --git a/unsupported/Eigen/src/FFT/ei_fftw_impl.h b/unsupported/Eigen/src/FFT/ei_fftw_impl.h
index a06f6739e..5c36db70c 100644
--- a/unsupported/Eigen/src/FFT/ei_fftw_impl.h
+++ b/unsupported/Eigen/src/FFT/ei_fftw_impl.h
@@ -22,6 +22,8 @@
// License and a copy of the GNU General Public License along with
// Eigen. If not, see <http://www.gnu.org/licenses/>.
+namespace Eigen {
+
namespace internal {
// FFTW uses non-const arguments
@@ -269,4 +271,6 @@ namespace internal {
} // end namespace internal
+} // end namespace Eigen
+
/* vim: set filetype=cpp et sw=2 ts=2 ai: */
diff --git a/unsupported/Eigen/src/FFT/ei_kissfft_impl.h b/unsupported/Eigen/src/FFT/ei_kissfft_impl.h
index 04b98b083..c3cbb7f01 100644
--- a/unsupported/Eigen/src/FFT/ei_kissfft_impl.h
+++ b/unsupported/Eigen/src/FFT/ei_kissfft_impl.h
@@ -22,6 +22,8 @@
// License and a copy of the GNU General Public License along with
// Eigen. If not, see <http://www.gnu.org/licenses/>.
+namespace Eigen {
+
namespace internal {
// This FFT implementation was derived from kissfft http:sourceforge.net/projects/kissfft
@@ -426,5 +428,6 @@ struct kissfft_impl
} // end namespace internal
-/* vim: set filetype=cpp et sw=2 ts=2 ai: */
+} // end namespace Eigen
+/* vim: set filetype=cpp et sw=2 ts=2 ai: */
diff --git a/unsupported/Eigen/src/IterativeSolvers/ConstrainedConjGrad.h b/unsupported/Eigen/src/IterativeSolvers/ConstrainedConjGrad.h
index 4d8e183ee..f8a550553 100644
--- a/unsupported/Eigen/src/IterativeSolvers/ConstrainedConjGrad.h
+++ b/unsupported/Eigen/src/IterativeSolvers/ConstrainedConjGrad.h
@@ -50,6 +50,8 @@
#include <Eigen/Core>
+namespace Eigen {
+
namespace internal {
/** \ingroup IterativeSolvers_Module
@@ -195,4 +197,6 @@ void constrained_cg(const TMatrix& A, const CMatrix& C, VectorX& x,
} // end namespace internal
+} // end namespace Eigen
+
#endif // EIGEN_CONSTRAINEDCG_H
diff --git a/unsupported/Eigen/src/IterativeSolvers/GMRES.h b/unsupported/Eigen/src/IterativeSolvers/GMRES.h
index 9bebae90e..3b74e44aa 100644
--- a/unsupported/Eigen/src/IterativeSolvers/GMRES.h
+++ b/unsupported/Eigen/src/IterativeSolvers/GMRES.h
@@ -26,6 +26,8 @@
#ifndef EIGEN_GMRES_H
#define EIGEN_GMRES_H
+namespace Eigen {
+
namespace internal {
/**
@@ -385,6 +387,8 @@ struct solve_retval<GMRES<_MatrixType, _Preconditioner>, Rhs>
}
};
-}
+} // end namespace internal
+
+} // end namespace Eigen
#endif // EIGEN_GMRES_H
diff --git a/unsupported/Eigen/src/IterativeSolvers/IncompleteLU.h b/unsupported/Eigen/src/IterativeSolvers/IncompleteLU.h
index d8d44695c..e02f1f0c8 100644
--- a/unsupported/Eigen/src/IterativeSolvers/IncompleteLU.h
+++ b/unsupported/Eigen/src/IterativeSolvers/IncompleteLU.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_INCOMPLETE_LU_H
#define EIGEN_INCOMPLETE_LU_H
+namespace Eigen {
+
template <typename _Scalar>
class IncompleteLU
{
@@ -119,6 +121,8 @@ struct solve_retval<IncompleteLU<_MatrixType>, Rhs>
}
};
-}
+} // end namespace internal
+
+} // end namespace Eigen
#endif // EIGEN_INCOMPLETE_LU_H
diff --git a/unsupported/Eigen/src/IterativeSolvers/IterationController.h b/unsupported/Eigen/src/IterativeSolvers/IterationController.h
index a65793cd5..dfb97e239 100644
--- a/unsupported/Eigen/src/IterativeSolvers/IterationController.h
+++ b/unsupported/Eigen/src/IterativeSolvers/IterationController.h
@@ -75,6 +75,8 @@
#ifndef EIGEN_ITERATION_CONTROLLER_H
#define EIGEN_ITERATION_CONTROLLER_H
+namespace Eigen {
+
/** \ingroup IterativeSolvers_Module
* \class IterationController
*
@@ -163,4 +165,6 @@ class IterationController
};
+} // end namespace Eigen
+
#endif // EIGEN_ITERATION_CONTROLLER_H
diff --git a/unsupported/Eigen/src/KroneckerProduct/KroneckerTensorProduct.h b/unsupported/Eigen/src/KroneckerProduct/KroneckerTensorProduct.h
index cc5f271f0..4627705ce 100644
--- a/unsupported/Eigen/src/KroneckerProduct/KroneckerTensorProduct.h
+++ b/unsupported/Eigen/src/KroneckerProduct/KroneckerTensorProduct.h
@@ -28,6 +28,8 @@
#define KRONECKER_TENSOR_PRODUCT_H
+namespace Eigen {
+
namespace internal {
/*!
@@ -165,4 +167,6 @@ void kroneckerProduct(const SparseMatrixBase<A>& a, const SparseMatrixBase<B>& b
internal::kroneckerProduct_sparse(a.derived(), b.derived(), c.derived());
}
+} // end namespace Eigen
+
#endif // KRONECKER_TENSOR_PRODUCT_H
diff --git a/unsupported/Eigen/src/MatrixFunctions/MatrixExponential.h b/unsupported/Eigen/src/MatrixFunctions/MatrixExponential.h
index c9aeb3321..6cdd65748 100644
--- a/unsupported/Eigen/src/MatrixFunctions/MatrixExponential.h
+++ b/unsupported/Eigen/src/MatrixFunctions/MatrixExponential.h
@@ -28,6 +28,8 @@
#include "StemFunction.h"
+namespace Eigen {
+
#if defined(_MSC_VER) || defined(__FreeBSD__)
template <typename Scalar> Scalar log2(Scalar v) { using std::log; return log(v)/log(Scalar(2)); }
#endif
@@ -462,4 +464,6 @@ const MatrixExponentialReturnValue<Derived> MatrixBase<Derived>::exp() const
return MatrixExponentialReturnValue<Derived>(derived());
}
+} // end namespace Eigen
+
#endif // EIGEN_MATRIX_EXPONENTIAL
diff --git a/unsupported/Eigen/src/MatrixFunctions/MatrixFunction.h b/unsupported/Eigen/src/MatrixFunctions/MatrixFunction.h
index 6970b3a15..859de7288 100644
--- a/unsupported/Eigen/src/MatrixFunctions/MatrixFunction.h
+++ b/unsupported/Eigen/src/MatrixFunctions/MatrixFunction.h
@@ -29,6 +29,8 @@
#include "MatrixFunctionAtomic.h"
+namespace Eigen {
+
/** \ingroup MatrixFunctions_Module
* \brief Class for computing matrix functions.
* \tparam MatrixType type of the argument of the matrix function,
@@ -598,4 +600,6 @@ const MatrixFunctionReturnValue<Derived> MatrixBase<Derived>::cosh() const
return MatrixFunctionReturnValue<Derived>(derived(), StdStemFunctions<ComplexScalar>::cosh);
}
+} // end namespace Eigen
+
#endif // EIGEN_MATRIX_FUNCTION
diff --git a/unsupported/Eigen/src/MatrixFunctions/MatrixFunctionAtomic.h b/unsupported/Eigen/src/MatrixFunctions/MatrixFunctionAtomic.h
index d08766921..97ab662fe 100644
--- a/unsupported/Eigen/src/MatrixFunctions/MatrixFunctionAtomic.h
+++ b/unsupported/Eigen/src/MatrixFunctions/MatrixFunctionAtomic.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_MATRIX_FUNCTION_ATOMIC
#define EIGEN_MATRIX_FUNCTION_ATOMIC
+namespace Eigen {
+
/** \ingroup MatrixFunctions_Module
* \class MatrixFunctionAtomic
* \brief Helper class for computing matrix functions of atomic matrices.
@@ -139,4 +141,6 @@ bool MatrixFunctionAtomic<MatrixType>::taylorConverged(Index s, const MatrixType
return false;
}
+} // end namespace Eigen
+
#endif // EIGEN_MATRIX_FUNCTION_ATOMIC
diff --git a/unsupported/Eigen/src/MatrixFunctions/MatrixLogarithm.h b/unsupported/Eigen/src/MatrixFunctions/MatrixLogarithm.h
index e575be0ac..4a40d6a9d 100644
--- a/unsupported/Eigen/src/MatrixFunctions/MatrixLogarithm.h
+++ b/unsupported/Eigen/src/MatrixFunctions/MatrixLogarithm.h
@@ -30,6 +30,8 @@
#define M_PI 3.141592653589793238462643383279503L
#endif
+namespace Eigen {
+
/** \ingroup MatrixFunctions_Module
* \class MatrixLogarithmAtomic
* \brief Helper class for computing matrix logarithm of atomic matrices.
@@ -503,4 +505,6 @@ const MatrixLogarithmReturnValue<Derived> MatrixBase<Derived>::log() const
return MatrixLogarithmReturnValue<Derived>(derived());
}
+} // end namespace Eigen
+
#endif // EIGEN_MATRIX_LOGARITHM
diff --git a/unsupported/Eigen/src/MatrixFunctions/MatrixSquareRoot.h b/unsupported/Eigen/src/MatrixFunctions/MatrixSquareRoot.h
index ed1b5ee35..658cd334c 100644
--- a/unsupported/Eigen/src/MatrixFunctions/MatrixSquareRoot.h
+++ b/unsupported/Eigen/src/MatrixFunctions/MatrixSquareRoot.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_MATRIX_SQUARE_ROOT
#define EIGEN_MATRIX_SQUARE_ROOT
+namespace Eigen {
+
/** \ingroup MatrixFunctions_Module
* \brief Class for computing matrix square roots of upper quasi-triangular matrices.
* \tparam MatrixType type of the argument of the matrix square root,
@@ -492,4 +494,6 @@ const MatrixSquareRootReturnValue<Derived> MatrixBase<Derived>::sqrt() const
return MatrixSquareRootReturnValue<Derived>(derived());
}
+} // end namespace Eigen
+
#endif // EIGEN_MATRIX_FUNCTION
diff --git a/unsupported/Eigen/src/MatrixFunctions/StemFunction.h b/unsupported/Eigen/src/MatrixFunctions/StemFunction.h
index 260690b63..3de68ec3a 100644
--- a/unsupported/Eigen/src/MatrixFunctions/StemFunction.h
+++ b/unsupported/Eigen/src/MatrixFunctions/StemFunction.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_STEM_FUNCTION
#define EIGEN_STEM_FUNCTION
+namespace Eigen {
+
/** \ingroup MatrixFunctions_Module
* \brief Stem functions corresponding to standard mathematical functions.
*/
@@ -113,4 +115,6 @@ class StdStemFunctions
}; // end of class StdStemFunctions
+} // end namespace Eigen
+
#endif // EIGEN_STEM_FUNCTION
diff --git a/unsupported/Eigen/src/MoreVectorization/MathFunctions.h b/unsupported/Eigen/src/MoreVectorization/MathFunctions.h
index bc948d0bd..123f4016e 100644
--- a/unsupported/Eigen/src/MoreVectorization/MathFunctions.h
+++ b/unsupported/Eigen/src/MoreVectorization/MathFunctions.h
@@ -26,6 +26,8 @@
#ifndef EIGEN_MOREVECTORIZATION_MATHFUNCTIONS_H
#define EIGEN_MOREVECTORIZATION_MATHFUNCTIONS_H
+namespace Eigen {
+
namespace internal {
/** \internal \returns the arcsin of \a a (coeff-wise) */
@@ -99,8 +101,10 @@ template<> EIGEN_DONT_INLINE Packet4f pasin(Packet4f x)
return _mm_xor_ps(z, sign_bit);
}
+#endif // EIGEN_VECTORIZE_SSE
+
} // end namespace internal
-#endif
+} // end namespace Eigen
#endif // EIGEN_MOREVECTORIZATION_MATHFUNCTIONS_H
diff --git a/unsupported/Eigen/src/NonLinearOptimization/HybridNonLinearSolver.h b/unsupported/Eigen/src/NonLinearOptimization/HybridNonLinearSolver.h
index 37abb6117..aa9430359 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/HybridNonLinearSolver.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/HybridNonLinearSolver.h
@@ -28,6 +28,8 @@
#ifndef EIGEN_HYBRIDNONLINEARSOLVER_H
#define EIGEN_HYBRIDNONLINEARSOLVER_H
+namespace Eigen {
+
namespace HybridNonLinearSolverSpace {
enum Status {
Running = -1,
@@ -602,6 +604,8 @@ HybridNonLinearSolver<FunctorType,Scalar>::solveNumericalDiff(FVectorType &x)
return status;
}
-//vim: ai ts=4 sts=4 et sw=4
+} // end namespace Eigen
+
#endif // EIGEN_HYBRIDNONLINEARSOLVER_H
+//vim: ai ts=4 sts=4 et sw=4
diff --git a/unsupported/Eigen/src/NonLinearOptimization/LevenbergMarquardt.h b/unsupported/Eigen/src/NonLinearOptimization/LevenbergMarquardt.h
index 0ae681b1c..2fc50fb93 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/LevenbergMarquardt.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/LevenbergMarquardt.h
@@ -28,6 +28,7 @@
#ifndef EIGEN_LEVENBERGMARQUARDT__H
#define EIGEN_LEVENBERGMARQUARDT__H
+namespace Eigen {
namespace LevenbergMarquardtSpace {
enum Status {
@@ -651,6 +652,8 @@ LevenbergMarquardt<FunctorType,Scalar>::lmdif1(
return info;
}
-//vim: ai ts=4 sts=4 et sw=4
+} // end namespace Eigen
+
#endif // EIGEN_LEVENBERGMARQUARDT__H
+//vim: ai ts=4 sts=4 et sw=4
diff --git a/unsupported/Eigen/src/NonLinearOptimization/chkder.h b/unsupported/Eigen/src/NonLinearOptimization/chkder.h
index bc0cb1880..fd3e0bc4a 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/chkder.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/chkder.h
@@ -2,6 +2,8 @@
#define chkder_log10e 0.43429448190325182765
#define chkder_factor 100.
+namespace Eigen {
+
namespace internal {
template<typename Scalar>
@@ -58,3 +60,4 @@ void chkder(
} // end namespace internal
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NonLinearOptimization/covar.h b/unsupported/Eigen/src/NonLinearOptimization/covar.h
index 6c77916f5..c73a09645 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/covar.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/covar.h
@@ -1,3 +1,5 @@
+namespace Eigen {
+
namespace internal {
template <typename Scalar>
@@ -63,3 +65,5 @@ void covar(
}
} // end namespace internal
+
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NonLinearOptimization/dogleg.h b/unsupported/Eigen/src/NonLinearOptimization/dogleg.h
index cbdcf4b71..4fbc98bfc 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/dogleg.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/dogleg.h
@@ -1,3 +1,5 @@
+namespace Eigen {
+
namespace internal {
template <typename Scalar>
@@ -98,3 +100,5 @@ algo_end:
}
} // end namespace internal
+
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NonLinearOptimization/fdjac1.h b/unsupported/Eigen/src/NonLinearOptimization/fdjac1.h
index 0a26c2061..1cabe69ae 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/fdjac1.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/fdjac1.h
@@ -1,3 +1,5 @@
+namespace Eigen {
+
namespace internal {
template<typename FunctorType, typename Scalar>
@@ -70,3 +72,5 @@ DenseIndex fdjac1(
}
} // end namespace internal
+
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NonLinearOptimization/lmpar.h b/unsupported/Eigen/src/NonLinearOptimization/lmpar.h
index 62f4aabc9..cc1ca530f 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/lmpar.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/lmpar.h
@@ -1,3 +1,5 @@
+namespace Eigen {
+
namespace internal {
template <typename Scalar>
@@ -288,3 +290,5 @@ void lmpar2(
}
} // end namespace internal
+
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NonLinearOptimization/qrsolv.h b/unsupported/Eigen/src/NonLinearOptimization/qrsolv.h
index cb1764a41..feafd62a8 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/qrsolv.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/qrsolv.h
@@ -1,3 +1,5 @@
+namespace Eigen {
+
namespace internal {
// TODO : once qrsolv2 is removed, use ColPivHouseholderQR or PermutationMatrix instead of ipvt
@@ -85,3 +87,5 @@ void qrsolv(
}
} // end namespace internal
+
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NonLinearOptimization/r1mpyq.h b/unsupported/Eigen/src/NonLinearOptimization/r1mpyq.h
index ffe505cd5..36ff700e9 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/r1mpyq.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/r1mpyq.h
@@ -1,3 +1,5 @@
+namespace Eigen {
+
namespace internal {
// TODO : move this to GivensQR once there's such a thing in Eigen
@@ -24,3 +26,5 @@ void r1mpyq(DenseIndex m, DenseIndex n, Scalar *a, const std::vector<JacobiRotat
}
} // end namespace internal
+
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NonLinearOptimization/r1updt.h b/unsupported/Eigen/src/NonLinearOptimization/r1updt.h
index 528f8eef9..55fae5ae8 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/r1updt.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/r1updt.h
@@ -1,3 +1,5 @@
+namespace Eigen {
+
namespace internal {
template <typename Scalar>
@@ -93,3 +95,5 @@ void r1updt(
}
} // end namespace internal
+
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NonLinearOptimization/rwupdt.h b/unsupported/Eigen/src/NonLinearOptimization/rwupdt.h
index ab83f9b25..9ce079e22 100644
--- a/unsupported/Eigen/src/NonLinearOptimization/rwupdt.h
+++ b/unsupported/Eigen/src/NonLinearOptimization/rwupdt.h
@@ -1,3 +1,5 @@
+namespace Eigen {
+
namespace internal {
template <typename Scalar>
@@ -44,3 +46,4 @@ void rwupdt(
} // end namespace internal
+} // end namespace Eigen
diff --git a/unsupported/Eigen/src/NumericalDiff/NumericalDiff.h b/unsupported/Eigen/src/NumericalDiff/NumericalDiff.h
index 52dc0ec01..36df9f5d7 100644
--- a/unsupported/Eigen/src/NumericalDiff/NumericalDiff.h
+++ b/unsupported/Eigen/src/NumericalDiff/NumericalDiff.h
@@ -28,6 +28,8 @@
#ifndef EIGEN_NUMERICAL_DIFF_H
#define EIGEN_NUMERICAL_DIFF_H
+namespace Eigen {
+
enum NumericalDiffMode {
Forward,
Central
@@ -134,6 +136,8 @@ private:
NumericalDiff& operator=(const NumericalDiff&);
};
+} // end namespace Eigen
+
//vim: ai ts=4 sts=4 et sw=4
#endif // EIGEN_NUMERICAL_DIFF_H
diff --git a/unsupported/Eigen/src/Polynomials/Companion.h b/unsupported/Eigen/src/Polynomials/Companion.h
index 608951d3c..8936b8fad 100644
--- a/unsupported/Eigen/src/Polynomials/Companion.h
+++ b/unsupported/Eigen/src/Polynomials/Companion.h
@@ -29,10 +29,12 @@
// * Eigen/Core
// * Eigen/src/PolynomialSolver.h
-#ifndef EIGEN_PARSED_BY_DOXYGEN
+namespace Eigen {
namespace internal {
+#ifndef EIGEN_PARSED_BY_DOXYGEN
+
template <typename T>
T radix(){ return 2; }
@@ -283,4 +285,6 @@ void companion<_Scalar,_Deg>::balance()
} // end namespace internal
+} // end namespace Eigen
+
#endif // EIGEN_COMPANION_H
diff --git a/unsupported/Eigen/src/Polynomials/PolynomialSolver.h b/unsupported/Eigen/src/Polynomials/PolynomialSolver.h
index 417b93df2..71295a105 100644
--- a/unsupported/Eigen/src/Polynomials/PolynomialSolver.h
+++ b/unsupported/Eigen/src/Polynomials/PolynomialSolver.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_POLYNOMIAL_SOLVER_H
#define EIGEN_POLYNOMIAL_SOLVER_H
+namespace Eigen {
+
/** \ingroup Polynomials_Module
* \class PolynomialSolverBase.
*
@@ -394,4 +396,6 @@ class PolynomialSolver<_Scalar,1> : public PolynomialSolverBase<_Scalar,1>
using PS_Base::m_roots;
};
+} // end namespace Eigen
+
#endif // EIGEN_POLYNOMIAL_SOLVER_H
diff --git a/unsupported/Eigen/src/Polynomials/PolynomialUtils.h b/unsupported/Eigen/src/Polynomials/PolynomialUtils.h
index 65942c52a..1fb1ed139 100644
--- a/unsupported/Eigen/src/Polynomials/PolynomialUtils.h
+++ b/unsupported/Eigen/src/Polynomials/PolynomialUtils.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_POLYNOMIAL_UTILS_H
#define EIGEN_POLYNOMIAL_UTILS_H
+namespace Eigen {
+
/** \ingroup Polynomials_Module
* \returns the evaluation of the polynomial at x using Horner algorithm.
*
@@ -149,5 +151,6 @@ void roots_to_monicPolynomial( const RootVector& rv, Polynomial& poly )
}
}
+} // end namespace Eigen
#endif // EIGEN_POLYNOMIAL_UTILS_H
diff --git a/unsupported/Eigen/src/Skyline/SkylineInplaceLU.h b/unsupported/Eigen/src/Skyline/SkylineInplaceLU.h
index 51537402e..ef36ac9b6 100644
--- a/unsupported/Eigen/src/Skyline/SkylineInplaceLU.h
+++ b/unsupported/Eigen/src/Skyline/SkylineInplaceLU.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_SKYLINEINPLACELU_H
#define EIGEN_SKYLINEINPLACELU_H
+namespace Eigen {
+
/** \ingroup Skyline_Module
*
* \class SkylineInplaceLU
@@ -360,4 +362,6 @@ bool SkylineInplaceLU<MatrixType>::solve(const MatrixBase<BDerived> &b, MatrixBa
return true;
}
+} // end namespace Eigen
+
#endif // EIGEN_SKYLINELU_H
diff --git a/unsupported/Eigen/src/Skyline/SkylineMatrix.h b/unsupported/Eigen/src/Skyline/SkylineMatrix.h
index 31810df08..98a19ce53 100644
--- a/unsupported/Eigen/src/Skyline/SkylineMatrix.h
+++ b/unsupported/Eigen/src/Skyline/SkylineMatrix.h
@@ -28,6 +28,8 @@
#include "SkylineStorage.h"
#include "SkylineMatrixBase.h"
+namespace Eigen {
+
/** \ingroup Skyline_Module
*
* \class SkylineMatrix
@@ -870,4 +872,6 @@ protected:
const Index m_end;
};
+} // end namespace Eigen
+
#endif // EIGEN_SkylineMatrix_H
diff --git a/unsupported/Eigen/src/Skyline/SkylineMatrixBase.h b/unsupported/Eigen/src/Skyline/SkylineMatrixBase.h
index 4d0c2397c..72131eb3f 100644
--- a/unsupported/Eigen/src/Skyline/SkylineMatrixBase.h
+++ b/unsupported/Eigen/src/Skyline/SkylineMatrixBase.h
@@ -27,6 +27,8 @@
#include "SkylineUtil.h"
+namespace Eigen {
+
/** \ingroup Skyline_Module
*
* \class SkylineMatrixBase
@@ -220,4 +222,6 @@ protected:
bool m_isRValue;
};
+} // end namespace Eigen
+
#endif // EIGEN_SkylineMatrixBase_H
diff --git a/unsupported/Eigen/src/Skyline/SkylineProduct.h b/unsupported/Eigen/src/Skyline/SkylineProduct.h
index aeedc47ec..fb653b446 100644
--- a/unsupported/Eigen/src/Skyline/SkylineProduct.h
+++ b/unsupported/Eigen/src/Skyline/SkylineProduct.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_SKYLINEPRODUCT_H
#define EIGEN_SKYLINEPRODUCT_H
+namespace Eigen {
+
template<typename Lhs, typename Rhs, int ProductMode>
struct SkylineProductReturnType {
typedef const typename internal::nested<Lhs, Rhs::RowsAtCompileTime>::type LhsNested;
@@ -303,4 +305,6 @@ SkylineMatrixBase<Derived>::operator*(const MatrixBase<OtherDerived> &other) con
return typename SkylineProductReturnType<Derived, OtherDerived>::Type(derived(), other.derived());
}
+} // end namespace Eigen
+
#endif // EIGEN_SKYLINEPRODUCT_H
diff --git a/unsupported/Eigen/src/Skyline/SkylineStorage.h b/unsupported/Eigen/src/Skyline/SkylineStorage.h
index 62806bfb6..5721dee90 100644
--- a/unsupported/Eigen/src/Skyline/SkylineStorage.h
+++ b/unsupported/Eigen/src/Skyline/SkylineStorage.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_SKYLINE_STORAGE_H
#define EIGEN_SKYLINE_STORAGE_H
+namespace Eigen {
+
/** Stores a skyline set of values in three structures :
* The diagonal elements
* The upper elements
@@ -267,4 +269,6 @@ public:
};
+} // end namespace Eigen
+
#endif // EIGEN_COMPRESSED_STORAGE_H
diff --git a/unsupported/Eigen/src/Skyline/SkylineUtil.h b/unsupported/Eigen/src/Skyline/SkylineUtil.h
index e0512476f..5c5bd8bda 100644
--- a/unsupported/Eigen/src/Skyline/SkylineUtil.h
+++ b/unsupported/Eigen/src/Skyline/SkylineUtil.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_SKYLINEUTIL_H
#define EIGEN_SKYLINEUTIL_H
+namespace Eigen {
+
#ifdef NDEBUG
#define EIGEN_DBG_SKYLINE(X)
#else
@@ -97,5 +99,6 @@ template<typename T> class eval<T,IsSkyline>
} // end namespace internal
+} // end namespace Eigen
#endif // EIGEN_SKYLINEUTIL_H
diff --git a/unsupported/Eigen/src/SparseExtra/BlockOfDynamicSparseMatrix.h b/unsupported/Eigen/src/SparseExtra/BlockOfDynamicSparseMatrix.h
index 753643736..0cc6e3a06 100644
--- a/unsupported/Eigen/src/SparseExtra/BlockOfDynamicSparseMatrix.h
+++ b/unsupported/Eigen/src/SparseExtra/BlockOfDynamicSparseMatrix.h
@@ -25,6 +25,7 @@
#ifndef EIGEN_SPARSE_BLOCKFORDYNAMICMATRIX_H
#define EIGEN_SPARSE_BLOCKFORDYNAMICMATRIX_H
+namespace Eigen {
/***************************************************************************
* specialisation for DynamicSparseMatrix
@@ -123,5 +124,6 @@ class SparseInnerVectorSet<DynamicSparseMatrix<_Scalar, _Options, _Index>, Size>
};
+} // end namespace Eigen
#endif // EIGEN_SPARSE_BLOCKFORDYNAMICMATRIX_H
diff --git a/unsupported/Eigen/src/SparseExtra/DynamicSparseMatrix.h b/unsupported/Eigen/src/SparseExtra/DynamicSparseMatrix.h
index d43149a8f..151d46538 100644
--- a/unsupported/Eigen/src/SparseExtra/DynamicSparseMatrix.h
+++ b/unsupported/Eigen/src/SparseExtra/DynamicSparseMatrix.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_DYNAMIC_SPARSEMATRIX_H
#define EIGEN_DYNAMIC_SPARSEMATRIX_H
+namespace Eigen {
+
/** \deprecated use a SparseMatrix in an uncompressed mode
*
* \class DynamicSparseMatrix
@@ -365,4 +367,6 @@ class DynamicSparseMatrix<Scalar,_Options,_Index>::ReverseInnerIterator : public
const Index m_outer;
};
+} // end namespace Eigen
+
#endif // EIGEN_DYNAMIC_SPARSEMATRIX_H
diff --git a/unsupported/Eigen/src/SparseExtra/MarketIO.h b/unsupported/Eigen/src/SparseExtra/MarketIO.h
index 3b103914a..d034d8e2f 100644
--- a/unsupported/Eigen/src/SparseExtra/MarketIO.h
+++ b/unsupported/Eigen/src/SparseExtra/MarketIO.h
@@ -25,6 +25,9 @@
#ifndef EIGEN_SPARSE_MARKET_IO_H
#define EIGEN_SPARSE_MARKET_IO_H
+
+namespace Eigen {
+
namespace internal
{
template <typename Scalar>
@@ -274,4 +277,7 @@ bool saveMarketVector (const VectorType& vec, const std::string& filename)
out.close();
return true;
}
+
+} // end namespace Eigen
+
#endif // EIGEN_SPARSE_MARKET_IO_H
diff --git a/unsupported/Eigen/src/SparseExtra/RandomSetter.h b/unsupported/Eigen/src/SparseExtra/RandomSetter.h
index b4e6afbe6..9328c60cf 100644
--- a/unsupported/Eigen/src/SparseExtra/RandomSetter.h
+++ b/unsupported/Eigen/src/SparseExtra/RandomSetter.h
@@ -25,6 +25,8 @@
#ifndef EIGEN_RANDOMSETTER_H
#define EIGEN_RANDOMSETTER_H
+namespace Eigen {
+
/** Represents a std::map
*
* \see RandomSetter
@@ -335,4 +337,6 @@ class RandomSetter
unsigned char m_keyBitsOffset;
};
+} // end namespace Eigen
+
#endif // EIGEN_RANDOMSETTER_H
diff --git a/unsupported/doc/Doxyfile.in b/unsupported/doc/Doxyfile.in
index bb9da3b7e..1facf2985 100644
--- a/unsupported/doc/Doxyfile.in
+++ b/unsupported/doc/Doxyfile.in
@@ -552,7 +552,6 @@ WARN_LOGFILE =
# with spaces.
INPUT = "${Eigen_SOURCE_DIR}/unsupported/Eigen" \
- "${Eigen_SOURCE_DIR}/unsupported/Eigen/src/Splines" \
"${Eigen_SOURCE_DIR}/unsupported/doc"
# This tag can be used to specify the character encoding of the source files
@@ -576,13 +575,14 @@ FILE_PATTERNS = *
# should be searched for input files as well. Possible values are YES and NO.
# If left blank NO is used.
-RECURSIVE = NO
+RECURSIVE = YES
# The EXCLUDE tag can be used to specify files and/or directories that should
# excluded from the INPUT source files. This way you can easily exclude a
# subdirectory from a directory tree whose root is specified with the INPUT tag.
-EXCLUDE =
+EXCLUDE = "${Eigen_SOURCE_DIR}/unsupported/doc/examples" \
+ "${Eigen_SOURCE_DIR}/unsupported/doc/snippets"
# The EXCLUDE_SYMLINKS tag can be used select whether or not files or
# directories that are symbolic links (a Unix filesystem feature) are excluded