Skip to main content

Multimodal omics analysis framework

Project description

muon is a multimodal omics Python framework.

Documentation | Tutorials | Publication

Documentation Status PyPi version

Data structure

muon is designed around MuData (multimodal data) objects — in the same vein as scanpy and AnnData are designed to work primarily with scRNA-seq data in Python. Individual modalities in MuData are naturally represented with AnnData objects.

MuData class and .h5mu files I/O operations are part of the standalone mudata library.

Input

MuData class is implemented in the mudata library and is exposed in muon:

from muon import MuData

mdata = MuData({'rna': adata_rna, 'atac': adata_atac})

If multimodal data from 10X Genomics is to be read, muon provides a reader that returns a MuData object with AnnData objects inside, each corresponding to its own modality:

import muon as mu

mu.read_10x_h5("filtered_feature_bc_matrix.h5")
# MuData object with n_obs × n_vars = 10000 × 80000 
# 2 modalities
#   rna:	10000 x 30000
#     var:	'gene_ids', 'feature_types', 'genome', 'interval'
#   atac:	10000 x 50000
#     var:	'gene_ids', 'feature_types', 'genome', 'interval'
#     uns:	'atac', 'files'

I/O with .h5mu files

Basic .h5mu files I/O functionality is implemented in mudata and is exposed in muon. A MuData object represents modalities as collections of AnnData objects, and these collections can be saved on disk and retrieved using HDF5-based .h5mu files, which design is based on .h5ad file structure.

mdata.write("pbmc_10k.h5mu")
mdata = mu.read("pbmc_10k.h5mu")

It allows to effectively use the hierarchical nature of HDF5 files and to read/write AnnData object directly from/to .h5mu files:

adata = mu.read("pbmc_10k.h5mu/rna")
mu.write("pbmc_10k.h5mu/rna", adata)

Multimodal omics analysis

muon incorporates a set of methods for multimodal omics analysis. These methods address the challenge of taking multimodal data as their input. For instance, while for a unimodal analysis one would use principal components analysis, muon comes with a method to run multi-omics factor analysis:

# Unimodal
import scanpy as sc
sc.tl.pca(adata)

# Multimodal
import muon as mu
mu.tl.mofa(mdata)

Individual assays

Individual assays are stored as AnnData object, which enables the use of all the default scanpy functionality per assay:

import scanpy as sc

sc.tl.umap(mdata.mod["rna"])

Typically, a modality inside a container can be referred to with a variable to make the code more concise:

rna = mdata.mod["rna"]
sc.pl.umap(rna)

Modules in muon

muon comes with a set of modules that can be used hand in hand with scanpy's API. These modules are named after respective sequencing protocols and comprise special functions that might come in handy. It is also handy to import them as two letter abbreviations:

# ATAC module:
from muon import atac as ac

# Protein (epitope) module:
from muon import prot as pt

Some implementation details are noted in DESIGN.md.

Contributions in the form of issues, pull requests or discussions are welcome.

muon is a part of scverse.

Project details


Download files

Download the file for your platform. If you're not sure which to choose, learn more about installing packages.

Source Distribution

muon-0.1.3.tar.gz (161.1 kB view details)

Uploaded Source

Built Distribution

muon-0.1.3-py3-none-any.whl (291.5 kB view details)

Uploaded Python 3

File details

Details for the file muon-0.1.3.tar.gz.

File metadata

  • Download URL: muon-0.1.3.tar.gz
  • Upload date:
  • Size: 161.1 kB
  • Tags: Source
  • Uploaded using Trusted Publishing? No
  • Uploaded via: twine/4.0.1 CPython/3.10.8

File hashes

Hashes for muon-0.1.3.tar.gz
Algorithm Hash digest
SHA256 22f6a3da682cc029012d74c20f41b618ca0765b772ecd161d86e72d49072e373
MD5 3ad8a72e804e70ccb8cc1406a3e92f55
BLAKE2b-256 01f7a6c6fd8c3c4847fa629ba269390135cdd4652b57ceca8e9177d415412771

See more details on using hashes here.

File details

Details for the file muon-0.1.3-py3-none-any.whl.

File metadata

  • Download URL: muon-0.1.3-py3-none-any.whl
  • Upload date:
  • Size: 291.5 kB
  • Tags: Python 3
  • Uploaded using Trusted Publishing? No
  • Uploaded via: twine/4.0.1 CPython/3.10.8

File hashes

Hashes for muon-0.1.3-py3-none-any.whl
Algorithm Hash digest
SHA256 706266fd3e80a0427f9813a4844551776a472cea1ba0879cf68a734a9002c3fa
MD5 a589f1cc6779f97d55b052f679e0796b
BLAKE2b-256 c6e308904f054742cb4841c705428d3efa07d75e91476c9922879edd81b711c4

See more details on using hashes here.

Supported by

AWS AWS Cloud computing and Security Sponsor Datadog Datadog Monitoring Fastly Fastly CDN Google Google Download Analytics Microsoft Microsoft PSF Sponsor Pingdom Pingdom Monitoring Sentry Sentry Error logging StatusPage StatusPage Status page