[SciPy-user] Error with 0.5.1 tests

Willi Richert w.richert at gmx.net
Tue Oct 24 04:12:06 EDT 2006


Hi,

I installed numpy-1.0rc3 and scipy. At the python shell I did scipy.test() and got:

======================================================================
ERROR: Solve: single precision complex
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/linsolve/umfpack/tests/test_umfpack.py", line 25, in check_solve_complex_without_umfpack
    x = linsolve.spsolve(a, b)
  File "/usr/lib/python2.4/site-packages/scipy/linsolve/linsolve.py", line 76, in spsolve
    return gssv(N, lastel, data, index0, index1, b, csc, permc_spec)[0]
TypeError: array cannot be safely cast to required type

======================================================================
ERROR: check loadmat case cellnest
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/io/tests/test_mio.py", line 80, in cc
    self._check_case(name, expected)
  File "/usr/lib/python2.4/site-packages/scipy/io/tests/test_mio.py", line 75, in _check_case
    self._check_level(k_label, expected, matdict[k])
  File "/usr/lib/python2.4/site-packages/scipy/io/tests/test_mio.py", line 33, in _check_level
    self._check_level(level_label, ev, actual[i])
  File "/usr/lib/python2.4/site-packages/scipy/io/tests/test_mio.py", line 33, in _check_level
    self._check_level(level_label, ev, actual[i])
  File "/usr/lib/python2.4/site-packages/scipy/io/tests/test_mio.py", line 33, in _check_level
    self._check_level(level_label, ev, actual[i])
  File "/usr/lib/python2.4/site-packages/scipy/io/tests/test_mio.py", line 30, in _check_level
    assert len(expected) == len(actual), "Different list lengths at %s" % label
TypeError: len() of unsized object

======================================================================
FAIL: check_rvs (scipy.stats.tests.test_distributions.test_randint)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/stats/tests/test_distributions.py", line 84, in check_rvs
    assert isinstance(val, numpy.ScalarType),`type(val)`
AssertionError: <type 'numpy.ndarray'>

----------------------------------------------------------------------
Ran 1569 tests in 4.551s

FAILED (failures=1, errors=2)

Any hints?
wr

PS: Here is the output head of "python setup.py install":
fft_opt_info:
fftw3_info:
  libraries fftw3 not found in /usr/local/lib
  libraries fftw3 not found in /usr/lib
  fftw3 not found
  NOT AVAILABLE

fftw2_info:
  libraries rfftw,fftw not found in /usr/local/lib
  libraries rfftw,fftw not found in /usr/lib
  fftw2 not found
  NOT AVAILABLE

dfftw_info:
  libraries drfftw,dfftw not found in /usr/local/lib
  libraries drfftw,dfftw not found in /usr/lib
  dfftw not found
  NOT AVAILABLE

djbfft_info:
  NOT AVAILABLE

  NOT AVAILABLE

blas_opt_info:
blas_mkl_info:
  libraries mkl,vml,guide not found in /usr/local/lib
  libraries mkl,vml,guide not found in /usr/lib
  NOT AVAILABLE

atlas_blas_threads_info:
Setting PTATLAS=ATLAS
  libraries lapack,blas not found in /usr/local/lib
Setting PTATLAS=ATLAS
Setting PTATLAS=ATLAS
  FOUND:
    libraries = ['lapack', 'blas']
    library_dirs = ['/usr/lib/atlas']
    language = c
    include_dirs = ['/usr/include']

Could not locate executable gfortran
Could not locate executable f95
customize GnuFCompiler
customize GnuFCompiler
customize GnuFCompiler using config
compiling '_configtest.c':

/* This file is generated from numpy_distutils/system_info.py */
void ATL_buildinfo(void);
int main(void) {
  ATL_buildinfo();
  return 0;
}
C compiler: gcc -pthread -fno-strict-aliasing -DNDEBUG -g -O3 -Wall -Wstrict-prototypes -fPIC

compile options: '-c'
gcc: _configtest.c
gcc -pthread _configtest.o -L/usr/lib/atlas -llapack -lblas -o _configtest
ATLAS version 3.6.0 built by camm on Tue Jun 15 03:19:44 UTC 2004:
   UNAME    : Linux intech131 2.4.20 #1 SMP Thu Jan 23 11:24:05 EST 2003 i686 GNU/Linux
   INSTFLG  :
   MMDEF    :
   ARCHDEF  :
   F2CDEFS  : -DAdd__ -DStringSunStyle
   CACHEEDGE: 196608
   F77      : /usr/bin/g77, version GNU Fortran (GCC) 3.3.5 (Debian 1:3.3.5-1)
   F77FLAGS : -O
   CC       : /usr/bin/gcc, version gcc (GCC) 3.3.5 (Debian 1:3.3.5-1)
   CC FLAGS : -fomit-frame-pointer -O3 -funroll-all-loops
   MCC      : /usr/bin/gcc, version gcc (GCC) 3.3.5 (Debian 1:3.3.5-1)
   MCCFLAGS : -fomit-frame-pointer -O
