All Projects → andrewjpage → tiptoft

andrewjpage / tiptoft

Licence: GPL-3.0 License
Predict plasmids from uncorrected long read data

Programming Languages

python
139335 projects - #7 most used programming language
TeX
3793 projects
Dockerfile
14818 projects

Projects that are alternatives of or similar to tiptoft

saffrontree
SaffronTree: Reference free rapid phylogenetic tree construction from raw read data
Stars: ✭ 17 (-37.04%)
Mutual labels:  bioinformatics, research, genomics, pathogen, bioinformatics-pipeline, global-health, infectious-diseases
plasmidtron
Assembling the cause of phenotypes and genotypes from NGS data
Stars: ✭ 27 (+0%)
Mutual labels:  bioinformatics, research, genomics, pathogen, bioinformatics-pipeline, global-health, infectious-diseases
gff3toembl
Converts Prokka GFF3 files to EMBL files for uploading annotated assemblies to EBI
Stars: ✭ 27 (+0%)
Mutual labels:  bioinformatics, research, genomics, pathogen, bioinformatics-pipeline, global-health, infectious-diseases
snp-sites
Finds SNP sites from a multi-FASTA alignment file
Stars: ✭ 182 (+574.07%)
Mutual labels:  research, genomics, pathogen, bioinformatics-pipeline, global-health, infectious-diseases
gubbins
Rapid phylogenetic analysis of large samples of recombinant bacterial whole genome sequences using Gubbins
Stars: ✭ 103 (+281.48%)
Mutual labels:  research, genomics, pathogen, bioinformatics-pipeline, global-health, infectious-diseases
assembly improvement
Improve the quality of a denovo assembly by scaffolding and gap filling
Stars: ✭ 46 (+70.37%)
Mutual labels:  research, genomics, pathogen, bioinformatics-pipeline, global-health, infectious-diseases
mlst check
Multilocus sequence typing by blast using the schemes from PubMLST
Stars: ✭ 22 (-18.52%)
Mutual labels:  research, genomics, pathogen, bioinformatics-pipeline, global-health, infectious-diseases
haslr
A fast tool for hybrid genome assembly of long and short reads
Stars: ✭ 68 (+151.85%)
Mutual labels:  nanopore, genomics, pacbio, long-reads
Gubbins
Rapid phylogenetic analysis of large samples of recombinant bacterial whole genome sequences using Gubbins
Stars: ✭ 67 (+148.15%)
Mutual labels:  bioinformatics, research, genomics
Ariba
Antimicrobial Resistance Identification By Assembly
Stars: ✭ 96 (+255.56%)
Mutual labels:  bioinformatics, research, genomics
Artemis
Artemis is a free genome viewer and annotation tool that allows visualization of sequence features and the results of analyses within the context of the sequence, and its six-frame translation
Stars: ✭ 135 (+400%)
Mutual labels:  bioinformatics, research, genomics
Roary
Rapid large-scale prokaryote pan genome analysis
Stars: ✭ 176 (+551.85%)
Mutual labels:  bioinformatics, research, genomics
bystro
Bystro genetic analysis (annotation, filtering, statistics)
Stars: ✭ 31 (+14.81%)
Mutual labels:  bioinformatics, genomics, bioinformatics-pipeline
streamformatics
Real-time species-typing visualisation for nanopore data.
Stars: ✭ 13 (-51.85%)
Mutual labels:  bioinformatics, nanopore, bioinformatics-pipeline
Circlator
A tool to circularize genome assemblies
Stars: ✭ 121 (+348.15%)
Mutual labels:  bioinformatics, research, genomics
pepper
PEPPER-Margin-DeepVariant
Stars: ✭ 179 (+562.96%)
Mutual labels:  nanopore, oxford-nanopore, long-reads
Clair3
Clair3 - Symphonizing pileup and full-alignment for high-performance long-read variant calling
Stars: ✭ 119 (+340.74%)
Mutual labels:  nanopore, genomics, long-reads
rkmh
Classify sequencing reads using MinHash.
Stars: ✭ 42 (+55.56%)
Mutual labels:  bioinformatics, nanopore, kmer
ntHash
Fast hash function for DNA sequences
Stars: ✭ 66 (+144.44%)
Mutual labels:  bioinformatics, genomics
nPhase
Ploidy agnostic phasing pipeline and algorithm
Stars: ✭ 18 (-33.33%)
Mutual labels:  bioinformatics, bioinformatics-pipeline

TipToft

Given some raw uncorrected long reads, such as those from PacBio or Oxford Nanopore, predict which plasmid should be present. Assemblies of long read data can often miss out on plasmids, particularly if they are very small or have a copy number which is too high/low when compared to the chromosome. This software gives you an indication of which plasmids to expect, flagging potential issues with an assembly.

Build Status License: GPL v3 codecov Docker Build Status Docker Pulls

Paper

DOI

AJ Page, T Seemann (2019). TipToft: detecting plasmids contained in uncorrected long read sequencing data. Journal of Open Source Software, 4(35), 1021, https://doi.org/10.21105/joss.01021

