cleaning pass: rm unused variables in MKL stuff, fix a few namespace issues, MarketIO needs iostream

This commit is contained in:
Gael Guennebaud 2012-04-18 10:09:46 +02:00
parent 1198ca0284
commit 5cab18976b
9 changed files with 20 additions and 11 deletions

View File

@ -133,7 +133,7 @@ struct product_triangular_matrix_matrix_trmm<EIGTYPE,Index,Mode,true, \
char side = 'L', transa, uplo, diag = 'N'; \ char side = 'L', transa, uplo, diag = 'N'; \
EIGTYPE *b; \ EIGTYPE *b; \
const EIGTYPE *a; \ const EIGTYPE *a; \
MKL_INT m, n, k, lda, ldb, ldc; \ MKL_INT m, n, lda, ldb; \
MKLTYPE alpha_; \ MKLTYPE alpha_; \
\ \
/* Set alpha_*/ \ /* Set alpha_*/ \
@ -247,7 +247,7 @@ struct product_triangular_matrix_matrix_trmm<EIGTYPE,Index,Mode,false, \
char side = 'R', transa, uplo, diag = 'N'; \ char side = 'R', transa, uplo, diag = 'N'; \
EIGTYPE *b; \ EIGTYPE *b; \
const EIGTYPE *a; \ const EIGTYPE *a; \
MKL_INT m, n, k, lda, ldb, ldc; \ MKL_INT m, n, lda, ldb, ldc; \
MKLTYPE alpha_; \ MKLTYPE alpha_; \
\ \
/* Set alpha_*/ \ /* Set alpha_*/ \

View File

@ -105,7 +105,7 @@ struct triangular_matrix_vector_product_trmv<Index,Mode,EIGTYPE,ConjLhs,EIGTYPE,
/* Square part handling */\ /* Square part handling */\
\ \
char trans, uplo, diag; \ char trans, uplo, diag; \
MKL_INT m, n, k, lda, incx, incy; \ MKL_INT m, n, lda, incx, incy; \
EIGTYPE const *a; \ EIGTYPE const *a; \
MKLTYPE alpha_, beta_; \ MKLTYPE alpha_, beta_; \
assign_scalar_eig2mkl<MKLTYPE, EIGTYPE>(alpha_, alpha); \ assign_scalar_eig2mkl<MKLTYPE, EIGTYPE>(alpha_, alpha); \
@ -190,7 +190,7 @@ struct triangular_matrix_vector_product_trmv<Index,Mode,EIGTYPE,ConjLhs,EIGTYPE,
/* Square part handling */\ /* Square part handling */\
\ \
char trans, uplo, diag; \ char trans, uplo, diag; \
MKL_INT m, n, k, lda, incx, incy; \ MKL_INT m, n, lda, incx, incy; \
EIGTYPE const *a; \ EIGTYPE const *a; \
MKLTYPE alpha_, beta_; \ MKLTYPE alpha_, beta_; \
assign_scalar_eig2mkl<MKLTYPE, EIGTYPE>(alpha_, alpha); \ assign_scalar_eig2mkl<MKLTYPE, EIGTYPE>(alpha_, alpha); \

View File

