All Projects → PaccMann → paccmann_datasets

PaccMann / paccmann_datasets

Licence: MIT license
pytoda - PaccMann PyTorch Dataset Classes. Read the docs: https://paccmann.github.io/paccmann_datasets/

Programming Languages

python
139335 projects - #7 most used programming language

Projects that are alternatives of or similar to paccmann datasets

AMIDD
Introduction to Applied Mathematics and Informatics in Drug Discovery (AMIDD)
Stars: ✭ 13 (-13.33%)
Mutual labels:  bioinformatics, chemoinformatics
py4chemoinformatics
Python for chemoinformatics
Stars: ✭ 78 (+420%)
Mutual labels:  rdkit, chemoinformatics
chembience
A Docker-based, cloudable platform for the development of chemoinformatics-centric web applications and microservices.
Stars: ✭ 41 (+173.33%)
Mutual labels:  rdkit, chemoinformatics
global-chem
A Chemical Knowledge Graph of What is Common in the World.
Stars: ✭ 77 (+413.33%)
Mutual labels:  chemoinformatics, smiles
Molecules Dataset Collection
Collection of data sets of molecules for a validation of properties inference
Stars: ✭ 69 (+360%)
Mutual labels:  rdkit, smiles
molenc
MolEnc: a molecular encoder using rdkit and OCaml.
Stars: ✭ 14 (-6.67%)
Mutual labels:  rdkit, chemoinformatics
Scaff10X
Pipeline for scaffolding and breaking a genome assembly using 10x genomics linked-reads
Stars: ✭ 21 (+40%)
Mutual labels:  bioinformatics
sample-sheet
A permissively licensed library designed to replace Illumina's Experiment Manager
Stars: ✭ 42 (+180%)
Mutual labels:  bioinformatics
faster lmm d
A faster lmm for GWAS. Supports GPU backend.
Stars: ✭ 12 (-20%)
Mutual labels:  bioinformatics
ACPC
Chemoinformatics tool for ligand-based virtual screening
Stars: ✭ 16 (+6.67%)
Mutual labels:  chemoinformatics
sirius
SIRIUS is a software for discovering a landscape of de-novo identification of metabolites using tandem mass spectrometry. This repository contains the code of the SIRIUS Software (GUI and CLI)
Stars: ✭ 32 (+113.33%)
Mutual labels:  bioinformatics
awesome-phages
A curated list of phage related software and computational resources for phage scientists, bioinformaticians and enthusiasts.
Stars: ✭ 14 (-6.67%)
Mutual labels:  bioinformatics
TeamTeri
Genomics using open source tools, running on GCP or AWS
Stars: ✭ 30 (+100%)
Mutual labels:  bioinformatics
CANDO
Computational Analysis of Novel Drug Opportunities
Stars: ✭ 27 (+80%)
Mutual labels:  bioinformatics
BridgeDb
The BridgeDb Library source code
Stars: ✭ 22 (+46.67%)
Mutual labels:  bioinformatics
ensembl-compara
The Ensembl Compara Perl API and SQL schema
Stars: ✭ 43 (+186.67%)
Mutual labels:  bioinformatics
GRAFIMO
GRAph-based Finding of Individual Motif Occurrences
Stars: ✭ 22 (+46.67%)
Mutual labels:  bioinformatics
jgi-query
A simple command-line tool to download data from Joint Genome Institute databases
Stars: ✭ 38 (+153.33%)
Mutual labels:  bioinformatics
unimap
A EXPERIMENTAL fork of minimap2 optimized for assembly-to-reference alignment
Stars: ✭ 76 (+406.67%)
Mutual labels:  bioinformatics
dysgu
dysgu-SV is a collection of tools for calling structural variants using short or long reads
Stars: ✭ 47 (+213.33%)
Mutual labels:  bioinformatics

PyToDa

PyPI version build License: MIT Code style: black Downloads Downloads GitHub Super-Linter

Overview

pytoda - PaccMann PyTorch Dataset Classes

A python package that eases handling biochemical data for deep learning applications with pytorch.

Installation

pytoda ships via PyPI:

pip install pytoda

Documentation

Please find the full documentation here.

Development

For development setup, we recommend to work in a dedicated conda environment:

conda env create -f conda.yml

Activate the environment:

conda activate pytoda

Install in editable mode:

pip install -r dev_requirements.txt
pip install --user --no-use-pep517 -e .

Note on rdkit vs rdkit-pypi

NOTE: The conda env ships with the official rdkit implementation. But the pip installation overwrites the rdkit package with the community-contributed PyPI package called rdkit-pypi. This is intentional because pytoda is distributed via PyPI too and most users will thus depend on rdkit-pypi. Keep in mind that rdkit-pypi might contain bugs or be outdated wrt rdkit. If developers experience issues with rdkit-pypi, they can temporarily uninstall rdkit-pypi and will then fall back on using the proper rdkit package.

Examples

For some examples on how to use pytoda see here

References

If you use pytoda in your projects, please cite the following:

@article{born2021datadriven,
  author = {
    Born, Jannis and Manica, Matteo and Cadow, Joris and Markert, Greta and
    Mill,Nil Adell and Filipavicius, Modestas and Janakarajan, Nikita and
    Cardinale, Antonio and Laino, Teodoro and 
    {Rodr{\'{i}}guez Mart{\'{i}}nez}, Mar{\'{i}}a
  },
  doi = {10.1088/2632-2153/abe808},
  issn = {2632-2153},
  journal = {Machine Learning: Science and Technology},
  number = {2},
  pages = {025024},
  title = {{
    Data-driven molecular design for discovery and synthesis of novel ligands: 
    a case study on SARS-CoV-2
  }},
  url = {https://iopscience.iop.org/article/10.1088/2632-2153/abe808},
  volume = {2},
  year = {2021}
}
@article{born2021paccmannrl,
    title = {
      PaccMann$^{RL}$: De novo generation of hit-like anticancer molecules from
      transcriptomic data via reinforcement learning
    },
    journal = {iScience},
    volume = {24},
    number = {4},
    year = {2021},
    issn = {2589-0042},
    doi = {https://doi.org/10.1016/j.isci.2021.102269},
    url = {https://www.cell.com/iscience/fulltext/S2589-0042(21)00237-6},
    author = {
      Jannis Born and Matteo Manica and Ali Oskooei and Joris Cadow and Greta Markert
      and Mar{\'\i}a Rodr{\'\i}guez Mart{\'\i}nez}
    }
}
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].