D:\Dev\Compile\Biopython\biopython-1.53>X:\Python26-x64\python.exe setup.py test running test test_Ace ... ok test_AlignIO ... ok test_AlignIO_convert ... ok test_BioSQL ... D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\BioSQL\Loader.py:797: UserWarning: order location operators are not fully supported % feature.location_operator) ok test_BioSQL_SeqIO ... D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\BioSQL\Loader.py:797: UserWarning: bond location operators are not fully supported % feature.location_operator) ok test_CAPS ... ok test_Clustalw ... ok test_Clustalw_tool ... skipping. Install clustalw or clustalw2 if you want to use Bio.Clustalw. test_Cluster ... ok test_CodonTable ... ok test_CodonUsage ... ok test_Compass ... ok test_Crystal ... ok test_Dialign_tool ... skipping. DIALIGN2-2 not available on Windows test_DocSQL ... ok test_Emboss ... skipping. Install EMBOSS if you want to use Bio.Emboss. test_EmbossPhylipNew ... skipping. Install the Emboss package 'Phylip New' if you want to use the Bio.Emboss.Applications wrappers for phylogenetic tools test_EmbossPrimer ... ok test_Entrez ... ok test_Enzyme ... ok test_FSSP ... ok test_Fasta ... ok test_File ... ok test_GACrossover ... ok test_GAMutation ... ok test_GAOrganism ... ok test_GAQueens ... ok test_GARepair ... ok test_GASelection ... ok test_GFF ... skipping. Environment is not configured for this test (not important if you do not plan to use Bio.GFF). test_GFF2 ... ok test_GenBank ... ok test_GenomeDiagram ... ok test_GraphicsBitmaps ... Warn: Can't find .pfb for face 'Times-Roman' FAIL test_GraphicsChromosome ... ok test_GraphicsDistribution ... ok test_GraphicsGeneral ... ok test_HMMCasino ... ok test_HMMGeneral ... ok test_HotRand ... ok test_IsoelectricPoint ... ok test_KDTree ... ok test_KEGG ... ok test_KeyWList ... ok test_Location ... ok test_LocationParser ... ok test_LogisticRegression ... ok test_MEME ... ok test_Mafft_tool ... skipping. Testing with MAFFT not implemented on Windows yet test_MarkovModel ... ok test_Medline ... ok test_Motif ... ok test_Muscle_tool ... skipping. Install MUSCLE if you want to use the Bio.Align.Applications wrapper. test_NCBIStandalone ... ok test_NCBITextParser ... ok test_NCBIXML ... ok test_NCBI_BLAST_tools ... ok test_NCBI_qblast ... ok test_NNExclusiveOr ... ok test_NNGene ... ok test_NNGeneral ... ok test_Nexus ... ok test_PDB ... ok test_PDB_unit ... ok test_ParserSupport ... ok test_Pathway ... ok test_Phd ... ok test_PopGen_FDist ... skipping. Install FDist if you want to use Bio.PopGen.FDist. test_PopGen_FDist_nodepend ... ok test_PopGen_GenePop ... skipping. Install GenePop if you want to use Bio.PopGen.GenePop. test_PopGen_GenePop_EasyController ... skipping. Install GenePop if you want to use Bio.PopGen.GenePop. test_PopGen_GenePop_nodepend ... ok test_PopGen_SimCoal ... skipping. Install SIMCOAL2 if you want to use Bio.PopGen.SimCoal. test_PopGen_SimCoal_nodepend ... ok test_Prank_tool ... skipping. Install PRANK if you want to use the Bio.Align.Applications wrapper. test_Probcons_tool ... skipping. PROBCONS not available on Windows test_ProtParam ... ok test_Restriction ... ok test_SCOP_Astral ... ok test_SCOP_Cla ... FAIL test_SCOP_Des ... ok test_SCOP_Dom ... ok test_SCOP_Hie ... ok test_SCOP_Raf ... FAIL test_SCOP_Residues ... ok test_SCOP_Scop ... ok test_SVDSuperimposer ... ok test_SeqIO ... ok test_SeqIO_FastaIO ... ok test_SeqIO_QualityIO ... ok test_SeqIO_convert ... ok test_SeqIO_features ... ok test_SeqIO_index ... ok test_SeqIO_online ... ok test_SeqRecord ... ok test_SeqUtils ... ok test_Seq_objs ... ok test_SubsMat ... ok test_SwissProt ... ok test_TCoffee_tool ... skipping. Testing TCOFFEE on Windows not supported yet test_UniGene ... ok test_UniGene_obsolete ... ok test_Wise ... skipping. Don't know how to find the Wise2 tool dnal on Windows. test_align ... ok test_geo ... ok test_interpro ... ok test_kNN ... ok test_lowess ... ok test_pairwise2 ... ok test_prodoc ... ok test_property_manager ... ok test_prosite1 ... ok test_prosite2 ... ok test_prosite_patterns ... ok test_psw ... skipping. Don't know how to find the Wise2 tool dnal on Windows. test_seq ... ok test_translate ... ok test_trie ... ok test_triefind ... ok Bio.Application docstring test ... ok Bio.Seq docstring test ... ok Bio.SeqFeature docstring test ... ok Bio.SeqRecord docstring test ... ok Bio.SeqIO docstring test ... ok Bio.SeqIO.PhdIO docstring test ... ok Bio.SeqIO.QualityIO docstring test ... ok Bio.SeqIO.AceIO docstring test ... ok Bio.SeqUtils docstring test ... ok Bio.Align.Generic docstring test ... ok Bio.AlignIO docstring test ... ok Bio.AlignIO.StockholmIO docstring test ... ok Bio.Blast.Applications docstring test ... ok Bio.Clustalw docstring test ... ok Bio.Emboss.Applications docstring test ... ok Bio.KEGG.Compound docstring test ... ok Bio.KEGG.Enzyme docstring test ... ok Bio.Wise docstring test ... ok Bio.Wise.psw docstring test ... ok Bio.Motif docstring test ... ok Bio.Statistics.lowess docstring test ... ok ====================================================================== ERROR: Test creation of a simple PNG scatter plot. ---------------------------------------------------------------------- Traceback (most recent call last): File "test_GraphicsBitmaps.py", line 92, in test_simple_scatter_plot "bitmaps from Bio.Graphics\n" + str(err)) MissingExternalDependencyError: Check the fonts needed by ReportLab if you want bitmaps from Bio.Graphics Can't setFont(Times-Roman) missing the T1 files? Originally : makeT1Font() argument 2 must be string, not None ====================================================================== ERROR: testIndex (test_SCOP_Cla.ClaTests) ---------------------------------------------------------------------- Traceback (most recent call last): File "test_SCOP_Cla.py", line 72, in testIndex rec = index['d1hbia_'] File "D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\Bio\SCOP\Cla.py", line 125, in __getitem__ record = Record(line) File "D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\Bio\SCOP\Cla.py", line 45, in __init__ self._process(line) File "D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\Bio\SCOP\Cla.py", line 51, in _process raise ValueError("I don't understand the format of %s" % line) ValueError: I don't understand the format of 5 ====================================================================== ERROR: testSeqMapIndex (test_SCOP_Raf.RafTests) ---------------------------------------------------------------------- Traceback (most recent call last): File "test_SCOP_Raf.py", line 68, in testSeqMapIndex r = index.getSeqMap("103m") File "D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\Bio\SCOP\Raf.py", line 152, in getSeqMap sm = self[id] File "D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\Bio\SCOP\Raf.py", line 125, in __getitem__ record = SeqMap(line) File "D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\Bio\SCOP\Raf.py", line 196, in __init__ self._process(line) File "D:\Dev\Compile\Biopython\biopython-1.53\build\lib.win-amd64-2.6\Bio\SCOP\Raf.py", line 216, in _process raise ValueError("Incompatible RAF version: "+self.version) ValueError: Incompatible RAF version: .01 ---------------------------------------------------------------------- Ran 140 tests in 88.813 seconds FAILED (failures = 3)