summaryrefslogtreecommitdiff
path: root/numpy/polynomial/tests
diff options
context:
space:
mode:
Diffstat (limited to 'numpy/polynomial/tests')
-rw-r--r--numpy/polynomial/tests/test_chebyshev.py4
-rw-r--r--numpy/polynomial/tests/test_classes.py6
-rw-r--r--numpy/polynomial/tests/test_hermite.py5
-rw-r--r--numpy/polynomial/tests/test_hermite_e.py5
-rw-r--r--numpy/polynomial/tests/test_laguerre.py5
-rw-r--r--numpy/polynomial/tests/test_legendre.py5
-rw-r--r--numpy/polynomial/tests/test_polynomial.py5
-rw-r--r--numpy/polynomial/tests/test_polyutils.py5
-rw-r--r--numpy/polynomial/tests/test_printing.py8
9 files changed, 2 insertions, 46 deletions
diff --git a/numpy/polynomial/tests/test_chebyshev.py b/numpy/polynomial/tests/test_chebyshev.py
index f003081cb..439dfa08d 100644
--- a/numpy/polynomial/tests/test_chebyshev.py
+++ b/numpy/polynomial/tests/test_chebyshev.py
@@ -8,7 +8,6 @@ import numpy.polynomial.chebyshev as cheb
from numpy.polynomial.polynomial import polyval
from numpy.testing import (
assert_almost_equal, assert_raises, assert_equal, assert_,
- run_module_suite
)
@@ -609,6 +608,3 @@ class TestMisc(object):
assert_almost_equal(cheb.chebpts2(4), tgt)
tgt = [-1.0, -0.707106781187, 0, 0.707106781187, 1.0]
assert_almost_equal(cheb.chebpts2(5), tgt)
-
-if __name__ == "__main__":
- run_module_suite()
diff --git a/numpy/polynomial/tests/test_classes.py b/numpy/polynomial/tests/test_classes.py
index 896137c9a..262de5fe2 100644
--- a/numpy/polynomial/tests/test_classes.py
+++ b/numpy/polynomial/tests/test_classes.py
@@ -13,7 +13,7 @@ from numpy.polynomial import (
Polynomial, Legendre, Chebyshev, Laguerre, Hermite, HermiteE)
from numpy.testing import (
assert_almost_equal, assert_raises, assert_equal, assert_,
- run_module_suite)
+ )
from numpy.compat import long
@@ -606,7 +606,3 @@ class TestInterpolate(object):
for t in range(0, deg + 1):
p = Chebyshev.interpolate(powx, deg, domain=[0, 2], args=(t,))
assert_almost_equal(p(x), powx(x, t), decimal=12)
-
-
-if __name__ == "__main__":
- run_module_suite()
diff --git a/numpy/polynomial/tests/test_hermite.py b/numpy/polynomial/tests/test_hermite.py
index 08b0a883a..18c26af8f 100644
--- a/numpy/polynomial/tests/test_hermite.py
+++ b/numpy/polynomial/tests/test_hermite.py
@@ -8,7 +8,6 @@ import numpy.polynomial.hermite as herm
from numpy.polynomial.polynomial import polyval
from numpy.testing import (
assert_almost_equal, assert_raises, assert_equal, assert_,
- run_module_suite
)
H0 = np.array([1])
@@ -545,7 +544,3 @@ class TestMisc(object):
tgt = np.exp(-x**2)
res = herm.hermweight(x)
assert_almost_equal(res, tgt)
-
-
-if __name__ == "__main__":
- run_module_suite()
diff --git a/numpy/polynomial/tests/test_hermite_e.py b/numpy/polynomial/tests/test_hermite_e.py
index ab05a2a21..58d74dae9 100644
--- a/numpy/polynomial/tests/test_hermite_e.py
+++ b/numpy/polynomial/tests/test_hermite_e.py
@@ -8,7 +8,6 @@ import numpy.polynomial.hermite_e as herme
from numpy.polynomial.polynomial import polyval
from numpy.testing import (
assert_almost_equal, assert_raises, assert_equal, assert_,
- run_module_suite
)
He0 = np.array([1])
@@ -546,7 +545,3 @@ class TestMisc(object):
tgt = np.exp(-.5*x**2)
res = herme.hermeweight(x)
assert_almost_equal(res, tgt)
-
-
-if __name__ == "__main__":
- run_module_suite()
diff --git a/numpy/polynomial/tests/test_laguerre.py b/numpy/polynomial/tests/test_laguerre.py
index c6b01ff7e..3cb630e46 100644
--- a/numpy/polynomial/tests/test_laguerre.py
+++ b/numpy/polynomial/tests/test_laguerre.py
@@ -8,7 +8,6 @@ import numpy.polynomial.laguerre as lag
from numpy.polynomial.polynomial import polyval
from numpy.testing import (
assert_almost_equal, assert_raises, assert_equal, assert_,
- run_module_suite
)
L0 = np.array([1])/1
@@ -527,7 +526,3 @@ class TestMisc(object):
tgt = np.exp(-x)
res = lag.lagweight(x)
assert_almost_equal(res, tgt)
-
-
-if __name__ == "__main__":
- run_module_suite()
diff --git a/numpy/polynomial/tests/test_legendre.py b/numpy/polynomial/tests/test_legendre.py
index 8547c9039..aeecd8775 100644
--- a/numpy/polynomial/tests/test_legendre.py
+++ b/numpy/polynomial/tests/test_legendre.py
@@ -8,7 +8,6 @@ import numpy.polynomial.legendre as leg
from numpy.polynomial.polynomial import polyval
from numpy.testing import (
assert_almost_equal, assert_raises, assert_equal, assert_,
- run_module_suite
)
L0 = np.array([1])
@@ -546,7 +545,3 @@ class TestMisc(object):
tgt = 1.
res = leg.legweight(x)
assert_almost_equal(res, tgt)
-
-
-if __name__ == "__main__":
- run_module_suite()
diff --git a/numpy/polynomial/tests/test_polynomial.py b/numpy/polynomial/tests/test_polynomial.py
index 370fbd616..67728e35e 100644
--- a/numpy/polynomial/tests/test_polynomial.py
+++ b/numpy/polynomial/tests/test_polynomial.py
@@ -7,7 +7,6 @@ import numpy as np
import numpy.polynomial.polynomial as poly
from numpy.testing import (
assert_almost_equal, assert_raises, assert_equal, assert_,
- run_module_suite
)
@@ -566,7 +565,3 @@ class TestMisc(object):
def test_polyline(self):
assert_equal(poly.polyline(3, 4), [3, 4])
-
-
-if __name__ == "__main__":
- run_module_suite()
diff --git a/numpy/polynomial/tests/test_polyutils.py b/numpy/polynomial/tests/test_polyutils.py
index bd1cb2008..32ea55716 100644
--- a/numpy/polynomial/tests/test_polyutils.py
+++ b/numpy/polynomial/tests/test_polyutils.py
@@ -7,7 +7,6 @@ import numpy as np
import numpy.polynomial.polyutils as pu
from numpy.testing import (
assert_almost_equal, assert_raises, assert_equal, assert_,
- run_module_suite
)
@@ -104,7 +103,3 @@ class TestDomain(object):
tgt = [-1 + 1j, 1 - 1j]
res = pu.mapparms(dom1, dom2)
assert_almost_equal(res, tgt)
-
-
-if __name__ == "__main__":
- run_module_suite()
diff --git a/numpy/polynomial/tests/test_printing.py b/numpy/polynomial/tests/test_printing.py
index 939d48a86..3f1236402 100644
--- a/numpy/polynomial/tests/test_printing.py
+++ b/numpy/polynomial/tests/test_printing.py
@@ -1,7 +1,7 @@
from __future__ import division, absolute_import, print_function
import numpy.polynomial as poly
-from numpy.testing import run_module_suite, assert_equal
+from numpy.testing import assert_equal
class TestStr(object):
@@ -66,9 +66,3 @@ class TestRepr(object):
res = repr(poly.Laguerre([0, 1]))
tgt = 'Laguerre([0., 1.], domain=[0, 1], window=[0, 1])'
assert_equal(res, tgt)
-
-
-#
-
-if __name__ == "__main__":
- run_module_suite()