Skip to content

Commit

Permalink
Remove unused imports.
Browse files Browse the repository at this point in the history
Imports in tests that hint at untested functionality were left in place.
  • Loading branch information
cbrueffer authored and peterjc committed Dec 17, 2012
1 parent 509ee43 commit c24a0b9
Show file tree
Hide file tree
Showing 38 changed files with 8 additions and 53 deletions.
2 changes: 0 additions & 2 deletions Bio/Graphics/Distribution.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -11,7 +11,6 @@
import math import math


# reportlab # reportlab
from reportlab.pdfgen import canvas
from reportlab.lib.pagesizes import letter from reportlab.lib.pagesizes import letter
from reportlab.lib.units import inch from reportlab.lib.units import inch
from reportlab.lib import colors from reportlab.lib import colors
Expand All @@ -20,7 +19,6 @@
from reportlab.graphics.charts.barcharts import VerticalBarChart from reportlab.graphics.charts.barcharts import VerticalBarChart
from reportlab.graphics.charts.barcharts import BarChartProperties from reportlab.graphics.charts.barcharts import BarChartProperties
from reportlab.graphics.widgetbase import TypedPropertyCollection from reportlab.graphics.widgetbase import TypedPropertyCollection
from reportlab.graphics import renderPDF, renderPS


from Bio.Graphics import _write from Bio.Graphics import _write


Expand Down
5 changes: 0 additions & 5 deletions Bio/Graphics/GenomeDiagram/_Diagram.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -29,22 +29,17 @@
# IMPORTS # IMPORTS


# ReportLab # ReportLab
from reportlab.graphics import renderPS, renderPDF, renderSVG
try: try:
from reportlab.graphics import renderPM from reportlab.graphics import renderPM
except ImportError: except ImportError:
#This is an optional part of ReportLab, so may not be installed. #This is an optional part of ReportLab, so may not be installed.
renderPM=None renderPM=None
from reportlab.lib import pagesizes


# GenomeDiagram # GenomeDiagram
from _LinearDrawer import LinearDrawer from _LinearDrawer import LinearDrawer
from _CircularDrawer import CircularDrawer from _CircularDrawer import CircularDrawer
from _Track import Track from _Track import Track


# Builtins
import sys

from Bio.Graphics import _write from Bio.Graphics import _write


#------------------------------------------------------------------------------ #------------------------------------------------------------------------------
Expand Down
1 change: 0 additions & 1 deletion Bio/Motif/TRANSFAC.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -12,7 +12,6 @@
warnings.warn("Bio.Motif.TRANSFAC is experimental code. While it is usable, \ warnings.warn("Bio.Motif.TRANSFAC is experimental code. While it is usable, \
the code is subject to change without warning", BiopythonExperimentalWarning) the code is subject to change without warning", BiopythonExperimentalWarning)


import string
from Bio.Motif import Motif as BaseMotif from Bio.Motif import Motif as BaseMotif




Expand Down
1 change: 0 additions & 1 deletion Scripts/scop_pdb.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -8,7 +8,6 @@


import getopt import getopt
import sys import sys
import types
import urllib import urllib


from Bio.SCOP import * from Bio.SCOP import *
Expand Down
2 changes: 0 additions & 2 deletions Tests/test_Ace.py
Original file line number Original file line Diff line number Diff line change
@@ -1,5 +1,3 @@
import os
import sys
import unittest import unittest


from Bio.Sequencing import Ace from Bio.Sequencing import Ace
Expand Down
1 change: 0 additions & 1 deletion Tests/test_BioSQL_MySQLdb.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -4,7 +4,6 @@
# as part of this package. # as part of this package.


"""Run BioSQL tests using SQLite""" """Run BioSQL tests using SQLite"""
import os
from Bio import MissingExternalDependencyError from Bio import MissingExternalDependencyError
from BioSQL import BioSeqDatabase from BioSQL import BioSeqDatabase


Expand Down
1 change: 0 additions & 1 deletion Tests/test_BioSQL_psycopg2.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -4,7 +4,6 @@
# as part of this package. # as part of this package.


