All Projects β†’ prashnts β†’ metaRNA

prashnts / metaRNA

Licence: other
Find target sites for the miRNAs in genomic sequences

Programming Languages

c
50402 projects - #5 most used programming language
python
139335 projects - #7 most used programming language
shell
77523 projects

Projects that are alternatives of or similar to metaRNA

sequencework
programs and scripts, mainly python, for analyses related to nucleic or protein sequences
Stars: ✭ 22 (+15.79%)
Mutual labels:  genomics, rna
berokka
🍊 πŸ’« Trim, circularise and orient long read bacterial genome assemblies
Stars: ✭ 23 (+21.05%)
Mutual labels:  genomics
Htsjdk
A Java API for high-throughput sequencing data (HTS) formats.
Stars: ✭ 220 (+1057.89%)
Mutual labels:  genomics
dnapacman
waka waka
Stars: ✭ 15 (-21.05%)
Mutual labels:  rna
Dragonn
A toolkit to learn how to model and interpret regulatory sequence data using deep learning.
Stars: ✭ 222 (+1068.42%)
Mutual labels:  genomics
RNArtist
RNArtist allows you to design and paint your RNA 2D structures interactively. Coupled with the 3D viewer UCSF Chimera, use your 2D as a map to explore RNA 3D architectures.
Stars: ✭ 86 (+352.63%)
Mutual labels:  rna
Miniasm
Ultrafast de novo assembly for long noisy reads (though having no consensus step)
Stars: ✭ 216 (+1036.84%)
Mutual labels:  genomics
GenomicsDB
Highly performant data storage in C++ for importing, querying and transforming variant data with C/C++/Java/Spark bindings. Used in gatk4.
Stars: ✭ 77 (+305.26%)
Mutual labels:  genomics
kmer-db
Kmer-db is a fast and memory-efficient tool for large-scale k-mer analyses (indexing, querying, estimating evolutionary relationships, etc.).
Stars: ✭ 68 (+257.89%)
Mutual labels:  genomics
cljam
A DNA Sequence Alignment/Map (SAM) library for Clojure
Stars: ✭ 85 (+347.37%)
Mutual labels:  genomics
Hap.py
Haplotype VCF comparison tools
Stars: ✭ 249 (+1210.53%)
Mutual labels:  genomics
Cyvcf2
cython + htslib == fast VCF and BCF processing
Stars: ✭ 243 (+1178.95%)
Mutual labels:  genomics
HLA
xHLA: Fast and accurate HLA typing from short read sequence data
Stars: ✭ 84 (+342.11%)
Mutual labels:  genomics
Bowtie
An ultrafast memory-efficient short read aligner
Stars: ✭ 221 (+1063.16%)
Mutual labels:  genomics
MGSE
Mapping-based Genome Size Estimation (MGSE) performs an estimation of a genome size based on a read mapping to an existing genome sequence assembly.
Stars: ✭ 22 (+15.79%)
Mutual labels:  genomics
Pyranges
Performant Pythonic GenomicRanges
Stars: ✭ 219 (+1052.63%)
Mutual labels:  genomics
Canvasxpress
JavaScript VisualizationTools
Stars: ✭ 247 (+1200%)
Mutual labels:  genomics
fermi
A WGS de novo assembler based on the FMD-index for large genomes
Stars: ✭ 74 (+289.47%)
Mutual labels:  genomics
cerebra
A tool for fast and accurate summarizing of variant calling format (VCF) files
Stars: ✭ 55 (+189.47%)
Mutual labels:  genomics
lncpipe
UNDER DEVELOPMENT--- Analysis of long non-coding RNAs from RNA-seq datasets
Stars: ✭ 24 (+26.32%)
Mutual labels:  rna

metaRNA

metaRNA finds potential target sites for the microRNAs in genomic sequences. It is built on miRanda, an algorithm for detection and ranking of the targets of microRNA.

Build Status PyPI V PyPI DM PyPI VER PyPI L image5 PyPI S

Quickstart

from metarna.target_scan import scan, free_energy

gene_sequence = (
    "ACAAGATGCCATTGTCCCCCGGCCTCCTGCTGCTGCTGCTCTCCGGGGCCACGGCCACCGCTGCCCTGCC"
    "CCTGGAGGGTGGCCCCACCGGCCGAGACAGCGAGCATATGCAGGAAGCGGCAGGAATAAGGAAAAGCAGC"
    "CTCCTGACTTTCCTCGCTTGGTGGTTTGAGTGGACCTCCCAGGCCAGTGCCGGGCCCCTCATAGGAGAGG"
)

mirna_sequence = "UGGCGAUUUUGGAACUCAAUGGCA"

# Get free Energy value:
delta_g = free_energy(gene_sequence, mirna_sequence)

# Get full targets information:
targets = scan(gene_sequence, mirna_sequence)

# Specifying Calculation Parameters
targets = scan(gene_sequence, mirna_sequence, scale=5.0)
# Check the docs for all available options

Documentation

Latest metaRNA documentation is available on ReadTheDocs.

Installation

metaRNA supports Python versions 2.7, 3.3, 3.4, and 3.5. It requires the Vienna RNA package which must be installed before installing metaRNA.

After Intalling Vienna RNA package, metaRNA may be installed simply by executing:

$ pip install metarna

metaRNA is currently tested on Mac OSX and Ubuntu, however other Unix based systems should be supported. It isn’t tested on Windows yet.

Running tests

Use of virtualenv is assumed and expected.

$ python setup.py develop # Installs Development Version
$ python -m unittest

Description

The miRanda algorithm works in two phases. In phase one, the potential target sites are reported based on query microRNA and reference (CDNA) sequence. These targets are scored and the high scoring alignments are then used in second phase, where the folding routines of RNAlib library are utilised to calculate the minimum free energy of the resulting combinations.

Further Information

Citing in publications

Please cite the original miRanda library, and Vienna RNA library. The citations can be obtained from the links above.

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].