success!
removing: _configtest.c _configtest.o _configtest
  FOUND:
    libraries = ['lapack', 'blas']
    library_dirs = ['/usr/lib/atlas']
    language = c
    define_macros = [('ATLAS_INFO', '"\\"3.6.0\\""')]
    include_dirs = ['/usr/include']

ATLAS version 3.6.0
lapack_opt_info:
lapack_mkl_info:
mkl_info:
  libraries mkl,vml,guide not found in /usr/local/lib
  libraries mkl,vml,guide not found in /usr/lib
  NOT AVAILABLE

  NOT AVAILABLE

atlas_threads_info:
Setting PTATLAS=ATLAS
  libraries lapack,blas not found in /usr/local/lib
  libraries lapack_atlas not found in /usr/local/lib
  libraries lapack_atlas not found in /usr/lib/atlas
numpy.distutils.system_info.atlas_threads_info
Setting PTATLAS=ATLAS
Setting PTATLAS=ATLAS
  FOUND:
    libraries = ['lapack', 'lapack', 'blas']
    library_dirs = ['/usr/lib/atlas']
    language = f77
    include_dirs = ['/usr/include']

customize GnuFCompiler
customize GnuFCompiler
customize GnuFCompiler using config
compiling '_configtest.c':

/* This file is generated from numpy_distutils/system_info.py */
void ATL_buildinfo(void);
int main(void) {
  ATL_buildinfo();
  return 0;
}
C compiler: gcc -pthread -fno-strict-aliasing -DNDEBUG -g -O3 -Wall -Wstrict-prototypes -fPIC

compile options: '-c'
gcc: _configtest.c
gcc -pthread _configtest.o -L/usr/lib/atlas -llapack -llapack -lblas -o _configtest
ATLAS version 3.6.0 built by camm on Tue Jun 15 03:19:44 UTC 2004:
   UNAME    : Linux intech131 2.4.20 #1 SMP Thu Jan 23 11:24:05 EST 2003 i686 GNU/Linux
   INSTFLG  :
   MMDEF    :
   ARCHDEF  :
   F2CDEFS  : -DAdd__ -DStringSunStyle
   CACHEEDGE: 196608
   F77      : /usr/bin/g77, version GNU Fortran (GCC) 3.3.5 (Debian 1:3.3.5-1)
   F77FLAGS : -O
   CC       : /usr/bin/gcc, version gcc (GCC) 3.3.5 (Debian 1:3.3.5-1)
   CC FLAGS : -fomit-frame-pointer -O3 -funroll-all-loops
   MCC      : /usr/bin/gcc, version gcc (GCC) 3.3.5 (Debian 1:3.3.5-1)
   MCCFLAGS : -fomit-frame-pointer -O
success!
removing: _configtest.c _configtest.o _configtest
  FOUND:
    libraries = ['lapack', 'lapack', 'blas']
    library_dirs = ['/usr/lib/atlas']
    language = f77
    define_macros = [('ATLAS_INFO', '"\\"3.6.0\\""')]
    include_dirs = ['/usr/include']

ATLAS version 3.6.0
ATLAS version 3.6.0
non-existing path in 'Lib/linsolve': 'tests'
umfpack_info:
  libraries umfpack not found in /usr/local/lib
  libraries umfpack not found in /usr/lib
/usr/lib/python2.4/site-packages/numpy/distutils/system_info.py:401: UserWarning:
    UMFPACK sparse solver (http://www.cise.ufl.edu/research/sparse/umfpack/)
    not found. Directories to search for the libraries can be specified in the
    numpy/distutils/site.cfg file (section [umfpack]) or by setting
    the UMFPACK environment variable.
  warnings.warn(self.notfounderror.__doc__)
  NOT AVAILABLE

non-existing path in 'Lib/maxentropy': 'doc'
Warning: Subpackage 'Lib' configuration returned as 'scipy'
running install
running build
running config_fc
running build_src
...



More information about the SciPy-User mailing list