@ -33,6 +33,8 @@
#ifndef EIGEN_TRIANGULAR_SOLVER_MATRIX_MKL_H #ifndef EIGEN_TRIANGULAR_SOLVER_MATRIX_MKL_H
#define EIGEN_TRIANGULAR_SOLVER_MATRIX_MKL_H #define EIGEN_TRIANGULAR_SOLVER_MATRIX_MKL_H
namespace Eigen {
namespace internal { namespace internal {
// implements LeftSide op(triangular)^-1 * general // implements LeftSide op(triangular)^-1 * general
@ -148,4 +150,6 @@ EIGEN_MKL_TRSM_R(scomplex, MKL_Complex8, c)
} // end namespace internal } // end namespace internal
} // end namespace Eigen
#endif // EIGEN_TRIANGULAR_SOLVER_MATRIX_MKL_H #endif // EIGEN_TRIANGULAR_SOLVER_MATRIX_MKL_H

View File

@ -66,7 +66,7 @@ SelfAdjointEigenSolver<Matrix<EIGTYPE, Dynamic, Dynamic, EIGCOLROW> >::compute(c
\ \
lda = matrix.outerStride(); \ lda = matrix.outerStride(); \
matrix_order=MKLCOLROW; \ matrix_order=MKLCOLROW; \
char jobz, uplo='L', range='A'; \ char jobz, uplo='L'/*, range='A'*/; \
jobz = computeEigenvectors ? 'V' : 'N'; \ jobz = computeEigenvectors ? 'V' : 'N'; \
\ \
info = LAPACKE_##MKLNAME( matrix_order, jobz, uplo, n, (MKLTYPE*)m_eivec.data(), lda, (MKLRTYPE*)m_eivalues.data() ); \ info = LAPACKE_##MKLNAME( matrix_order, jobz, uplo, n, (MKLTYPE*)m_eivec.data(), lda, (MKLRTYPE*)m_eivalues.data() ); \

View File

@ -58,7 +58,7 @@ ColPivHouseholderQR<Matrix<EIGTYPE, Dynamic, Dynamic, EIGCOLROW, Dynamic, Dynami
m_hCoeffs.resize(size);\ m_hCoeffs.resize(size);\
\ \
m_colsTranspositions.resize(cols);\ m_colsTranspositions.resize(cols);\
Index number_of_transpositions = 0;\ /*Index number_of_transpositions = 0;*/ \
\ \
m_nonzero_pivots = 0; \ m_nonzero_pivots = 0; \
m_maxpivot = RealScalar(0);\ m_maxpivot = RealScalar(0);\

View File

@ -49,7 +49,7 @@ JacobiSVD<Matrix<EIGTYPE, Dynamic, Dynamic, EIGCOLROW, Dynamic, Dynamic>, ColPiv
typedef MatrixType::RealScalar RealScalar; \ typedef MatrixType::RealScalar RealScalar; \
allocate(matrix.rows(), matrix.cols(), computationOptions); \ allocate(matrix.rows(), matrix.cols(), computationOptions); \
\ \
const RealScalar precision = RealScalar(2) * NumTraits<Scalar>::epsilon(); \ /*const RealScalar precision = RealScalar(2) * NumTraits<Scalar>::epsilon();*/ \
m_nonzeroSingularValues = m_diagSize; \ m_nonzeroSingularValues = m_diagSize; \
\ \
lapack_int lda = matrix.outerStride(), ldu, ldvt; \ lapack_int lda = matrix.outerStride(), ldu, ldvt; \

View File

@ -39,9 +39,7 @@
#if !defined(_WIN32) #if !defined(_WIN32)
#include <dirent.h> #include <dirent.h>
namespace Eigen {
#include "src/SparseExtra/MatrixMarketIterator.h" #include "src/SparseExtra/MatrixMarketIterator.h"
}
#endif #endif
#include "../../Eigen/src/Core/util/ReenableStupidWarnings.h" #include "../../Eigen/src/Core/util/ReenableStupidWarnings.h"

View File

@ -26,6 +26,8 @@
#ifndef EIGEN_SPARSE_MARKET_IO_H #ifndef EIGEN_SPARSE_MARKET_IO_H
#define EIGEN_SPARSE_MARKET_IO_H #define EIGEN_SPARSE_MARKET_IO_H
#include <iostream>
namespace Eigen { namespace Eigen {
namespace internal namespace internal
@ -117,7 +119,7 @@ namespace internal
out << value.real << " " << value.imag()<< "\n"; out << value.real << " " << value.imag()<< "\n";
} }
} } // end namepsace internal
inline bool getMarketHeader(const std::string& filename, int& sym, bool& iscomplex, bool& isvector) inline bool getMarketHeader(const std::string& filename, int& sym, bool& iscomplex, bool& isvector)
{ {

View File

@ -2,7 +2,7 @@
// This file is part of Eigen, a lightweight C++ template library // This file is part of Eigen, a lightweight C++ template library
// for linear algebra. // for linear algebra.
// //
// Copyright (C) 2012 // Copyright (C) 2012 Desire NUENTSA WAKAM <desire.nuentsa_wakam@inria.fr>
// //
// Eigen is free software; you can redistribute it and/or // Eigen is free software; you can redistribute it and/or
// modify it under the terms of the GNU Lesser General Public // modify it under the terms of the GNU Lesser General Public
@ -22,9 +22,12 @@
// You should have received a copy of the GNU Lesser General Public // You should have received a copy of the GNU Lesser General Public
// License and a copy of the GNU General Public License along with // License and a copy of the GNU General Public License along with
// Eigen. If not, see <http://www.gnu.org/licenses/>. // Eigen. If not, see <http://www.gnu.org/licenses/>.
#ifndef EIGEN_BROWSE_MATRICES_H #ifndef EIGEN_BROWSE_MATRICES_H
#define EIGEN_BROWSE_MATRICES_H #define EIGEN_BROWSE_MATRICES_H
namespace Eigen {
enum { enum {
SPD = 0x100, SPD = 0x100,
NonSymmetric = 0x0 NonSymmetric = 0x0
@ -227,4 +230,6 @@ class MatrixMarketIterator
}; };
} // end namespace Eigen
#endif #endif