You signed in with another tab or window. Reload to refresh your session.You signed out in another tab or window. Reload to refresh your session.You switched accounts on another tab or window. Reload to refresh your session.Dismiss alert
| abi | 1.58 | No | N/A | Reads the ABI "Sanger" capillary sequence traces files, including the PHRED quality scores for the base calls. This allows ABI to FASTQ conversion. Note each ABI file contains one and only one sequence (so there is no point in indexing the file). |
68
68
| ace | 1.47 | No | 1.52 | Reads the contig sequences from an ACE assembly file. Uses Bio.Sequencing.Ace internally |
69
-
| clustal | 1.43 | 1.43 | No | The [alignment format of Clustal X and Clustal W](bp:ClustalW_multiple_alignment_format"wikilink"). |
| fasta | 1.43 | 1.43 | 1.52 | This refers to the input [FASTA file format](bp:FASTA_sequence_format"wikilink") introduced for Bill Pearson's FASTA tool, where each record starts with a ">" line. Resulting sequences have a generic alphabet by default. |
69
+
| clustal | 1.43 | 1.43 | No | The [alignment format of Clustal X and Clustal W](http://bioperl.org/formats/alignment_formats/ClustalW_multiple_alignment_format).|
| fasta | 1.43 | 1.43 | 1.52 | This refers to the input [FASTA file format](http://bioperl.org/formats/sequence_formats/FASTA_sequence_format) introduced for Bill Pearson's FASTA tool, where each record starts with a ">" line. Resulting sequences have a generic alphabet by default. |
72
72
| fastq-sanger or fastq | 1.50 | 1.50 | 1.52 |[FASTQ files](http://en.wikipedia.org/wiki/FASTQ_format) are a bit like FASTA files but also include sequencing qualities. In Biopython, "fastq" (or the alias "fastq-sanger") refers to Sanger style FASTQ files which encode PHRED qualities using an ASCII offset of 33. See also the incompatible "fastq-solexa" and "fastq-illumina" variants used in early Solexa/Illumina pipelines, Illumina pipeline 1.8 produces Sanger FASTQ. |
73
73
| fastq-solexa | 1.50 | 1.50 | 1.52 |[FASTQ files](http://en.wikipedia.org/wiki/FASTQ_format) are a bit like FASTA files but also include sequencing qualities. In Biopython, "fastq-solexa" refers to the original Solexa/Illumina style FASTQ files which encode Solexa qualities using an ASCII offset of 64. See also what we call the "fastq-illumina" format. |
74
74
| fastq-illumina | 1.51 | 1.51 | 1.52 |[FASTQ files](http://en.wikipedia.org/wiki/FASTQ_format) are a bit like FASTA files but also include sequencing qualities. In Biopython, "fastq-illumina" refers to early Solexa/Illumina style FASTQ files (from pipeline version 1.3 to 1.7) which encode PHRED qualities using an ASCII offset of 64. For *good* quality reads, PHRED and Solexa scores are approximately equal, so the "fastq-solexa" and "fastq-illumina" variants are almost equivalent. |
75
-
| genbank or gb | 1.43 | 1.48 / 1.51 | 1.52 | The [GenBank or GenPept flat file format](bp:GenBank_sequence_format"wikilink"). Uses Bio.GenBank internally for parsing. Biopython 1.48 to 1.50 wrote basic GenBank files with only minimal annotation, while 1.51 onwards will also write the features table. |
76
-
| ig | 1.47 | No | 1.52 | This refers to the IntelliGenetics file format, apparently the same as the [MASE alignment format](bp:Mase_multiple_alignment_format"wikilink"). |
75
+
| genbank or gb | 1.43 | 1.48 / 1.51 | 1.52 | The [GenBank or GenPept flat file format](http://bioperl.org/formats/sequence_formats/GenBank_sequence_format). Uses Bio.GenBank internally for parsing. Biopython 1.48 to 1.50 wrote basic GenBank files with only minimal annotation, while 1.51 onwards will also write the features table. |
76
+
| ig | 1.47 | No | 1.52 | This refers to the IntelliGenetics file format, apparently the same as the [MASE alignment format](http://bioperl.org/formats/alignment_formats/Mase_multiple_alignment_format). |
77
77
| imgt | 1.56 | 1.56 | 1.56 | This refers to the IMGT variant of the EMBL plain text file format. |
78
-
| nexus | 1.43 | 1.48 | No | The [NEXUS multiple alignment](bp:NEXUS_multiple_alignment_format"wikilink") format, also known as PAUP format. Uses Bio.Nexus internally. |
78
+
| nexus | 1.43 | 1.48 | No | The [NEXUS multiple alignment](http://bioperl.org/formats/alignment_formats/NEXUS_multiple_alignment_format) format, also known as PAUP format. Uses Bio.Nexus internally. |
79
79
| pdb-seqres | 1.61 | No | No | Reads a Protein Data Bank (PDB) file to determine the complete protein sequence as it appears in the header (no dependency on Bio.PDB and NumPy). |
80
80
| pdb-atom | 1.61 | No | No | Uses Bio.PDB to determine the (partial) protein sequence as it appears in the structure based on the atom coordinate section of the file (requires NumPy). |
81
-
| phd | 1.46 | 1.52 | 1.52 |[PHD files](bp:PHD_sequence_format"wikilink") are output from PHRED, used by PHRAP and CONSED for input. Uses Bio.Sequencing.Phd internally. |
82
-
| phylip | 1.43 | 1.43 | No |An alignment format. Truncates names at 10 characters. |
83
-
| pir | 1.48 | No | 1.52 | A "FASTA like" format introduced by the National Biomedical Research Foundation (NBRF) for the [Protein Information Resource (PIR)](bp:PIR_sequence_format"wikilink") database, now part of UniProt. |
81
+
| phd | 1.46 | 1.52 | 1.52 |[PHD files](http://bioperl.org/formats/sequence_formats/PHD_sequence_format) are output from PHRED, used by PHRAP and CONSED for input. Uses Bio.Sequencing.Phd internally. |
82
+
| phylip | 1.43 | 1.43 | No |[PHYLIP files](http://bioperl.org/formats/alignment_formats/PHYLIP_multiple_alignment_format). Truncates names at 10 characters. |
83
+
| pir | 1.48 | No | 1.52 | A "FASTA like" format introduced by the National Biomedical Research Foundation (NBRF) for the [Protein Information Resource (PIR)](http://bioperl.org/formats/sequence_formats/PIR_sequence_format) database, now part of UniProt. |
84
84
| seqxml | 1.58 | 1.58 | No | Simple [sequence XML file format](http://seqxml.org). |
85
85
| sff | 1.54 | 1.54 | 1.54 | Standard Flowgram Format ([SFF](http://www.ncbi.nlm.nih.gov/books/NBK47537/#File_Format_Guide_B.Standard_Flowgram_Fo)) binary files produced by Roche 454 and IonTorrent/IonProton sequencing machines. |
86
-
| stockholm | 1.43 | 1.43 | No | The [Stockholm alignment format](bp:Stockholm_multiple_alignment_format"wikilink") is also known as PFAM format. |
87
-
| swiss | 1.43 | No | 1.52 |[Swiss-Prot](bp:Swissprot_sequence_format"wikilink") aka UniProt format. Uses Bio.SwissProt internally. See also the UniProt XML format. |
88
-
| tab | 1.48 | 1.48 | 1.52 |[Simple two column tab separated sequence files](bp:Tab_sequence_format"wikilink"), where each line holds a record's identifier and sequence. For example, this is used by Aligent's eArray software when saving microarray probes in a minimal tab delimited text file. |
89
-
| qual | 1.50 | 1.50 | 1.52 |[Qual files](bp:Qual_sequence_format"wikilink") are a bit like FASTA files but instead of the sequence, record space separated integer sequencing values as PHRED quality scores. A matched pair of FASTA and QUAL files are often used as an alternative to a single FASTQ file. |
86
+
| stockholm | 1.43 | 1.43 | No | The [Stockholm alignment format](http://bioperl.org/formats/alignment_formats/Stockholm_multiple_alignment_format) is also known as PFAM format. |
87
+
| swiss | 1.43 | No | 1.52 |[Swiss-Prot](http://bioperl.org/formats/sequence_formats/Swissprot_sequence_format) aka UniProt format. Uses Bio.SwissProt internally. See also the UniProt XML format. |
88
+
| tab | 1.48 | 1.48 | 1.52 |[Simple two column tab separated sequence files](http://bioperl.org/formats/sequence_formats/Tab_sequence_format), where each line holds a record's identifier and sequence. For example, this is used by Aligent's eArray software when saving microarray probes in a minimal tab delimited text file. |
89
+
| qual | 1.50 | 1.50 | 1.52 |[Qual files](http://bioperl.org/formats/sequence_formats/Qual_sequence_format) are a bit like FASTA files but instead of the sequence, record space separated integer sequencing values as PHRED quality scores. A matched pair of FASTA and QUAL files are often used as an alternative to a single FASTQ file. |
90
90
| uniprot-xml | 1.56 | No | 1.56 | UniProt XML format, successor to the plain text Swiss-Prot format. |
91
91
||
92
92
@@ -119,7 +119,7 @@ function **open**. The argument 'rU' means open for **r**eading using
119
119
file uses Unix, Mac or DOS/Windows style newline characters.
120
120
121
121
Note that you *must* specify the file format explicitly, unlike
122
-
[BioPerl's SeqIO](bp:HOWTO:SeqIO"wikilink") which can try to guess
122
+
[BioPerl's SeqIO](http://bioperl.org/howtos/SeqIO_HOWTO) which can try to guess
123
123
using the file name extension and/or the file contents. See *Explicit is
0 commit comments