SciPy-Dev
Threads by month
- ----- 2025 -----
- July
- June
- May
- April
- March
- February
- January
- ----- 2024 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2023 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2022 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2021 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2020 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2019 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2018 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2017 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2016 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2015 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2014 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2013 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2012 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2011 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2010 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2009 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2008 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2007 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2006 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2005 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2004 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2003 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2002 -----
- December
- November
- October
- September
- August
- July
- June
- May
- April
- March
- February
- January
- ----- 2001 -----
- December
- November
- October
- September
- August
- July
- June
August 2006
- 19 participants
- 23 discussions
On Wed, 2 Aug 2006 07:20:30 -0400
Steve Lianoglou <lists.steve(a)arachnedesign.net> wrote:
> Hi Nils et. al,
>
>> is someone able to confirm the output (32bit.png) of
>>test_det.py on a
>> 32-bit machine ?
>> The script is available via
>>
>> http://projects.scipy.org/scipy/scipy/ticket/223
>
> I just ran it on the newest scipy and almost newest
>numpy from svn and my output is the correct one (the
>64bit.png) and I'm running on a 32bit machine (Intel
>Core Duo (MacBook Pro)).
>
>
> No atlas as such, tho I was under the impression I did
>install atlas ... there's even a libatlas.a in my
>/usr/local/lib ... hmm ..
>
> Anyway, scipy/numpy info is pasted below.
>
> -steve
>
>
> In [5]: scipy.__version__
> Out[5]: '0.5.0.2142'
>
> In [6]: scipy.show_config()
> umfpack_info:
> NOT AVAILABLE
>
> dfftw_info:
> libraries = ['drfftw', 'dfftw']
> library_dirs = ['/opt/local/lib']
> define_macros = [('SCIPY_DFFTW_H', None)]
> include_dirs = ['/opt/local/include']
>
> fft_opt_info:
> libraries = ['drfftw', 'dfftw']
> library_dirs = ['/opt/local/lib']
> define_macros = [('SCIPY_DFFTW_H', None)]
> include_dirs = ['/opt/local/include']
>
> djbfft_info:
> NOT AVAILABLE
>
> lapack_opt_info:
> extra_link_args = ['-Wl,-framework',
>'-Wl,Accelerate']
> extra_compile_args = ['-msse3']
> define_macros = [('NO_ATLAS_INFO', 3)]
>
> fftw2_info:
> NOT AVAILABLE
>
> fftw3_info:
> NOT AVAILABLE
>
> blas_opt_info:
> extra_link_args = ['-Wl,-framework',
>'-Wl,Accelerate']
> extra_compile_args = ['-msse3',
>'-I/System/Library/Frameworks/
> vecLib.framework/Headers']
> define_macros = [('NO_ATLAS_INFO', 3)]
>
> =============================
>
>
> In [9]: numpy.__version__
> Out[9]: '1.0b2.dev2940'
>
> In [10]: numpy.show_config()
> lapack_opt_info:
> extra_link_args = ['-Wl,-framework',
>'-Wl,Accelerate']
> extra_compile_args = ['-msse3']
> define_macros = [('NO_ATLAS_INFO', 3)]
>
> blas_opt_info:
> extra_link_args = ['-Wl,-framework',
>'-Wl,Accelerate']
> extra_compile_args = ['-msse3',
>'-I/System/Library/Frameworks/
> vecLib.framework/Headers']
> define_macros = [('NO_ATLAS_INFO', 3)]
>
Thank you all for running the test !
Finally I have disabled ATLAS by
export ATLAS=None
Good news is that I get the correct result.
So I guess it's definitely an ATLAS issue.
Bad news is that
scipy.test(1) results in
FAILED (failures=17, errors=4)
More details below.
Can someone reproduce these failures (No ATLAS) ?
>>> numpy.__version__
'1.0b2.dev2943'
>>> scipy.__version__
'0.5.0.2142'
>>>
======================================================================
ERROR: Compare eigenvalues of eigvals_banded with those of
linalg.eig.
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_decomp.py",
line 270, in check_eigvals_banded
select='i', select_range=(ind1, ind2) )
File
"/usr/lib/python2.4/site-packages/scipy/linalg/decomp.py",
line 381, in eigvals_banded
select_range=select_range)
File
"/usr/lib/python2.4/site-packages/scipy/linalg/decomp.py",
line 362, in eig_banded
if info>0: raise LinAlgError,"eig algorithm did not
converge"
LinAlgError: eig algorithm did not converge
======================================================================
ERROR: check_zero
(scipy.linalg.tests.test_matfuncs.test_expm)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_matfuncs.py",
line 105, in check_zero
assert_array_almost_equal(expm2(a),[[1,0],[0,1]])
File
"/usr/lib/python2.4/site-packages/scipy/linalg/matfuncs.py",
line 71, in expm2
vri = inv(vr)
File
"/usr/lib/python2.4/site-packages/scipy/linalg/basic.py",
line 180, in inv
a1 = asarray_chkfinite(a)
File
"/usr/lib/python2.4/site-packages/numpy/lib/function_base.py",
line 181, in asarray_chkfinite
raise ValueError, "array must not contain infs or
NaNs"
ValueError: array must not contain infs or NaNs
======================================================================
ERROR: check_defective1
(scipy.linalg.tests.test_matfuncs.test_signm)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_matfuncs.py",
line 46, in check_defective1
r = signm(a)
File
"/usr/lib/python2.4/site-packages/scipy/linalg/matfuncs.py",
line 274, in signm
iS0 = inv(S0)
File
"/usr/lib/python2.4/site-packages/scipy/linalg/basic.py",
line 180, in inv
a1 = asarray_chkfinite(a)
File
"/usr/lib/python2.4/site-packages/numpy/lib/function_base.py",
line 181, in asarray_chkfinite
raise ValueError, "array must not contain infs or
NaNs"
ValueError: array must not contain infs or NaNs
======================================================================
ERROR: check_defective3
(scipy.linalg.tests.test_matfuncs.test_signm)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_matfuncs.py",
line 67, in check_defective3
r = signm(a)
File
"/usr/lib/python2.4/site-packages/scipy/linalg/matfuncs.py",
line 274, in signm
iS0 = inv(S0)
File
"/usr/lib/python2.4/site-packages/scipy/linalg/basic.py",
line 180, in inv
a1 = asarray_chkfinite(a)
File
"/usr/lib/python2.4/site-packages/numpy/lib/function_base.py",
line 181, in asarray_chkfinite
raise ValueError, "array must not contain infs or
NaNs"
ValueError: array must not contain infs or NaNs
======================================================================
FAIL: Compare eigenvalues and eigenvectors of eig_banded
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_decomp.py",
line 314, in check_eig_banded
self.w_sym_lin[ind1:ind2+1])
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 199, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(shapes (0,), (5,) mismatch)
x: array([], dtype=float64)
y: array([-0.52994106, -0.43023792, 0.86217766,
1.66090423, 2.84350424])
======================================================================
FAIL: check_simple
(scipy.linalg.tests.test_decomp.test_svdvals)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_decomp.py",
line 508, in check_simple
assert s[0]>=s[1]>=s[2]
AssertionError
======================================================================
FAIL: check_simple_complex
(scipy.linalg.tests.test_decomp.test_svdvals)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_decomp.py",
line 526, in check_simple_complex
assert s[0]>=s[1]>=s[2]
AssertionError
======================================================================
FAIL: check_syevr_irange_high
(scipy.lib.tests.test_lapack.test_flapack_double)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 74, in check_syevr_irange_high
def check_syevr_irange_high(self):
self.check_syevr_irange(irange=[1,2])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 66, in check_syevr_irange
assert_array_almost_equal(w,exact_w[rslice])
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0., 0.])
y: array([ 0.48769389, 9.18223045])
======================================================================
FAIL: check_syevr_irange_low
(scipy.lib.tests.test_lapack.test_flapack_double)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 70, in check_syevr_irange_low
def check_syevr_irange_low(self):
self.check_syevr_irange(irange=[0,1])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 66, in check_syevr_irange
assert_array_almost_equal(w,exact_w[rslice])
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0., 0.])
y: array([-0.66992434, 0.48769389])
======================================================================
FAIL: check_syevr_irange_mid
(scipy.lib.tests.test_lapack.test_flapack_double)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 72, in check_syevr_irange_mid
def check_syevr_irange_mid(self):
self.check_syevr_irange(irange=[1,1])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 66, in check_syevr_irange
assert_array_almost_equal(w,exact_w[rslice])
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0.])
y: array([ 0.48769389])
======================================================================
FAIL: check_syevr_vrange
(scipy.lib.tests.test_lapack.test_flapack_double)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 91, in check_syevr_vrange
assert_array_almost_equal(w,ew)
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 4.5, 4.5, 4.5])
y: array([-0.66992434, 0.48769389, 9.18223045])
======================================================================
FAIL: check_syevr_vrange_high
(scipy.lib.tests.test_lapack.test_flapack_double)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 100, in check_syevr_vrange_high
def check_syevr_vrange_high(self):
self.check_syevr_vrange(vrange=[1,10])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 91, in check_syevr_vrange
assert_array_almost_equal(w,ew)
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 5.5])
y: array([ 9.18223045])
======================================================================
FAIL: check_syevr_vrange_low
(scipy.lib.tests.test_lapack.test_flapack_double)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 96, in check_syevr_vrange_low
def check_syevr_vrange_low(self):
self.check_syevr_vrange(vrange=[-1,1])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 91, in check_syevr_vrange
assert_array_almost_equal(w,ew)
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0., 0.])
y: array([-0.66992434, 0.48769389])
======================================================================
FAIL: check_syevr_vrange_mid
(scipy.lib.tests.test_lapack.test_flapack_double)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 98, in check_syevr_vrange_mid
def check_syevr_vrange_mid(self):
self.check_syevr_vrange(vrange=[0,1])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 91, in check_syevr_vrange
assert_array_almost_equal(w,ew)
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0.5])
y: array([ 0.48769389])
======================================================================
FAIL: check_syevr_irange_high
(scipy.lib.tests.test_lapack.test_flapack_float)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 74, in check_syevr_irange_high
def check_syevr_irange_high(self):
self.check_syevr_irange(irange=[1,2])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 66, in check_syevr_irange
assert_array_almost_equal(w,exact_w[rslice])
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0., 0.], dtype=float32)
y: array([ 0.48769389, 9.18223045])
======================================================================
FAIL: check_syevr_irange_low
(scipy.lib.tests.test_lapack.test_flapack_float)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 70, in check_syevr_irange_low
def check_syevr_irange_low(self):
self.check_syevr_irange(irange=[0,1])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 66, in check_syevr_irange
assert_array_almost_equal(w,exact_w[rslice])
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0., 0.], dtype=float32)
y: array([-0.66992434, 0.48769389])
======================================================================
FAIL: check_syevr_irange_mid
(scipy.lib.tests.test_lapack.test_flapack_float)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 72, in check_syevr_irange_mid
def check_syevr_irange_mid(self):
self.check_syevr_irange(irange=[1,1])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 66, in check_syevr_irange
assert_array_almost_equal(w,exact_w[rslice])
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0.], dtype=float32)
y: array([ 0.48769389])
======================================================================
FAIL: check_syevr_vrange
(scipy.lib.tests.test_lapack.test_flapack_float)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 91, in check_syevr_vrange
assert_array_almost_equal(w,ew)
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 4.5, 4.5, 4.5], dtype=float32)
y: array([-0.66992434, 0.48769389, 9.18223045])
======================================================================
FAIL: check_syevr_vrange_high
(scipy.lib.tests.test_lapack.test_flapack_float)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 100, in check_syevr_vrange_high
def check_syevr_vrange_high(self):
self.check_syevr_vrange(vrange=[1,10])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 91, in check_syevr_vrange
assert_array_almost_equal(w,ew)
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 5.5], dtype=float32)
y: array([ 9.18223045])
======================================================================
FAIL: check_syevr_vrange_low
(scipy.lib.tests.test_lapack.test_flapack_float)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 96, in check_syevr_vrange_low
def check_syevr_vrange_low(self):
self.check_syevr_vrange(vrange=[-1,1])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 91, in check_syevr_vrange
assert_array_almost_equal(w,ew)
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0., 0.], dtype=float32)
y: array([-0.66992434, 0.48769389])
======================================================================
FAIL: check_syevr_vrange_mid
(scipy.lib.tests.test_lapack.test_flapack_float)
----------------------------------------------------------------------
Traceback (most recent call last):
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 98, in check_syevr_vrange_mid
def check_syevr_vrange_mid(self):
self.check_syevr_vrange(vrange=[0,1])
File
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/esv_tests.py",
line 91, in check_syevr_vrange
assert_array_almost_equal(w,ew)
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 230, in assert_array_almost_equal
header='Arrays are not almost equal')
File
"/usr/lib/python2.4/site-packages/numpy/testing/utils.py",
line 215, in assert_array_compare
assert cond, msg
AssertionError:
Arrays are not almost equal
(mismatch 100.0%)
x: array([ 0.5], dtype=float32)
y: array([ 0.48769389])
----------------------------------------------------------------------
Ran 1552 tests in 3.979s
1
0
Hi
The function scipy.interpolate.splprep only returns a tuple of length 2
instead of three. Therefore the splines cannot be evaluated with splev:
---------------
import scipy as S
import scipy.interpolate
x = S.array([[0.,0.,0.],
[1.,1.,0.],
[1.5,0.9,0.5],
[2.,0.,1.],]
)
sp = scipy.interpolate.splprep(x.transpose())
print scipy.interpolate.splev([0.], sp)
---------------
yields
---------------
exceptions.ValueError Traceback (most recent call last)
/home/tinu/projects/lbie/python/<ipython console>
/tmp/python-5096nEG.py
7 [2.,0.,1.],]
8 )
9
10 sp = scipy.interpolate.splprep(x.transpose())
---> 11 print scipy.interpolate.splev([0.], sp)
/usr/lib/python2.4/site-packages/scipy/interpolate/fitpack.py in splev(x, tck, der)
406 representing the curve in N-dimensional space.
407 """
--> 408 t,c,k=tck
409 try:
410 c[0][0]
ValueError: need more than 2 values to unpack
---------------
Thanks, Martin
--
Martin Lüthi answer(a)tnoo.net
1
0
Hi
Sorry to bug the list with bug reports. If someone can point me at a bug
tracking system on scipy.org I would certainly do that. The Scipy homepage is
silent about it, and also searching reveals nothing.
The newest SVN version of scipy gives me an error with markoutercomma.
numpy revision 2942.
scipy revision 2142.
-- Python 2.4.3 (#2, Apr 27 2006, 14:43:58)
[GCC 4.0.3 (Ubuntu 4.0.3-1ubuntu5)] on linux2
==================
...../numeric/scipy$ python setup.py install
building extension "scipy.fftpack._fftpack" sources
f2py options: []
f2py: Lib/fftpack/fftpack.pyf
Traceback (most recent call last):
File "setup.py", line 55, in ?
setup_package()
File "setup.py", line 47, in setup_package
configuration=configuration )
File "/usr/lib/python2.4/site-packages/numpy/distutils/core.py", line 174, in
setup
return old_setup(**new_attr)
File "/usr/lib/python2.4/distutils/core.py", line 149, in setup
dist.run_commands()
File "/usr/lib/python2.4/distutils/dist.py", line 946, in run_commands
self.run_command(cmd)
File "/usr/lib/python2.4/distutils/dist.py", line 966, in run_command
cmd_obj.run()
File "/usr/lib/python2.4/site-packages/numpy/distutils/command/install.py", li
ne 16, in run
r = old_install.run(self)
File "/usr/lib/python2.4/distutils/command/install.py", line 506, in run
self.run_command('build')
File "/usr/lib/python2.4/distutils/cmd.py", line 333, in run_command
self.distribution.run_command(command)
File "/usr/lib/python2.4/distutils/dist.py", line 966, in run_command
cmd_obj.run()
File "/usr/lib/python2.4/distutils/command/build.py", line 112, in run
self.run_command(cmd_name)
File "/usr/lib/python2.4/distutils/cmd.py", line 333, in run_command
self.distribution.run_command(command)
File "/usr/lib/python2.4/distutils/dist.py", line 966, in run_command
cmd_obj.run()
File "/usr/lib/python2.4/site-packages/numpy/distutils/command/build_src.py",
line 87, in run
self.build_sources()
File "/usr/lib/python2.4/site-packages/numpy/distutils/command/build_src.py",
line 106, in build_sources
self.build_extension_sources(ext)
File "/usr/lib/python2.4/site-packages/numpy/distutils/command/build_src.py",
line 218, in build_extension_sources
sources = self.f2py_sources(sources, ext)
File "/usr/lib/python2.4/site-packages/numpy/distutils/command/build_src.py",
line 450, in f2py_sources
import numpy.f2py as f2py2e
File "/usr/lib/python2.4/site-packages/numpy/f2py/__init__.py", line 11, in ?
import f2py2e
File "/usr/lib/python2.4/site-packages/numpy/f2py/f2py2e.py", line 27, in ?
import rules
File "/usr/lib/python2.4/site-packages/numpy/f2py/rules.py", line 66, in ?
import capi_maps
File "/usr/lib/python2.4/site-packages/numpy/f2py/capi_maps.py", line 21, in ?
from crackfortran import markoutercomma
ImportError: cannot import name markoutercomma
==================
Thanks!
Martin Lüthi answer(a)tnoo.net
2
1