All Projects → oschwengers → platon

oschwengers / platon

Licence: GPL-3.0 License
Identification & characterization of bacterial plasmid-borne contigs from short-read draft assemblies.

Programming Languages

python
139335 projects - #7 most used programming language
Nextflow
61 projects
shell
77523 projects

Projects that are alternatives of or similar to platon

referenceseeker
Rapid determination of appropriate reference genomes.
Stars: ✭ 65 (+25%)
Mutual labels:  bioinformatics, microbiology, wgs
awesome-phages
A curated list of phage related software and computational resources for phage scientists, bioinformaticians and enthusiasts.
Stars: ✭ 14 (-73.08%)
Mutual labels:  bioinformatics, bacteria
PHAT
Pathogen-Host Analysis Tool - A modern Next-Generation Sequencing (NGS) analysis platform
Stars: ✭ 17 (-67.31%)
Mutual labels:  bioinformatics, ngs
catch
A package for designing compact and comprehensive capture probe sets.
Stars: ✭ 55 (+5.77%)
Mutual labels:  bioinformatics, ngs
bac-genomics-scripts
Collection of scripts for bacterial genomics
Stars: ✭ 39 (-25%)
Mutual labels:  ngs, microbiology
PlasFlow
Software for prediction of plasmid sequences in metagenomic assemblies
Stars: ✭ 74 (+42.31%)
Mutual labels:  contigs, plasmids
atropos
An NGS read trimming tool that is specific, sensitive, and speedy. (production)
Stars: ✭ 109 (+109.62%)
Mutual labels:  bioinformatics, ngs
Scde
R package for analyzing single-cell RNA-seq data
Stars: ✭ 147 (+182.69%)
Mutual labels:  bioinformatics, ngs
reg-gen
Regulatory Genomics Toolbox: Python library and set of tools for the integrative analysis of high throughput regulatory genomics data.
Stars: ✭ 64 (+23.08%)
Mutual labels:  bioinformatics, ngs
OpenGene.jl
(No maintenance) OpenGene, core libraries for NGS data analysis and bioinformatics in Julia
Stars: ✭ 60 (+15.38%)
Mutual labels:  bioinformatics, ngs
Deepvariant
DeepVariant is an analysis pipeline that uses a deep neural network to call genetic variants from next-generation DNA sequencing data.
Stars: ✭ 2,404 (+4523.08%)
Mutual labels:  bioinformatics, ngs
gencore
Generate duplex/single consensus reads to reduce sequencing noises and remove duplications
Stars: ✭ 91 (+75%)
Mutual labels:  bioinformatics, ngs
Afterqc
Automatic Filtering, Trimming, Error Removing and Quality Control for fastq data
Stars: ✭ 169 (+225%)
Mutual labels:  bioinformatics, ngs
asap
A scalable bacterial genome assembly, annotation and analysis pipeline
Stars: ✭ 47 (-9.62%)
Mutual labels:  ngs, bacteria
Fgbio
Tools for working with genomic and high throughput sequencing data.
Stars: ✭ 166 (+219.23%)
Mutual labels:  bioinformatics, ngs
CONSENT
Scalable long read self-correction and assembly polishing with multiple sequence alignment
Stars: ✭ 47 (-9.62%)
Mutual labels:  ngs, contigs
Ugene
UGENE is free open-source cross-platform bioinformatics software
Stars: ✭ 112 (+115.38%)
Mutual labels:  bioinformatics, ngs
Ngless
NGLess: NGS with less work
Stars: ✭ 115 (+121.15%)
Mutual labels:  bioinformatics, ngs
SVCollector
Method to optimally select samples for validation and resequencing
Stars: ✭ 20 (-61.54%)
Mutual labels:  bioinformatics, ngs
peppy
Project metadata manager for PEPs in Python
Stars: ✭ 29 (-44.23%)
Mutual labels:  bioinformatics, ngs

DOI:10.1099/mgen.0.000398 License: GPL v3 PyPI - Python Version GitHub release PyPI PyPI - Status Conda

Platon: identification and characterization of bacterial plasmid contigs from short-read draft assemblies

Contents

Description

TL;DR Platon detects plasmid-borne contigs within bacterial draft (meta) genomes assemblies. Therefore, Platon analyzes the distribution bias of protein-coding gene families among chromosomes and plasmids. This analysis is complemented by comprehensive contig characterizations follwoed by heuristic filters.