"""Run BioSQL tests using SQLite""" """Run BioSQL tests using SQLite"""
import os
from Bio import MissingExternalDependencyError from Bio import MissingExternalDependencyError
from BioSQL import BioSeqDatabase from BioSQL import BioSeqDatabase


Expand Down
3 changes: 0 additions & 3 deletions Tests/test_Chi2.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -4,9 +4,6 @@
# as part of this package. # as part of this package.


import unittest import unittest
import os
import os.path
import sys
from Bio.Phylo.PAML import chi2 from Bio.Phylo.PAML import chi2




Expand Down
2 changes: 1 addition & 1 deletion Tests/test_CodonTable.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -6,7 +6,7 @@
from Bio.Data import IUPACData from Bio.Data import IUPACData
from Bio.Data.CodonTable import ambiguous_generic_by_id, ambiguous_generic_by_name from Bio.Data.CodonTable import ambiguous_generic_by_id, ambiguous_generic_by_name
from Bio.Data.CodonTable import ambiguous_rna_by_id, ambiguous_dna_by_id from Bio.Data.CodonTable import ambiguous_rna_by_id, ambiguous_dna_by_id
from Bio.Data.CodonTable import unambiguous_rna_by_id, unambiguous_dna_by_id from Bio.Data.CodonTable import unambiguous_rna_by_id
from Bio.Data.CodonTable import list_ambiguous_codons, TranslationError from Bio.Data.CodonTable import list_ambiguous_codons, TranslationError


#Check the extension of stop codons to include well defined ambiguous ones #Check the extension of stop codons to include well defined ambiguous ones
Expand Down
1 change: 0 additions & 1 deletion Tests/test_Crystal.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -6,7 +6,6 @@
# python unittest framework # python unittest framework
import unittest import unittest
import copy import copy
import sys


# modules to be tested # modules to be tested
from Bio.Crystal import Hetero, Chain, Crystal, CrystalError from Bio.Crystal import Hetero, Chain, Crystal, CrystalError
Expand Down
1 change: 0 additions & 1 deletion Tests/test_Dialign_tool.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -8,7 +8,6 @@
import sys import sys
import os import os
import unittest import unittest
import subprocess
from Bio import MissingExternalDependencyError from Bio import MissingExternalDependencyError
from Bio.Align.Applications import DialignCommandline from Bio.Align.Applications import DialignCommandline


Expand Down
1 change: 0 additions & 1 deletion Tests/test_EmbossPhylipNew.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -6,7 +6,6 @@
import os import os
import sys import sys
import unittest import unittest
import subprocess


from Bio import MissingExternalDependencyError from Bio import MissingExternalDependencyError
from Bio import AlignIO from Bio import AlignIO
Expand Down
1 change: 0 additions & 1 deletion Tests/test_EmbossPrimer.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -2,7 +2,6 @@
"""Tests for Primer-based programs in the Emboss suite. """Tests for Primer-based programs in the Emboss suite.
""" """
# standard library # standard library
import sys
import os import os
import unittest import unittest


Expand Down
3 changes: 1 addition & 2 deletions Tests/test_FSSP.py
Original file line number Original file line Diff line number Diff line change
@@ -1,9 +1,8 @@
from Bio import FSSP, Align from Bio import FSSP
from Bio.FSSP import FSSPTools from Bio.FSSP import FSSPTools
import sys import sys
import os import os
import cPickle import cPickle
import time


test_file = os.path.join('FSSP', '1cnv.fssp') test_file = os.path.join('FSSP', '1cnv.fssp')
f = sys.stdout f = sys.stdout
Expand Down
2 changes: 0 additions & 2 deletions Tests/test_GAQueens.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -18,9 +18,7 @@
""" """
# standard library # standard library
import sys import sys
import math
import random import random
import copy
import time import time
import unittest import unittest


Expand Down
1 change: 0 additions & 1 deletion Tests/test_HotRand.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -2,7 +2,6 @@
"""Tests HotRand. """Tests HotRand.
""" """
# standard library # standard library
import sys
import unittest import unittest


# local stuff # local stuff
Expand Down
1 change: 0 additions & 1 deletion Tests/test_LogisticRegression.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -15,7 +15,6 @@
"Install NumPy if you want to use Bio.LogisticRegression.") "Install NumPy if you want to use Bio.LogisticRegression.")


