[SciPy-user] scipy.test failures=22, errors=3; Looks like i am doing something horribly wrong again.

iCy-fLaME icy.flame.gm at gmail.com
Fri Oct 20 10:20:21 EDT 2006


Any thoughts are appreciated.



Python 2.4.3 (#1, Jun 13 2006, 16:41:18)
[GCC 4.0.2 20051125 (Red Hat 4.0.2-8)] on linux2

>>> import numpy.version
>>> numpy.version.version
'1.0rc3'
>>> import scipy
>>> scipy.version.version
'0.5.1'
>>> scipy.test(level=1)

======================================================================
ERROR: line-search Newton conjugate gradient optimization routine
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/optimize/tests/test_optimize.py",
line 104, in check_ncg
    full_output=False, disp=False, retall=False)
  File "/usr/lib/python2.4/site-packages/scipy/optimize/optimize.py",
line 971, in fmin_ncg
    alphak, fc, gc, old_fval = line_search_BFGS(f,xk,pk,gfk,old_fval)
  File "/usr/lib/python2.4/site-packages/scipy/optimize/optimize.py",
line 535, in line_search_BFGS
    phi_a2 = apply(f,(xk+alpha2*pk,)+args)
  File "/usr/lib/python2.4/site-packages/scipy/optimize/optimize.py",
line 94, in function_wrapper
    return function(x, *args)
  File "/usr/lib/python2.4/site-packages/scipy/optimize/tests/test_optimize.py",
line 31, in func
    raise RuntimeError, "too many iterations in optimization routine"
RuntimeError: too many iterations in optimization routine