Platon conducts three analysis steps:

  1. It predicts and searches protein sequences against a custom and pre-computed database comprising marker protein sequences (MPS) and related replicon distribution scores (RDS). These scores express the empirically measured bias of protein sequence family distributions among plasmids and chromosomes pre-computed on complete NCBI RefSeq replicons. Platon calculates the mean RDS for each contig and either classifies them as chromosome if the RDS is below a sensitivity cutoff determined to 95% sensitivity or as plasmid if the RDS is above a specificity cutoff determined to 99.9% specificity. Exact values for these thresholds have been computed based on Monte Carlo simulations of artifical replicon fragments created from complete RefSeq chromosome and plasmid sequences.
  2. Contigs passing the sensitivity filter get comprehensivley characterized. Hereby, Platon tries to circularize the contig sequences, searches for rRNA, replication, mobilization and conjugation genes, oriT sequences, incompatibility group DNA probes and finally performs a BLAST+ search against the NCBI plasmid database.
  3. Finally, to increase the overall sensitivity, Platon classifies all remaining contigs based on the gathered information by several heuristics.
Replicon distribution and alignment hit frequencies of MPS
Fig: Replicon distribution and alignment hit frequencies of MPS. Shown are summed plasmid and chromosome alignment hit frequencies per MPS plotted against plasmid/chromosome hit count ratios scaled to [-1 (chromosome), 1 (plasmid)]; Hue: normalized RDS values (min=-100, max=100), hit count outliers below 10-4 and above 1 are discarded for the sake of readability.

Input/Output

Input

Platon accepts draft (meta) genome assemblies in fasta format. If contigs have been assembled with SPAdes, Platon is able to extract the coverage information from the contig names.

Output

For each contig classified as plasmid sequence the following columns are printed to STDOUT as tab separated values:

  • Contig ID
  • Length
  • Coverage
  • # ORFs
  • RDS
  • Circularity
  • Incompatibility Type(s)
  • # Replication Genes
  • # Mobilization Genes
  • # OriT Sequences
  • # Conjugation Genes
  • # rRNA Genes
  • # Plasmid Database Hits

In addition, Platon writes the following files into the output directory:

  • <prefix>.plasmid.fasta: contigs classified as plasmids or plasmodal origin
  • <prefix>.chromosome.fasta: contigs classified as chromosomal origin
  • <prefix>.tsv: dense information as printed to STDOUT (see above)
  • <prefix>.json: comprehensive results and information on each single plasmid contig. All files are prefixed (<prefix>) as the input genome fasta file.

Installation

Platon can be installed via BioConda or Pip. However, we encourage to use Conda to automatically install all required 3rd party dependencies. In all cases a mandatory database must be downloaded.

BioConda

$ conda install -c conda-forge -c bioconda -c defaults platon

Pip

$ python3 -m pip install --user cb-platon

Platon requires the following 3rd party executables which must be installed & executable:

Database download

Platon requires a mandatory database which is publicly hosted at Zenodo: DOI Further information is provided in the database section below.

$ wget https://zenodo.org/record/4066768/files/db.tar.gz
$ tar -xzf db.tar.gz
$ rm db.tar.gz

The db path can either be provided via parameter (--db) or environment variable (PLATON_DB):

$ platon --db <db-path> genome.fasta

$ export PLATON_DB=<db-path>
$ platon genome.fasta

Additionally, for a system-wide setup, the database can be copied to the Platon base directory:

$ cp -r db/ <platon-installation-dir>

Usage

Usage:

usage: platon [--db DB] [--prefix PREFIX] [--output OUTPUT] [--mode {sensitivity,accuracy,specificity}] [--characterize] [--meta] [--help] [--verbose] [--threads THREADS] [--version] <genome>

Identification and characterization of bacterial plasmid contigs from short-read draft assemblies.

Input / Output:
  <genome>              draft genome in fasta format
  --db DB, -d DB        database path (default = <platon_path>/db)
  --prefix PREFIX, -p PREFIX
                        Prefix for output files
  --output OUTPUT, -o OUTPUT
                        Output directory (default = current working directory)