Please remember to cite the plasmidFinder paper as their database makes this software work:

Carattoli et al, In Silico Detection and Typing of Plasmids using PlasmidFinder and Plasmid Multilocus Sequence Typing, Antimicrob Agents Chemother. 2014;58(7):3895–3903. view

Installation

The only dependancies are Python3 and a compiler (gcc, clang,...) and this should work on Linux or OSX. Cython needs to be installed in advance. Assuming you have Python 3.4+ and pip installed, just run:

pip3 install cython
pip3 install tiptoft

or if you wish to install the latest development version:

pip3 install git+git://github.com/andrewjpage/tiptoft.git

Debian/Ubuntu (Trusty/Xenial)

To install Python3 on Ubuntu run:

sudo apt-get update -qq
sudo apt-get install -y git python3 python3-setuptools python3-biopython python3-pip
pip3 install cython
pip3 install tiptoft

Docker

Install Docker. There is a docker container which gets automatically built from the latest version of TipToft. To install it:

docker pull andrewjpage/tiptoft

To use it you would use a command such as this (substituting in your filename/directories), using the example file in this respository:

docker run --rm -it -v /path/to/example_data:/example_data andrewjpage/tiptoft tiptoft /example_data/ERS654932_plasmids.fastq.gz

Homebrew

Install Brew for OSX or LinuxBrew for Linux, then run:

brew install python # this is python v3
pip3 install cython
pip3 install tiptoft

Bioconda

Install Bioconda, then run:

conda install tiptoft

Windows

It has been reported that the software works when using Ubuntu on Windows 10. This is not a supported platform as the authors don't use windows, so use at your own risk.

Usage

tiptoft_database_downloader script

First of all you need plasmid database from PlasmidFinder. There is a snapshot bundled with this repository for your convenience, or alternatively you can use the downloader script to get the latest data. You will need internet access for this step. Please remember to cite the PlasmidFinder paper.

usage: tiptoft_database_downloader [options] output_prefix

Download PlasmidFinder database

positional arguments:
  output_prefix  Output prefix

optional arguments:
  -h, --help     show this help message and exit
  --verbose, -v  Turn on debugging (default: False)
  --version      show program's version number and exit

Just run:

tiptoft_database_downloader 

You will now have a file called 'plasmid_files.fa' which can be used with the main script.

tiptoft script

This is the main script of the application. The mandatory inputs are a FASTQ file of long reads, which can be optionally gzipped.

usage: tiptoft [options] input.fastq

plasmid incompatibility group prediction from uncorrected long reads

positional arguments:
  input_fastq           Input FASTQ file (optionally gzipped)

optional arguments:
  -h, --help            show this help message and exit

Optional input arguments:
  --plasmid_data PLASMID_DATA, -d PLASMID_DATA
                        FASTA file containing plasmid data from downloader
                        script, defaults to bundled database (default: None)
  --kmer KMER, -k KMER  k-mer size (default: 13)

Optional output arguments:
  --filtered_reads_file FILTERED_READS_FILE, -f FILTERED_READS_FILE
                        Filename to save matching reads to (default: None)
  --output_file OUTPUT_FILE, -o OUTPUT_FILE
                        Output file [STDOUT] (default: None)
  --print_interval PRINT_INTERVAL, -p PRINT_INTERVAL
                        Print results every this number of reads (default:
                        None)
  --verbose, -v         Turn on debugging [False]
  --version             show program's version number and exit

Optional advanced input arguments:
  --max_gap MAX_GAP     Maximum gap for blocks to be contigous, measured in
                        multiples of the k-mer size (default: 3)
  --margin MARGIN       Flanking region around a block to use for mapping
                        (default: 10)
  --min_block_size MIN_BLOCK_SIZE
                        Minimum block size in bases (default: 130)
  --min_fasta_hits MIN_FASTA_HITS, -m MIN_FASTA_HITS
                        Minimum No. of kmers matching a read (default: 10)
  --min_perc_coverage MIN_PERC_COVERAGE, -c MIN_PERC_COVERAGE
                        Minimum percentage coverage of typing sequence to
                        report (default: 85)
  --min_kmers_for_onex_pass MIN_KMERS_FOR_ONEX_PASS
                        Minimum No. of kmers matching a read in 1st pass
                        (default: 10)

Required argument

input_fastq: This is a single FASTQ file. It can be optionally gzipped. Alternatively input can be read from stdin by using the dash character (-) as the input file name. The file must contain long reads, such as those from PacBio or Oxford Nanopore. The quality scores are ignored.

Optional input arguments

plasmid_data: This is a FASTA file containing all of the plasmid typing sequences. This is generated by the tiptoft_database_downloader script. It comes from the PlasmidFinder website, so please be sure to cite their paper (citation gets printed every time you run the script).

kmer: The most important parameter. 13 works well for Nanopore, 15 works well for PacBio, but you may need to play around with it for your data. Long reads have a high error rate, so if you set this too high, nothing will match (because it will contain errors). If you set it too low, everything will match, which isnt much use to you. Thinking about your data, on average how long of a stretch of bases can you get in your read without errors? This is what you should set your kmer to. For example, if you have an average of 1 error every 10 bases, then the ideal kmer would be 9.