import unittest import unittest
import sys
from Bio import LogisticRegression from Bio import LogisticRegression




Expand Down
2 changes: 0 additions & 2 deletions Tests/test_MMCIF.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -9,8 +9,6 @@


"""Unit tests for the MMCIF portion of the Bio.PDB module.""" """Unit tests for the MMCIF portion of the Bio.PDB module."""


import os
import tempfile
import unittest import unittest
import warnings import warnings


Expand Down
1 change: 0 additions & 1 deletion Tests/test_Medline.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -3,7 +3,6 @@
# license. Please see the LICENSE file that should have been included # license. Please see the LICENSE file that should have been included
# as part of this package. # as part of this package.


import sys
import unittest import unittest


from Bio import Medline from Bio import Medline
Expand Down
1 change: 0 additions & 1 deletion Tests/test_NCBI_qblast.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -12,7 +12,6 @@
Make sure that all retrieval is working as expected. Make sure that all retrieval is working as expected.
Make sure we can parse the latest XML format being used by the NCBI. Make sure we can parse the latest XML format being used by the NCBI.
""" """
import sys
import requires_internet import requires_internet
requires_internet.check() requires_internet.check()
from Bio import MissingExternalDependencyError from Bio import MissingExternalDependencyError
Expand Down
1 change: 0 additions & 1 deletion Tests/test_PAML_baseml.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -6,7 +6,6 @@
import unittest import unittest
import os import os
import os.path import os.path
import sys
from Bio.Phylo.PAML import baseml from Bio.Phylo.PAML import baseml
from Bio.Phylo.PAML._paml import PamlError from Bio.Phylo.PAML._paml import PamlError


Expand Down
1 change: 0 additions & 1 deletion Tests/test_ParserSupport.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -4,7 +4,6 @@
# as part of this package. # as part of this package.


import string import string
import sys
from Bio import File from Bio import File
from Bio import ParserSupport from Bio import ParserSupport


Expand Down
1 change: 0 additions & 1 deletion Tests/test_Pathway.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -5,7 +5,6 @@


# python unittest framework # python unittest framework
import unittest import unittest
import sys


# modules to be tested # modules to be tested
from Bio.Pathway import Reaction from Bio.Pathway import Reaction
Expand Down
1 change: 0 additions & 1 deletion Tests/test_PopGen_DFDist.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -3,7 +3,6 @@
# license. Please see the LICENSE file that should have been included # license. Please see the LICENSE file that should have been included
# as part of this package. # as part of this package.


import commands
import os import os
import shutil import shutil
import tempfile import tempfile
Expand Down
1 change: 0 additions & 1 deletion Tests/test_PopGen_FDist.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -3,7 +3,6 @@
# license. Please see the LICENSE file that should have been included # license. Please see the LICENSE file that should have been included
# as part of this package. # as part of this package.


import commands
import os import os
import shutil import shutil
import tempfile import tempfile
Expand Down
1 change: 0 additions & 1 deletion Tests/test_Prank_tool.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -9,7 +9,6 @@
import sys import sys
import os import os
import unittest import unittest
import subprocess
from Bio import AlignIO from Bio import AlignIO
from Bio import SeqIO from Bio import SeqIO
from Bio import MissingExternalDependencyError from Bio import MissingExternalDependencyError
Expand Down
1 change: 0 additions & 1 deletion Tests/test_Probcons_tool.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -7,7 +7,6 @@
import sys import sys
import os import os
import unittest import unittest
import subprocess
from cStringIO import StringIO from cStringIO import StringIO
from Bio import AlignIO, SeqIO, MissingExternalDependencyError from Bio import AlignIO, SeqIO, MissingExternalDependencyError
from Bio.Align.Applications import ProbconsCommandline from Bio.Align.Applications import ProbconsCommandline
Expand Down
2 changes: 1 addition & 1 deletion Tests/test_SearchIO_blast_tab.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -11,7 +11,7 @@
import os import os
import unittest import unittest


from Bio.SearchIO import parse, read from Bio.SearchIO import parse


# test case files are in the Blast directory # test case files are in the Blast directory
TEST_DIR = 'Blast' TEST_DIR = 'Blast'
Expand Down
2 changes: 1 addition & 1 deletion Tests/test_SearchIO_blast_xml.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@
import os import os
import unittest import unittest