Workflow:
  --mode {sensitivity,accuracy,specificity}, -m {sensitivity,accuracy,specificity}
                        applied filter mode: sensitivity: RDS only (>= 95% sensitivity); specificity: RDS only (>=99.9% specificity); accuracy: RDS & characterization heuristics (highest accuracy) (default = accuracy)
  --characterize, -c    deactivate filters; characterize all contigs
  --meta                use metagenome gene prediction mode

General:
  --help, -h            Show this help message and exit
  --verbose, -v         Print verbose information
  --threads THREADS, -t THREADS
                        Number of threads to use (default = number of available CPUs)
  --version             show program's version number and exit

Examples

Simple:

$ platon genome.fasta

Expert: writing results to results directory with verbose output using 8 threads:

$ platon --db ~/db --output results/ --verbose --threads 8 genome.fasta

Mode

Platon provides 3 different modi controlling which filters will be used. Accuracy mode is the preset default.

Sensitivity

In the sensitivity mode Platon will classifiy all contigs with an RDS value below the sensitivity threshold as chromosomal and all remaining contigs as plasmid. This threshold was defined to account for 95% sensitivity and computed via Monte Carlo simulations of artifical contigs resulting in an RDS=-7.9. -> use this mode to exclude chromosomal contigs.

Specificity

In the specificity mode Platon will classifiy all contigs with an RDS value above the specificity threshold as plasmid and all remaining contigs as chromosomal. This threshold was defined to account for 99.9% specificity and computed via Monte Carlo simulations of artifical contigs resulting in an RDS=0.7.

Accuracy (default)

In the accuracy mode Platon will classifiy all contigs with:

  • an RDS value below the sensitivity threshold as chromosomal
  • an RDS value above the specificity threshold as plasmid and in addition all contigs as plasmid for which one of the following is true: it
  • can be circularized
  • has an incompatibility group sequence
  • has a replication or mobilization HMM hit
  • has an oriT hit
  • has an RDS above the conservative score (0.1), a RefSeq plasmid hit and no rRNA hit

Database

Platon depends on a custom database based on MPS, RDS, RefSeq Plasmid database, PlasmidFinder db as well as manually curated MOB HMM models from MOBscan, custom conjugation and replication HMM models and oriT sequences from MOB-suite. This database based on UniProt UniRef90 release 202 can be downloaded here: (zipped 1.6 Gb, unzipped 2.8 Gb) DOI https://zenodo.org/record/4066768/files/db.tar.gz

Please make sure that you use the latest Platon version along with the most recent database version! Older software versions are not compatible with the latest database version

Dependencies

Platon was developed and tested in Python 3.5 and depends on BioPython (>=1.71).

Additionally, it depends on the following 3rd party executables:

Citation

Schwengers O., Barth P., Falgenhauer L., Hain T., Chakraborty T., & Goesmann A. (2020). Platon: identification and characterization of bacterial plasmid contigs in short-read draft assemblies exploiting protein sequence-based replicon distribution scores. Microbial Genomics, 95, 295. https://doi.org/10.1099/mgen.0.000398

As Platon takes advantage of the inc groups, MOB HMMs and oriT sequences of the following databases, please also cite:

  • Carattoli A., Zankari E., Garcia-Fernandez A., Voldby Larsen M., Lund O., Villa L., Aarestrup F.M., Hasman H. (2014) PlasmidFinder and pMLST: in silico detection and typing of plasmids. Antimicrobial Agents and Chemotherapy, https://doi.org/10.1128/AAC.02412-14

  • Garcillán-Barcia M. P., Redondo-Salvo S., Vielva L., de la Cruz F. (2020) MOBscan: Automated Annotation of MOB Relaxases. Methods in Molecular Biology, https://doi.org/10.1007/978-1-4939-9877-7_21

  • Robertson J., Nash J. H. E. (2018) MOB-suite: Software Tools for Clustering, Reconstruction and Typing of Plasmids From Draft Assemblies. Microbial Genomics, https://doi.org/10.1099/mgen.0.000206

Issues

If you run into any issues with Platon, we'd be happy to hear about it! Please, start the pipeline with -v (verbose) and do not hesitate to file an issue including as much of the following as possible:

  • a detailed description of the issue
  • the platon cmd line output
  • the <prefix>.json file if possible
  • A reproducible example of the issue with a small dataset that you can share (helps us identify whether the issue is specific to a particular computer, operating system, and/or dataset).
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].