All Projects → compmetagen → micca

compmetagen / micca

Licence: GPL-3.0 License
micca - MICrobial Community Analysis

Programming Languages

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

Projects that are alternatives of or similar to micca

virnet
VirNet: A deep attention model for viral reads identification
Stars: ✭ 26 (+36.84%)
Mutual labels:  bioinformatics, metagenomics
Cytometry Clustering Comparison
R scripts to reproduce analyses in our paper comparing clustering methods for high-dimensional cytometry data
Stars: ✭ 30 (+57.89%)
Mutual labels:  bioinformatics, clustering
Vsearch
Versatile open-source tool for microbiome analysis
Stars: ✭ 444 (+2236.84%)
Mutual labels:  bioinformatics, clustering
Awesome Single Cell
Community-curated list of software packages and data resources for single-cell, including RNA-seq, ATAC-seq, etc.
Stars: ✭ 1,937 (+10094.74%)
Mutual labels:  bioinformatics, clustering
catch
A package for designing compact and comprehensive capture probe sets.
Stars: ✭ 55 (+189.47%)
Mutual labels:  bioinformatics, metagenomics
Binning refiner
Improving genome bins through the combination of different binning programs
Stars: ✭ 26 (+36.84%)
Mutual labels:  bioinformatics, metagenomics
Swarm
A robust and fast clustering method for amplicon-based studies
Stars: ✭ 88 (+363.16%)
Mutual labels:  bioinformatics, clustering
matam
Mapping-Assisted Targeted-Assembly for Metagenomics
Stars: ✭ 18 (-5.26%)
Mutual labels:  bioinformatics, metagenomics
SemiBin
No description or website provided.
Stars: ✭ 25 (+31.58%)
Mutual labels:  bioinformatics, metagenomics
snpsea
📊 Identify cell types and pathways affected by genetic risk loci.
Stars: ✭ 26 (+36.84%)
Mutual labels:  bioinformatics
awesome-bioinformatics-formats
Curated list of bioinformatics formats and publications
Stars: ✭ 50 (+163.16%)
Mutual labels:  bioinformatics
peppy
Project metadata manager for PEPs in Python
Stars: ✭ 29 (+52.63%)
Mutual labels:  bioinformatics
dna-traits
A fast 23andMe genome text file parser, now superseded by arv
Stars: ✭ 64 (+236.84%)
Mutual labels:  bioinformatics
genomedisco
Software for comparing contact maps from HiC, CaptureC and other 3D genome data.
Stars: ✭ 23 (+21.05%)
Mutual labels:  bioinformatics
gencore
Generate duplex/single consensus reads to reduce sequencing noises and remove duplications
Stars: ✭ 91 (+378.95%)
Mutual labels:  bioinformatics
bacnet
BACNET is a Java based platform to develop website for multi-omics analysis
Stars: ✭ 12 (-36.84%)
Mutual labels:  bioinformatics
Clustering-in-Python
Clustering methods in Machine Learning includes both theory and python code of each algorithm. Algorithms include K Mean, K Mode, Hierarchical, DB Scan and Gaussian Mixture Model GMM. Interview questions on clustering are also added in the end.
Stars: ✭ 27 (+42.11%)
Mutual labels:  clustering
tiptoft
Predict plasmids from uncorrected long read data
Stars: ✭ 27 (+42.11%)
Mutual labels:  bioinformatics
watset-java
An implementation of the Watset clustering algorithm in Java.
Stars: ✭ 24 (+26.32%)
Mutual labels:  clustering
RNAseq titration results
Cross-platform normalization enables machine learning model training on microarray and RNA-seq data simultaneously
Stars: ✭ 22 (+15.79%)
Mutual labels:  bioinformatics

micca - MICrobial Community Analysis

https://travis-ci.org/compmetagen/micca.svg?branch=master

micca (MICrobial Community Analysis) is a software pipeline for the processing of amplicon sequencing data, from raw sequences to OTU tables, taxonomy classification and phylogenetic tree inference. The pipeline can be applied to a range of highly conserved genes/spacers, such as 16S rRNA gene, Internal Transcribed Spacer (ITS) 18S and 28S rRNA. micca is an open-source, GPLv3-licensed software.

Key features:

  • supports single-end (Roche 454, Illumina MiSeq/HiSeq ,Ion Torrent) and overlapping paired-end reads (Illumina MiSeq/HiSeq);
  • multithread de novo greedy, closed-reference, open-reference and swarm OTU picking protocols;
  • denoising of Illumina reads;
  • state-of-the-art taxonomic classification algorithms (RDP and consensus-based classifier);
  • fast and and memory efficient NAST multiple sequence alignment (MSA);
  • filters low quality sequences according to the maximum allowed expected error (EE) rate %;
  • runs on Linux, Mac OS X and MS Windows (through Docker containers)
  • simple, easy to use.

Docker images are available (compmetagen/micca) starting from version 1.2.2, see the documentation (>=1.3.0) to learn how to use them. Docker hub page.

How to cite: Davide Albanese, Paolo Fontana, Carlotta De Filippo, Duccio Cavalieri and Claudio Donati. MICCA: a complete and accurate software for taxonomic profiling of metagenomic data. Scientific Reports 5, Article number: 9743 (2015), doi:10.1038/srep09743, Link. Dataset download: ftp://ftp.fmach.it/metagenomics/micca/scirep/.

micca wraps third party software packages and these should be cited if they are used:

  • VSEARCH (doi: 10.7717/peerj.2584) used in classify, filter, mergepairs, otu and msa commands
  • MUSCLE (doi: 10.1093/nar/gkh340) used in msa and tree commands
  • FastTree (doi: 10.1371/journal.pone.0009490) used in the tree command
  • Cutadapt (doi: 10.14806/ej.17.1.200) used in the trim command
  • RDP classifier (doi: 10.1128/AEM.00062-07) used in the classify command
  • swarm (doi: 10.7717/peerj.1420) used in the otu command
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].