from Bio.SearchIO import parse, read from Bio.SearchIO import parse


# test case files are in the Blast directory # test case files are in the Blast directory
TEST_DIR = 'Blast' TEST_DIR = 'Blast'
Expand Down
2 changes: 1 addition & 1 deletion Tests/test_SearchIO_hmmer3_domtab.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@
import os import os
import unittest import unittest


from Bio.SearchIO import parse, read from Bio.SearchIO import parse


# test case files are in the Blast directory # test case files are in the Blast directory
TEST_DIR = 'Hmmer' TEST_DIR = 'Hmmer'
Expand Down
2 changes: 1 addition & 1 deletion Tests/test_SearchIO_hmmer3_tab.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@
import os import os
import unittest import unittest


from Bio.SearchIO import parse, read from Bio.SearchIO import parse


# test case files are in the Blast directory # test case files are in the Blast directory
TEST_DIR = 'Hmmer' TEST_DIR = 'Hmmer'
Expand Down
2 changes: 1 addition & 1 deletion Tests/test_SearchIO_hmmer3_text.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@
import os import os
import unittest import unittest


from Bio.SearchIO import parse, read from Bio.SearchIO import parse


# test case files are in the Blast directory # test case files are in the Blast directory
TEST_DIR = 'Hmmer' TEST_DIR = 'Hmmer'
Expand Down
4 changes: 1 addition & 3 deletions Tests/test_SeqIO_AbiIO.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -8,9 +8,7 @@
from os.path import join, basename from os.path import join, basename


from Bio import SeqIO from Bio import SeqIO
from Bio.Seq import Seq from Bio._py3k import _as_bytes
from Bio.SeqRecord import SeqRecord
from Bio._py3k import _bytes_to_string, _as_bytes


test_data = { test_data = {
'data_empty': { 'data_empty': {
Expand Down
1 change: 0 additions & 1 deletion Tests/test_SeqIO_convert.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -4,7 +4,6 @@
# as part of this package. # as part of this package.


"""Unit tests for Bio.SeqIO.convert(...) function.""" """Unit tests for Bio.SeqIO.convert(...) function."""
import os
import unittest import unittest
import warnings import warnings
from Bio.Seq import UnknownSeq from Bio.Seq import UnknownSeq
Expand Down
2 changes: 0 additions & 2 deletions Tests/test_TCoffee_tool.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -7,8 +7,6 @@
import sys import sys
import os import os
import unittest import unittest
import subprocess
from cStringIO import StringIO
from Bio import AlignIO, SeqIO, MissingExternalDependencyError from Bio import AlignIO, SeqIO, MissingExternalDependencyError
from Bio.Align.Applications import TCoffeeCommandline from Bio.Align.Applications import TCoffeeCommandline


Expand Down
2 changes: 0 additions & 2 deletions Tests/test_TogoWS.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -5,9 +5,7 @@


"""Testing Bio.TogoWS online code. """Testing Bio.TogoWS online code.
""" """
import sys
import unittest import unittest
import urllib
from StringIO import StringIO from StringIO import StringIO


import requires_internet import requires_internet
Expand Down
1 change: 0 additions & 1 deletion Tests/test_Uniprot.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -2,7 +2,6 @@
"""Test for the Uniprot parser on Uniprot XML files. """Test for the Uniprot parser on Uniprot XML files.
""" """
import os import os
import copy
import unittest import unittest


from Bio import SeqIO from Bio import SeqIO
Expand Down
1 change: 0 additions & 1 deletion Tests/test_XXmotif_tool.py
Original file line number Original file line Diff line number Diff line change
Expand Up @@ -10,7 +10,6 @@
import sys import sys
import unittest import unittest
from Bio import MissingExternalDependencyError from Bio import MissingExternalDependencyError
from Bio import Motif
from Bio import SeqIO from Bio import SeqIO
from Bio.Application import ApplicationError from Bio.Application import ApplicationError
from Bio.Motif.Applications import XXmotifCommandline from Bio.Motif.Applications import XXmotifCommandline
Expand Down

0 comments on commit c24a0b9

Please sign in to comment.