======================================================================
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_definition (scipy.fftpack.tests.test_pseudo_diffs.test_diff)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 85, in check_definition
    assert_array_almost_equal(diff(sin(x)),direct_diff(sin(x)))
  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 87.5%)
 x: array([  1.00000000e+00,   9.23879533e-01,   7.07106781e-01,
         3.82683432e-01,   8.80098148e-17,  -3.82683432e-01,
        -7.07106781e-01,  -9.23879533e-01,  -1.00000000e-00,...
 y: array([ -0.00000000e+00,   5.00000000e-01,   7.76627939e-17,
         1.29677356e-16,   1.24900090e-16,   2.16128927e-16,
         1.49721655e-16,  -9.71445147e-17,   0.00000000e+00,...

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_pseudo_diffs.test_hilbert)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 301, in check_definition
    assert_array_almost_equal (y,y1)
  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 87.5%)
 x: array([  1.00000000e+00,   9.23879533e-01,   7.07106781e-01,
         3.82683432e-01,   8.23044233e-17,  -3.82683432e-01,
        -7.07106781e-01,  -9.23879533e-01,  -1.00000000e+00,...
 y: array([ -0.00000000e+00 +0.00000000e+00j,
         5.00000000e-01 -7.31057196e-17j,
         3.88313970e-17 -2.42387134e-17j,...

======================================================================
FAIL: check_random_even (scipy.fftpack.tests.test_pseudo_diffs.test_hilbert)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 332, in check_random_even
    assert_array_almost_equal(direct_hilbert(direct_ihilbert(f)),f)
  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.00000000e+00+0.j        ,  -3.39208538e-04+0.00036363j,
        -1.06020671e-03-0.00021316j,  -5.23844841e-04+0.00028867j,
         3.09111343e-04-0.0020875j ,   7.67990574e-04+0.00133127j,...
 y: array([-0.11060715, -0.49769099,  0.47834226, -0.33737298,  0.24581014,
        0.02109089, -0.4631084 ,  0.19285299,  0.47922014, -0.39063467,
        0.22212061,  0.031721  ,  0.04744712, -0.10681613, -0.04652146,...

======================================================================
FAIL: check_tilbert_relation
(scipy.fftpack.tests.test_pseudo_diffs.test_hilbert)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 311, in check_tilbert_relation
    assert_array_almost_equal (y,y1)
  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 62.5%)
 x: array([  1.00000000e+00,   6.53281482e-01,   2.12809267e-16,
        -2.70598050e-01,  -1.06260199e-16,   2.70598050e-01,
         1.53930800e-16,  -6.53281482e-01,  -1.00000000e+00,...
 y: array([ -0.00000000e+00 +0.00000000e+00j,
         2.50000000e-01 -3.52840045e-17j,
        -1.19052598e-18 +4.47468130e-17j,...

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_pseudo_diffs.test_ihilbert)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 370, in check_definition
    assert_array_almost_equal (y,y1)
  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 87.5%)
 x: array([ -1.00000000e+00,  -9.23879533e-01,  -7.07106781e-01,
        -3.82683432e-01,  -8.23044233e-17,   3.82683432e-01,
         7.07106781e-01,   9.23879533e-01,   1.00000000e+00,...
 y: array([  0.00000000e+00 -0.00000000e+00j,
        -5.00000000e-01 +7.31057196e-17j,
        -3.88313970e-17 +2.42387134e-17j,...

======================================================================
FAIL: check_itilbert_relation
(scipy.fftpack.tests.test_pseudo_diffs.test_ihilbert)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 380, in check_itilbert_relation
    assert_array_almost_equal (y,y1)
  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 62.5%)
 x: array([ -1.00000000e+00,  -6.53281482e-01,  -2.12809267e-16,
         2.70598050e-01,   1.06260199e-16,  -2.70598050e-01,
        -1.53930800e-16,   6.53281482e-01,   1.00000000e+00,...
 y: array([  0.00000000e+00 -0.00000000e+00j,
        -2.50000000e-01 +3.52840045e-17j,
         1.19052598e-18 -4.47468130e-17j,...

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_pseudo_diffs.test_itilbert)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 288, in check_definition
    assert_array_almost_equal (y,y1)
  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 87.5%)
 x: array([ -9.96679946e-02,  -9.20812203e-02,  -7.04759149e-02,
        -3.81412903e-02,  -7.12619106e-18,   3.81412903e-02,
         7.04759149e-02,   9.20812203e-02,   9.96679946e-02,...
 y: array([ -0.00000000e+00 +0.00000000e+00j,
        -4.98339973e-02 +7.28630047e-18j,
        -7.66435941e-18 +4.78412381e-18j,...

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_pseudo_diffs.test_shift)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 390, in check_definition
    assert_array_almost_equal(shift(sin(x),a),direct_shift(sin(x),a))
  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.09983342,  0.19688015,  0.29203083,  0.38436909,  0.47300566,
        0.55708693,  0.63580315,  0.70839623,  0.77416708,  0.83248227,
        0.8827802 ,  0.92457648,  0.95746858,  0.98113973,  0.99536197,...
 y: array([  1.23217883e-17,   4.99167083e-02,   2.46487097e-19,
         8.84658105e-18,   5.94125166e-18,   2.09940707e-17,
         1.47767496e-17,   1.22028436e-17,  -4.63296513e-18,...

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_pseudo_diffs.test_tilbert)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 227, in check_definition
    assert_array_almost_equal (y,y1)
  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 87.5%)
 x: array([  1.00333111e+01,   9.26957080e+00,   7.09462234e+00,
         3.83958194e+00,   1.10138648e-15,  -3.83958194e+00,
        -7.09462234e+00,  -9.26957080e+00,  -1.00333111e+01,...
 y: array([ -0.00000000e+00 +0.00000000e+00j,
         5.01665557e+00 -7.33492430e-16j,
         1.96738867e-16 -1.22805188e-16j,...

======================================================================
FAIL: check_random_even (scipy.fftpack.tests.test_pseudo_diffs.test_tilbert)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_pseudo_diffs.py",
line 240, in check_random_even
    assert_array_almost_equal(direct_tilbert(direct_itilbert(f,h),h),f)
  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.00000000e+00 +0.00000000e+00j,
         1.43984280e-03 +1.83732630e-03j,
        -8.76803558e-04 +9.96589953e-04j,...
 y: array([ 0.50751095, -0.23808924, -0.20386413, -0.30474938, -0.21144356,
        0.45414021, -0.11937844, -0.0768124 , -0.15613727,  0.10529999,
        0.03414752, -0.22981309, -0.38280197,  0.06423689,  0.06691425,...

======================================================================
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'>

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_basic.test_fft)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 99, in check_definition
    assert_array_almost_equal(y,y1)
  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([ 1.+0.j,  2.+0.j,  3.+0.j,  4.+1.j,  1.+0.j,  2.+0.j,  3.+0.j,
        4.+2.j])
 y: array([ 20.        +3.j        ,  -0.70710678+0.70710678j,
        -7.        +4.j        ,  -0.70710678-0.70710678j,
        -4.        -3.j        ,   0.70710678-0.70710678j,
        -1.        -4.j        ,   0.70710678+0.70710678j])

======================================================================
FAIL: check_djbfft (scipy.fftpack.tests.test_basic.test_fft)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 125, in check_djbfft
    assert_array_almost_equal(y,y2)
  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.j,  1.+0.j,  2.+0.j,  3.+0.j])
 y: array([ 6.+0.j, -2.+2.j, -2.+0.j, -2.-2.j])

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_basic.test_fftn)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 380, in check_definition
    assert_array_almost_equal(fftn(x),direct_dftn(x))
  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([[[[  6.00785656e+02 +0.j        ,  -5.43773337e+00 +3.46229661j,
           -1.23088437e+01 -2.42889835j, ...,
           -1.26123816e+01-16.10100662j,  -1.23088437e+01 +2.42889835j,...
 y: array([[[[  1.56754048e+02+0.j        ,  -1.02378379e+00-3.98450277j,
           -5.04603298e+00+0.77949078j, ...,   6.41083848e-01-6.21599229j,
           -5.04603298e+00-0.77949078j,  -1.02378379e+00+3.98450277j],...

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_basic.test_ifft)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 171, in check_definition
    assert_array_almost_equal(y,y1)
  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.125+0.j   ,  0.25 +0.j   ,  0.375+0.j   ,  0.5  +0.125j,
        0.125+0.j   ,  0.25 +0.j   ,  0.375+0.j   ,  0.5  +0.25j ])
 y: array([ 2.5       +0.375j     ,  0.08838835+0.08838835j,
       -0.125     -0.5j       ,  0.08838835-0.08838835j,
       -0.5       -0.375j     , -0.08838835-0.08838835j,
       -0.875     +0.5j       , -0.08838835+0.08838835j])

======================================================================
FAIL: check_djbfft (scipy.fftpack.tests.test_basic.test_ifft)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 187, in check_djbfft
    assert_array_almost_equal(y,y2)
  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.j,  0.25+0.j,  0.5 +0.j,  0.75+0.j])
 y: array([ 1.5+0.j , -0.5-0.5j, -0.5+0.j , -0.5+0.5j])

======================================================================
FAIL: check_random_complex (scipy.fftpack.tests.test_basic.test_ifft)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 195, in check_random_complex
    assert_array_almost_equal (ifft(fft(x)),x)
  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([  9.42894405e-03+0.00342265j,   1.14753943e-02+0.01060178j,
         1.29591488e-03+0.00189321j,   5.93220438e-03+0.00153937j,
         9.05895435e-03+0.00339772j,   1.54679173e-03+0.00557983j,...
 y: array([ 0.60345242+0.21904973j,  0.73442523+0.67851408j,
        0.08293855+0.12116574j,  0.37966108+0.09851944j,
        0.57977308+0.21745381j,  0.09899467+0.35710892j,...

======================================================================
FAIL: check_random_real (scipy.fftpack.tests.test_basic.test_ifft)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 201, in check_random_real
    assert_array_almost_equal (ifft(fft(x)),x)
  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.50529514+0.j        , -0.00891716+0.01194018j,
       -0.05414143-0.0252995j ,  0.03278662+0.02075578j,
        0.04225036+0.04154863j, -0.04497517+0.00314367j,...
 y: array([ 0.65301309,  0.59886448,  0.00535917,  0.42038218,  0.33614078,
        0.25537539,  0.02969843,  0.47543031,  0.75088581,  0.77640457,
        0.60916846,  0.44936911,  0.16806369,  0.67254209,  0.54249481,...

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_basic.test_ifftn)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 541, in check_definition
    assert_array_almost_equal(ifftn(x),direct_idftn(x))
  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.99182623e-01 +0.00000000e+00j,
            9.92310707e-05 -4.45232854e-04j,
            1.38377527e-03 -1.81726474e-03j, ...,...
 y: array([[[[  1.32547471e-01 +0.00000000e+00j,
           -6.49846621e-04 +3.22985157e-03j,
           -1.78142582e-05 -1.17333233e-03j, ...,...

======================================================================
FAIL: check_definition (scipy.fftpack.tests.test_basic.test_irfft)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/fftpack/tests/test_basic.py",
line 303, in check_definition
    assert_array_almost_equal(y,ifft(x1))
  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([ 2.625     , -1.68566017, -0.375     , -1.18566017,  0.625     ,
        0.43566017, -0.375     ,  0.93566017])
 y: array([ 0.125+0.j   ,  0.25 +0.375j,  0.5  +0.125j,  0.25 +0.375j,
        0.5  +0.j   ,  0.25 -0.375j,  0.5  -0.125j,  0.25 -0.375j])

======================================================================
FAIL: check_dot (scipy.lib.tests.test_blas.test_fblas1_simple)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/lib/blas/tests/test_blas.py",
line 76, in check_dot
    assert_almost_equal(f([3j,-4,3-4j],[2,3,1]),-9+2j)
  File "/usr/lib/python2.4/site-packages/numpy/testing/utils.py", line
156, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
 ACTUAL: (2.125+0j)
 DESIRED: (-9+2j)

======================================================================
FAIL: check_dot (scipy.linalg.tests.test_blas.test_fblas1_simple)
----------------------------------------------------------------------
Traceback (most recent call last):
  File "/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_blas.py",
line 75, in check_dot
    assert_almost_equal(f([3j,-4,3-4j],[2,3,1]),-9+2j)
  File "/usr/lib/python2.4/site-packages/numpy/testing/utils.py", line
156, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
 ACTUAL: (2.125+0j)
 DESIRED: (-9+2j)

----------------------------------------------------------------------
Ran 1569 tests in 851.074s

FAILED (failures=22, errors=3)








-- 
iCy-fLaME
------------------------------------------------
The body maybe wounded, but it is the mind that hurts.



More information about the SciPy-User mailing list