Optional output arguments

filtered_reads_file: Save the reads which contain the rep/inc sequences to a new FASTQ file. This is useful if you want to undertake a further assembly just on the plasmids.This file should not already exist.

output_file OUTPUT_FILE: By default the results are printed to STDOUT. If you provide an output filename (which must not exist already), it will print the results to the file.

print_interval: By default the whole file is processed and the final results are printed out. However you can get intermediate results printed after every X number of reads, which is useful if you are doing real time streaming of data into the application and can halt when you have enough information. They are separated by "****".

verbose: Enable debugging mode where lots of extra output is printed to STDOUT.

version: Print the version number and exit.

Optional advanced input arguments

max_gap: Maximum gap for blocks to be contigous, measured in multiples of the k-mer size. This allows for short regions of elevated errors in the reads to be spanned.

margin: Expand the analysis to look at a few bases on either side of where the sequence is predicted to be on the read. This allows for k-mers to overlap the ends.

min_block_size: This is the minimum sub read size of a read to consider for indepth analysis after matching k-mers have been identified in the read. This speeds up the analysis quite a bit, but there is the risk that some reads may be missed, particularly if they have partial rep/inc sequences.

min_fasta_hits: This is the minimum number of matching kmers in a read, for the read to be considered for analysis. It is a hard minimum threshold to speed up analysis.

min_perc_coverage: Only report rep/inc sequences above this percentage coverage. Coverage in this instance is kmer coverage of the underlying sequence (rather than depth of coverage).

min_kmers_for_onex_pass: The number of k-mers that must be present in the read for the initial onex pass of the database to be considered for further analysis. This speeds up the analysis quite a bit, but there is the risk that some reads may be missed, particularly if they have partial rep/inc sequences.

Output

The output is tab delmited and printed to STDOUT by default. You can optionally print it to a file using the '-o' parameter. If you would like to see intermediate results, you can tell it to print every X reads with the '-p' parameter, separated by '****'. An example of the output is:

GENE	COMPLETENESS	%COVERAGE	ACCESSION	DATABASE	PRODUCT
rep7.1	Full	100	AB037671	plasmidfinder	rep7.1_repC(Cassette)_AB037671
rep7.5	Partial	99	AF378372	plasmidfinder	rep7.5_CDS1(pKC5b)_AF378372
rep7.6	Partial	94	SAU38656	plasmidfinder	rep7.6_ORF(pKH1)_SAU38656
rep7.9	Full	100	NC007791	plasmidfinder	rep7.9_CDS3(pUSA02)_NC007791
rep7.10	Partial	91	NC_010284.1	plasmidfinder	rep7.10_repC(pKH17)_NC_010284.1
rep7.12	Partial	93	GQ900417.1	plasmidfinder	rep7.12_rep(SAP060B)_GQ900417.1
rep7.17	Full	100	AM990993.1	plasmidfinder	rep7.17_repC(pS0385-1)_AM990993.1
rep20.11	Full	100	AP003367	plasmidfinder	rep20.11_repA(VRSAp)_AP003367
repUS14.	Full	100	AP003367	plasmidfinder	repUS14._repA(VRSAp)_AP003367

GENE: The first column is the first part of the product name.

COMPLETENESS: If all of the k-mers in the gene are found in the reads, the completeness is noted as 'Full', otherwise if there are some k-mers missing, it is noted as 'Partial'.

%COVERAGE: The percentage coverage is the number of underlying k-mers in the gene where at least 1 matching k-mer has been found in the reads. 100 indicates that every k-mer in the gene is covered. Low coverage results are not shown (controlled by the --min_perc_coverage parameter).

ACCESSION: This is the accession number from where the typing sequence originates. You can look this up at NCBI or EBI.

DATABASE: This is where the data has come from, which is currently always plasmidfinder.

PRODUCT: This is the full product of the gene as found in the database.

Example usage

A real test file is bundled in the repository. Download it then run:

tiptoft ERS654932_plasmids.fastq.gz

The expected output is in the repository. This uses a bundled database, however if you wish to use the latest up to date database, you should run the tiptoft_database_downloader script.

Resource usage

For an 800 MB FASTQ file (unzipped) of long reads from a Oxford Nanopore MinION containing Salmonella required 80 MB of RAM and took under 1 minute.

License

TipToft is free software, licensed under GPLv3.

Feedback/Issues

Please report any issues to the issues page.

Contribute to the software

If you wish to fix a bug or add new features to the software we welcome Pull Requests. We use GitHub Flow style development. Please fork the repo, make the change, then submit a Pull Request against out master branch, with details about what the change is and what it fixes/adds. We will then review your changes and merge them, or provide feedback on enhancements.

Note that the project description data, including the texts, logos, images, and/or trademarks, for each open source project belongs to its rightful owner. If you wish to add or remove any projects, please contact us at [email protected].